Main Content

Array Pattern Synthesis Part II: Optimization

This example shows how to use optimization techniques to perform pattern synthesis. Using minimum variance beamforming as an illustration, the example covers how to set up the pattern synthesis as an optimization problem and then solve it using optimization solvers.

Pattern synthesis can be achieved using a variety of techniques. The Array Pattern Synthesis Part I: Nulling, Windowing, and Thinning example introduced nulling and windowing techniques.

This example requires Optimization Toolbox™.

Minimum Variance Beamforming

Compared to a single element, a major benefit of a phased array is the capability of forming beams. In general, an N-element phased array provides N degrees of freedom when synthesizing a pattern, meaning that one can adjust N weights, one for each element, to control the shape of the beam to satisfy some pre-defined constraints.

Many popular beamforming techniques can be expressed as optimization problems. For example, the popular minimum variance distortionless response (MVDR) beamformer is used to minimize the total noise output while preserving the signal from a given direction. Mathematically, the MVDR beamforming weights can be found by solving the optimization problem

wo=minwwHRw            s.t.B(θ0,w)=1

where R is the covariance matrix, B(θ0,w) is the beam response towards the direction θ0 with the weights vector w, and wo is the vector containing the optimal weights. Because the beam pattern can be written as

B(θ,w)=wHv(θ)

where v(θ) is the steering vector corresponding to the angle θ, the constraints have a linear relation in the complex domain.

The distortionless constraint at θ0 only takes 1 degree of freedom in the design space. Since an N-element array can handle N – 1 constraints, the MVDR beamformer can be extended to include more constraints, which results in a linear constraints minimum variance (LCMV) beamformer. The extra constraints in an LCMV beamformer are often used to null out interferences from given directions. Therefore, such an LCMV beamformer is a solution to the following optimization problem

wo=minwwHRw            s.t.B(θ0,w)=1                    B(θk,w)=0      k=1,2,,K

where θk represents the kth nulling direction and there are K nulling directions in total. Because all constraints are linear in the complex domain, the LCMV beamforing weights can be derived analytically using the Lagrange multiplier method.

Next, a 32-element ULA with half wavelength spacing is used to demonstrate how to perform array synthesis using the LCMV approach. Note that even though this example uses a linear array, the technique applies to any array geometry. Assume that the signal of interest is at 0 degrees azimuth and the interferences are at –70, -–40, and –20 degrees azimuth. The noise power is assumed to be at 40 dB below signal. The closed form solution for LCMV weights can be computed using the lcmvweights function.

N = 32;
pos = (0:N-1)*0.5;         % position of elements
ang_i = [-70 -40 -20];     % interference angles
ang_d = 0;                 % desired angle

Rn = sensorcov(pos,ang_i,db2pow(-40));  % Noise covariance matrix
sv_c = steervec(pos,[ang_d ang_i]);     % Linear constraints
r_c = [1 zeros(size(ang_i))]';          % Desired response
w_lcmv = lcmvweights(sv_c,r_c,Rn);      % LCMV weights

ang_plot = -90:0.1:90;
sv_plot = steervec(pos,ang_plot);
plcmv = plot(ang_plot,mag2db(abs(w_lcmv'*sv_plot)));
xline(ang_i,"--")
ylim([-100 0])
grid on
legend(plcmv,"LCMV - Analytic")
xlabel("Azimuth Angle (deg)")
ylabel("Beam Pattern (dB)")

The figure shows that the computed weights satisfy all constraints.

LCMV Beamforming Using Quadratic Programming

Since LCMV beamforming can be described as an optimization problem, it would be useful to see how the problem can be solved using optimization techniques. When a closed form solution is not available, for example when constraints include inequalities, such workflow becomes important.

When using optimization techniques to perform pattern synthesis tasks, the first step is to pick a solver. Since solvers are often developed to address a particular problem formulation, it is of utmost importance to make the right choice.

The quadratic programming (QP) solver is often used to solve a quadratic objective function with linear constraints. The formulation is given by

wo=minw12wTHw+fTw            s.t.Awb                     Aeqw=beq                     wlbwwub

where A and Aeq are matrices specifying the inequality and equality constraints, respectively; b and beq are vectors specifying the desired bounds for inequality and equality constraints, respectively; and wlb and w indicate lower and upper bounds for elements in w, respectively.

At first sight, the problem formulation of quadratic programming seems to be a perfect match for LCM beamforming because we know that the beam pattern can be written as B(θ,w)=wHv(θ). Unfortunately, this is not true because although the beam pattern is linear in complex domain, it is not so in real domain. On the other hand, most optimization solvers, including quadratic programming, work in real domain as the solution space becomes really complicated in the complex domain. In addition, the inequality is not well defined in the complex domain either. Thus, the question is if the LCMV beamforming problem can be formulated into real domain and still obtain the quadratic programming form.

Start with the objective function wHRw. Note that R is a covariance matrix in this context, thus wHRw is real. Therefore, the goal is really to minimize the real part of wHRw, which can be written in the following form:

{wHRw}=[{w}T{w}T][{R}-{R}{R}{R}][{w}{w}]=wTRw

where w=[{w}{w}] and R=[{R}-{R}{R}{R}].

Next, look at the constraints. The fact that the constraints in LCMV beamforming are equalities makes the conversion a bit easier since one complex linear equality constraint can just be divided into two corresponding real linear equality constraints, one for the real part and the other for the imaginary part. For example, the following constraint

wHv=rH

can be rewritten as

vHw=r[{v}{v}{v}-{v}][{w}{w}]=[{v}{v}{v}-{v}]w=[{r}{r}]

With these relations, quadratic programming can then be used to obtain LCMV beamforming weights.

% Objective function
H = [real(Rn) -imag(Rn);imag(Rn) real(Rn)];
f = [];

% Equality constraints
Aeq = [real(sv_c).' imag(sv_c).';imag(sv_c).' -real(sv_c).'];
beq = [real(r_c);imag(r_c)];

% Compute weights
x_opt = quadprog(H,f,[],[],Aeq,beq);
Minimum found that satisfies the constraints.

Optimization completed because the objective function is non-decreasing in 
feasible directions, to within the value of the optimality tolerance,
and constraints are satisfied to within the value of the constraint tolerance.
w_opt = x_opt(1:numel(x_opt)/2)+x_opt(numel(x_opt)/2+1:end)*1i;

hold on
plcmvq = plot(ang_plot,mag2db(abs(w_opt'*sv_plot)),"--");
hold off
legend([plcmv plcmvq],["LCMV - Lagrange" "LCMV - QP"])

The figure shows that the QP technique can obtain the same LCMV beamforming weights.

Minimum Variance Beamforming Using Quadratic Programming

Another common requirement for pattern synthesis is to ensure the response is below a certain threshold for a set of given angles. These are inequality requirements and the overall optimization problem becomes

wo=minwwHRw            s.t.B(θ0,w)=1                    B(θk,w)=0      k=1,2,,K                   |B(w,θl)|rl      l=1,2,,L

where θl is the lth angle at which the sidelobe level should be less than the threshold rl. There are L inequality requirements in total.

As an example, add the following requirements to our sample problem:

  1. The sidelobe should be below –40 dB between –30 and –10 degrees in azimuth.

  2. Everywhere outside of the mainlobe, the sidelobe should be below −20 dB.

This code plots the mask of the desired pattern and returns the inequality constraints:

[rc,angc,sv_cineq,r_ineq,ang_ineq]=generatePatternMask(pos,r_c,[ang_d ang_i]);

pdp = plot(angc,rc,"k--");
ylim([-100 0])
grid on
xlabel("Azimuth Angle (deg)")
ylabel("Beam Pattern (dB)")

With the introduction of the new inequality constraint, the problem no longer has a closed-form solution. In addition, due to the presence of the norm operation, the aforementioned trick to translate complex constraints to real domain no longer works. Therefore, a new way to translate the complex inequality is needed to use the QP solver for this set of constraints,

Given a constraint of |B(θ,w)|<r, one possible way to convert this is to assume that both real and imaginary parts contribute equally to the norm. In that case, the single complex inequality constraint can be divided into two real inequalities as

-r2{B(θ,w)}r2-r2{B(θ,w)}r2

or

{B(θ,w)}r2{B(θ,w)}r2-{B(θ,w)}r2-{B(θ,w)}r2

The real and imaginary part of the constraints can be extracted as described in the previous section. Hence, the following code sets up the constraints and solves the pattern synthesis task.

% Map complex inequality constraints to real constraints
sv_c_real = [real(sv_cineq).' imag(sv_cineq).'];
sv_c_imag = [imag(sv_cineq).' -real(sv_cineq).'];
A_ineq = [sv_c_real;sv_c_imag];
A_ineq = [A_ineq;-A_ineq];
b_ineq = [r_ineq;r_ineq]/sqrt(2);  
b_ineq = [b_ineq;b_ineq];

% Compute weights
x_opt = quadprog(H,f,A_ineq,b_ineq,Aeq,beq);
Minimum found that satisfies the constraints.

Optimization completed because the objective function is non-decreasing in 
feasible directions, to within the value of the optimality tolerance,
and constraints are satisfied to within the value of the constraint tolerance.
% Reassemble complex weights from real and imaginary parts
w_opt = x_opt(1:numel(x_opt)/2)+x_opt(numel(x_opt)/2+1:end)*1i;

hold on
pqp = plot(ang_plot,mag2db(abs(w_opt'*sv_plot)));
hold off
legend(pqp,"Pattern - QP")

The resulting pattern satisfies the requirements.

Minimum Variance Beamforming Using Second Order Cone Programming

Even though the QP solver solves the minimum variance beamforming problem successfully, the conversion of the inequality constraints from complex to real is not ideal. For example, there is no reason that real and imaginary parts should always equally contribute to the norm. However, there is really no easy way to handle a constraint with norm in a QP problem setup.

Luckily, there is another optimization solver that can be used in this case, called Second order cone programming (SOCP). SOCP is developed to efficiently solve the following optimization problem:

wo=minwfTw            s.t.Ascw-bscdTw-γ                     Awb                     Aeqw=beq                     wlbwwub

where Asc is a matrix, bscand d are vectors, and γ is a scalar. Asc, bsc, d, and γtogether define a second order cone constraint, which is a natural choice to specify a constraint on norms. The solver can handle multiple second order cone constraints simultaneously.

Comparing to the problem formulation for QP, SOCP can not only handle second order constraints, but also handle all constraints specified in QP. However, the objective function is quite different. Instead of minimizing a variance, SOCP minimize a linear function of the optimization variable, w. Fortunately, there is a way to convert the minimum variance objective function to fit into this SOCP framework. The trick is to define an auxiliary variable, t, and ensure that the variance is bounded by t. This way, the problem becomes to minimize t while the original quadratic objective becomes a cone constraint bounded by t.

Following this thought, amend t to the bottom of w. Now the optimization search space is defined by w=[wt]. Since the goal is to minimize t, f is defined as fT=[0,,01].

f = [zeros(2*N,1);1];

Next, explore how to convert the quadratic constraint to a second order cone constraint. Since the idea is to constraint the variance as

wTRwt

it is equivalent to say

R0.5w2t+14

Thus,

[R0.5001][wt]2R0.5w2+t2t2+t+14=(t+12)2

and the second cone constraint becomes

[R0.5001]wt+12

% The cone constraints are defined as ||A_c*u-b_c||<=d_c^T*u-gamma_c
Ac = [sqrtm(H) zeros(2*N,1);zeros(1,2*N) 1];
bc = zeros(2*N+1,1);
dc = [zeros(2*N,1);1];
gammac = -1/2;

M = numel(r_ineq);
socConstraints(M+1) = secondordercone(Ac,bc,dc,gammac);

The remaining second cone constraints are from the original inequality constraints and are fairly straightforward to be converted. Each inequality constraint in the form of

B(θ,w)r

can be written as a second order cone constraint as

[{B(θ,w)}0{B(θ,w)}000]wr

for m = 1:M
    Ac = [A_ineq([m m+M],:) zeros(2,1);zeros(1,2*N) 0];
    bc = zeros(3,1);
    dc = zeros(2*N+1,1);
    gammac = -r_ineq(m);
    socConstraints(m) = secondordercone(Ac,bc,dc,gammac);
end

The equality constraints also need to be augmented to accommodate the auxiliary variable, t.

% patch Aeq and beq
Aeqc = [Aeq zeros(size(Aeq,1),1);zeros(1,2*N) 0]; 
beqc = [beq;0];

The array weights can now be computed using the SOCP solver. Since the inequality constraints are more natural to be represented in cone constraints, naively one would expect that in this example, the resulting pattern from SOCP would be better compared to the pattern from QP.

[u_op,feval,exitflag] = coneprog(f,socConstraints,[],[],Aeqc,beqc);
Optimal solution found.
% Reassemble complex weights from real and imaginary parts 
% The last entry in the optimized vector corresponds to the variable t
w_op = u_op(1:N)+u_op(N+1:2*N)*1i;

hold on
psocp = plot(ang_plot,mag2db(abs(w_op'*sv_plot)));
hold off
legend([pqp psocp],["Pattern - QP" "Pattern - SOCP"])

Indeed, the plot shows that the pattern obtained via SOCP has better sidelobe suppression compared to the pattern obtained using QP. As you can see, the process is quite involved when an optimization solver is used. We can simplify this process by calling the minvarweights function. The code below shows how to define the mask constraints as inputs for minvarweights function. The mask sidelobe level and mask angle represent the inequality constraints for the optimization problem, and the null angle represents the equality constraint for SOCP. For more details, refer to the minvarweights documentation.

W_opt = minvarweights(pos,ang_d,Rn, ...
    MaskSidelobeLevel=mag2db(r_ineq)', ...
    MaskAngle=ang_ineq,NullAngle=ang_i);

plot(ang_plot,mag2db(abs(W_opt'*sv_plot)))
hold on
plot(angc,rc,'k--')
hold off
legend(["Pattern - minvarweights" "Sidelobe Mask"], ...
    Location="best")
ylim([-100 0])
grid on
xlabel("Azimuth Angle (deg)")
ylabel("Beam Pattern (dB)")

Minimum Variance Beamforming Using minvarweights with Other Mask Constraints

In this section, we use minvarweights function to solve pattern synthesis problems with different optimization constraints. Consider a linear array with 55 antenna elements and 0.5λ spacing ULA in the direction of 25-degree in azimuth. The goal is to optimize the beamforming weights with the following constraints:

  • Sidelobe levels less than a tapered sidelobe mask decrease linearly from −18dB to −55dB in the range of 1st SLL to ±90 degrees in azimuth.

  • Steer nulls at [−45 −35 40 60] degrees in azimuth.

N = 55;                     % Number of elements
pos = (0:N-1)*0.5;          % Position of elements
ANGmainBeam = 25;           % Main Beam direction

% Define null directions 
ANGn = [-35 -45 40 60];     % Null angles, degree

% Define the SLL mask  
ANGml = -90:.2:22.5;                        % mask angles for left SLLs
SLLml = linspace(-55,-18,numel(ANGml));     % mask SLLs for ANGml ( decrease linearly from −18dB to −55dB)
ANGmr = 27.5:0.2:90;                        % mask angles for right SLLs
SLLmr = linspace(-18,-55,numel(ANGmr));     % mask SLLs for ANGmr ( decrease linearly from −18dB to −55dB)
ANGm = [ANGml ANGmr];                       % mask angles
SLLm = [SLLml SLLmr];                       % mask SLL

% Compute optimized weights 
OptimizedWeights = minvarweights(pos, ANGmainBeam, ...
    MaskAngle=ANGm,MaskSidelobeLevel=SLLm,NullAngle=ANGn);

% Calculate array pattern
sv_plot = steervec(pos,-90:.25:90);
Pattern = OptimizedWeights'*sv_plot;

% Plot the pattern
plot(-90:.25:90,mag2db(abs(Pattern)))
xlabel("Azimuth Angle (deg)")
ylabel("Beam Pattern (dB)")
axis([-90 90 -80 0])
grid on

% Plot the mask with nulls
hold on
[AngMask,IA] = sort([ANGm ANGn]);
SLLmask = [SLLm -1000*ones(1,size(ANGn,2))];
plot(AngMask,SLLmask(IA),'k')
legend(["Pattern - minvarweights" "Sidelobe Mask"], ...
    Location="best")
hold off

This animation shows the pattern synthesis results for the beam sweeping from −35 degree to +35 degree and SLLs decrease linearly from −18 dB to −55 dB in the range of 1st SLL to ±90 degrees in azimuth.

Pattern_v3.m4v.gif

Summary

This example shows how to use optimization techniques to perform pattern synthesis. The example started with the familiar LCMV problem and extended the desired pattern to include inequality constraints. Compared to the closed-form solution, optimization techniques are more flexible and can be applied to address more complex constraints. The example also showed how to address inequality constraints using either quadratic programming, second order cone programming, or minvarweights.

Reference

[1] Lebret, Hervé, and Stephen Boyd. "Antenna Array Pattern Synthesis via Convex Optimization." IEEE Transactions on Signal Processing, Vol. 45, No. 3 (March 1997), pp. 526–532.

function [rcplot,angc,svcineq,rineq,angineq]=generatePatternMask(pos,rcexist,angexist)
% generatePatternMask  Generate mask for pattern synthesis

ang_c1 = [-30:-21 -19:-10];
ang_c2 = [-90:-71 -69:-41 -39:-31 -9:-5 5:90];  
% Note the main beam is between -10 and 10 degrees
sv_c1 = steervec(pos,ang_c1);
sv_c2 = steervec(pos,ang_c2);

r1 = db2mag(-40)*ones(size(sv_c1,2),1);
r2 = db2mag(-20)*ones(size(sv_c2,2),1);

[angc,cidx] = sort([ang_c1 ang_c2 angexist]);
rc = [r1;r2;rcexist];
rcplot = mag2db(rc(cidx));
rcplot(rcplot<-100) = -100;

% Inequality constraints
sv_c1 = steervec(pos,ang_c1);
sv_c2 = steervec(pos,ang_c2);
svcineq = [sv_c1 sv_c2];
rineq = [r1;r2];
angineq = [ang_c1 ang_c2];

end