Homework Set #7 - Solutions

Size: px
Start display at page:

Download "Homework Set #7 - Solutions"

Transcription

1 EE 5 - Applications of Convex Optimization in Signal Processing and Communications Dr Andre kacenko, JPL hird erm - First note that we can express f(t) as Homework Set #7 - Solutions f(t) = c(t) x, where we have [ c(t) ( ) π () t cos ( ) πkt cos x [ a a b b K ] ( ) π () t sin ( ) ] πkt sin, o compute the L approximation, we can equivalently minimize the L -norm of the error his leads to the following f y = / / ( c(t) x y(t)) dt [ ] [ / / = x c(t) c(t) dt x / } {{ } P c(t) y(t) / ] } {{ } q / + / y (t) dt } {{ } r Note that by the orthogonality of the Fourier series basis functions, we have that [ ] P = / K, () K I K and hence P hus, the optimal choice of x for the L approximation problem is given by x = P q (3) his can be simplified further as follows From our expression for P given in (), it is clear that we have [ ] P = K (4) K I K () Also, note that from (), we have / y(t) dt, k = / / ( ) π (k ) t [q] k = y(t) cos dt, k =,, K + / / ( ) π (k K ) t y(t) sin dt, k = K +,, K + /

2 From this, it can be shown that we have the following for our choice of y(t) 4, ( ) k = [q] k = π (k ) (k ) π sin, k =,, K +, k = K +,, K + his can be further simplified to 4, [ ] k = [q] k = (k ) π ( ) k ( ) k, k =,, K +, k = K +,, K + Combining this result with (3) and (4), we have that, k = [ ] [x ( ) k ( ) k ] k =, k =,, K + (k ) π, k = K +,, K + o compute the L approximation, using the summation approximation to the L -norm advocated in the problem, we get f y = N N m= c(t m ) x y(t m ) Now, the problem of minimizing the L -norm of the error can be posed as the following LP minimize N s s i c(t i ) x y(t i ) s i, i =,, N A plot of the periodic function y(t) along with its optimal L and L Fourier series approximations are shown in Figure From the plot, we can see that the L optimal approximation has the familiar Gibbs phenomenon near the discontinuities in y, but the L optimal approximation has much less pronounced oscillation in this neighborhood Furthermore, the L approximation has much smaller error than the L approximation, except near the discontinuities A plot of the histogram of the residuals for both the L and L optimal solutions is shown in Figure As can be seen, the optimal L approximation exhibits a much larger number of residuals near zero than the L approximation In addition, the L approximation also has a larger number of outlier residuals than the L approximation, as expected Sample MALAB code using cvx that can be used to generate the figures created here is shown below

3 y(t ) L -norm approximation L -norm approximation Figure : Plot of the -periodic function y(t) along with its optimal L and L Fourier series approximations t 35 3 L-norm L-norm Figure : Plot of the histogram of the residuals for both the L and L optimal approximations to y

4 % Initialize problem parameters N = 496; n = :(*N-); = ; t = (-/) + (n*/(*n)); K = ; % Create matrix of Fourier series coefficients for k = :K cos_mat(k,:) = cos(*pi*k*t/); sin_mat(k,:) = sin(*pi*k*t/); end coef_mat = [ repmat(5,,*n) ; cos_mat ; sin_mat]; % Generate samples of the periodic signal y = zeros(*n,); i_live = find(t >= -5 & t < 5); y(i_live) = ; % Calculate the optimal L_ approximation x_l_ = zeros(*k+,); x_l_() = ; for k = :K+ x_l_(k) = (((-)^(k/))*(((-)^(k-)) - ))/((k-)*pi); end % Calculate the optimal L_ approximation variable x_l_(*k+) minimize(norm(coef_mat *x_l_ - y,)) % Alternate method for calculating the optimal L_ approximation variable x_l_(*k+) variable s(*n) minimize((/(*n))*ones(,*n)*s) - coef_mat *x_l_ + y - s <= coef_mat *x_l_ - y - s <= % Compute the optimal function approximation from the Fourier series % coefficients f_l_ = coef_mat *x_l_; f_l_ = coef_mat *x_l_; % Plot the periodic function and its L_ and L_ Fourier series

5 % approximations figure plot(t,y, r ) hold on plot(t,f_l_, g ) plot(t,f_l_, b ) xlabel( $t$, Interpreter, LaeX, FontSize,) %print -depsc Fourier_series_approx_plot % Plot histograms or distributions of the residual magnitudes figure subplot(,,) hist(f_l_ - y,5) ylabel( $L_{}$-norm, Interpreter, LaeX, FontSize,) axis([ ]) subplot(,,) hist(f_l_ - y,5) ylabel( $L_{}$-norm, Interpreter, LaeX, FontSize,) axis([ ]) %print -depsc Fourier_series_hist_plot his problem can be simplified through vectorization of the matrix quantities that appear throughout the problem For example, by defining the horizontal and vertical difference vectors as u x vec(u k,l U k,l ), u y vec(u k,l U k,l ), with some abuse of notation, then the l variation problem can be equivalently expressed as [ ] ux minimize u y, U k,l = U orig k,l while the total variation problem can be expressed as [ ] ux minimize u y U k,l = U orig k,l, In MALAB, with the help of cvx, this can be implemented as follows % Load total variation image interpolation data tv_img_interp % Calculate the optimal l_ variation interpolant variable Ul(m,n); Ux = Ul(:end,:end) - Ul(:end,:end-); % Compute the x % (horizontal) variations

6 O riginal image Obscured image l variation reconstructed image otal variation reconstructed image Figure 3: Plot of the original, obscured, l variation interpolated, and total variation interpolated images Uy = Ul(:end,:end) - Ul(:end-,:end); % Compute the y (vertical) % variations minimize(norm([ux(:);uy(:)],)); % minimize the l_ % roughness measure Ul(Known) == Uorig(Known); % Fix known pixel values % values % Calculate the optimal total variation interpolant variable Utv(m,n); Ux = Utv(:end,:end) - Utv(:end,:end-); % Compute the x % (horizontal) variations Uy = Utv(:end,:end) - Utv(:end-,:end); % Compute the y (vertical) % variations minimize(norm([ux(:);uy(:)],)); % minimize the total % variation measure Utv(Known) == Uorig(Known); % Fix known pixel values A plot of the original and obscured image, along with the l variation and total variation interpolants are shown in Figure 3 As can be seen, for this particular type of sparse original image, the l based total variation reconstruction interpolates the missing data much better than the l variation based approach

7 3 (a) Ideally, the problem we would like to solve is the following one ) ) minimize card(â + card( B ( W / x(t + ) t= ) Âx(t) Bu(t) n ( ) + n ( ) Here, card(x) is the cardinality of matrix X, ie, the number of nonzero entries he issue with trying to solve this problem is that the objective is nonconvex o address this issue, we will use the common heuristic of minimizing the l norm of the entries of  and B Using the standard vectorization operator, this leads to the following convex optimization problem ) minimize vec(â) + vec( B ( W / x(t + ) t= ) Âx(t) Bu(t) n ( ) + n ( ) Intuitively, it can be said that the constraint will always be tight as relaxing the requirement on the) implied errors ) allows for more freedom to reduce the sum of the l -norms of vec(â and vec( B (b) his problem can be easily solved in MALAB with the help of cvx using the following code % Load problem data sparse_lds_data % Set the fit tolerance fit_tol = sqrt(n*(-) + *sqrt(*n*(-))); % Compute the l_ approximation to the sparse dynamical system fit problem variables Ahat(n,n) Bhat(n,m); minimize(sum(norms(ahat,)) + sum(norms(bhat,))); norm(inv(whalf)*(xs(:,:) - Ahat*xs(:,:-) - Bhat*us), fro ) <= fit_tol; disp(cvx_status) % Round near-zero elements to zero Ahat = Ahat * (abs(ahat) >= ); Bhat = Bhat * (abs(bhat) >= ); % Display the number of false positives and negatives disp([ false positives, Ahat: numstr(nnz((ahat ~= ) & (A == )))]) disp([ false negatives, Ahat: numstr(nnz((ahat == ) & (A ~= )))]) disp([ false positives, Bhat: numstr(nnz((bhat ~= ) & (B == )))]) disp([ false negatives, Bhat: numstr(nnz((bhat == ) & (B ~= )))])

8 With the given problem data, we get false positive (at the (6, 5)-th entry) and false negatives (at the (4, )-th and (6, )-th entries) for Â, and no false positives and false negative (at the (7, )-th entry) for B he matrix estimates are and  =, B = Finally, there are a lot of methods that will do better than this, usually be taking the above solutions as a starting point and then polishing the result after that Several of these have been shown to give fairly reliable, if modest, improvements 4 (a) o find qi min, we solve the convex optimization problem minimize q i l Sq u, q, with variable q R n hen, we set qi min = qi convex optimization problem maximize q i l Sq u, q, Similarly, to find qmax i, we solve the and then we set qi max = qi (b) Running spectrum datam yields plots of the spectra of the compounds s (),, s (n), alongside the lower and upper bounds l and u shown in Figure 4(a) and (b), respectively he following MALAB code using cvx can be used to find the range of possible values for each compound quantity q i [ qi min, qi max ] % Load the spectrum compound data spectrum_data

9 4 8 7 lower bound l upper bound u s (i) : i =,,n l, u k : k =,,m (a) k : k =,,m (b) Figure 4: Plots of compound data: (a) spectra of the compounds and (b) lower and upper bounds for the sample % Calculate the quantity bounds for each compound using a for-loop qmin = zeros(n,); qmax = zeros(n,); for i = :n % Compute the minimum bound for the i-th quantity variable q(n) l <= S*q; u >= S*q; q >= ; minimize(q(i)) qmin(i) = q(i); % Compute the maximum bound for the i-th quantity variable q(n) l <= S*q; u >= S*q; q >= ; maximize(q(i)) qmax(i) = q(i); end % Display the quantity bounds [qmin qmax] % Plot the quantity bounds figure; hold on; for i = :n plot([i,i],[qmax(i),qmin(i)], o- ); end

10 9 8 ] qi [ q i min,q i max i : i =,,n Figure 5: Plot of the range of possible values for each quantity q i [ q min i, qi max ] for i =,, n axis([,,,]); A plot of the range of possible values for each quantity q i is shown in Figure 5 From the output of cvx, we have q4 min = and q4 max = 5 *5 (a) First note that we have [ ] Re[G(θ)] G(θ) = Im[G(θ)] hen, note that if we define the following quantities ] x C(θ) [ wre w im R n, where [w re ] k = w re,k, [w im ] k = w im,k, [ cos φ (θ) cos φ n (θ) sin φ (θ) sin φ n (θ) sin φ (θ) sin φ n (θ) cos φ (θ) cos φ n (θ) ] R n, then we have [ ] Re[G(θ)] = C(θ) x Im[G(θ)] o express the design problem as an SOCP, define the following quantities A l C(θ l ), B C ( θ tar), [ ] d

11 3 5 y G(θ) (db) (a) x θ (deg) (b) Figure 6: Plots of (a) the antenna array geometry and (b) antenna array magnitude response G(θ) in db Note that the constraint G ( θ tar) = is equivalent to the following [ [ ( Re G θ tar )] ] [ ] Im [ G ( θ tar)] = Bx = d, which is an affine equality constraint on x hus, the antenna array design problem becomes the following SOCP minimize t A l x t, l =,, N Bx = d (b) his part of the problem can be simplified by noting that we can alternatively express G(θ) as G(θ) = e (θ) w, where e(θ) C n and w C n are given by ( [e(θ)] k = e j πxk λ [w] k = w k, k =,, n cos θ+ πy k λ sin θ ), k =,, n Using this simplification, for the antenna array geometry shown in Figure 6(a), we obtain the antenna array magnitude response G(θ) in db as shown in Figure 6(b) From Figure 6(b), it can be seen that the array response yields unity gain at the target angle of arrival θ tar and over 35 db of attenuation outside of the beamwidth Sample MALAB code using cvx which was used to obtain the results here is shown below % Define design problem parameters n = 4;

12 lambda = *pi; theta_tar_deg = 5; theta_tar = degrad(theta_tar_deg); Delta_deg = 5; Delta = degrad(delta_deg); N = ; % Generate antenna positions rand( state,); x = 3*rand(n,); y = 3*rand(n,); % Construct the discretized angle of arrival values theta_des = linspace(theta_tar+delta,theta_tar+(*pi)-delta); wn = *pi/lambda; e = exp(-j*(((wn*x)*cos(theta_des)) + ((wn*y)*sin(theta_des)))); e_tar = exp(-j*(((wn*x)*cos(theta_tar)) + ((wn*y)*sin(theta_tar)))); % Compute the optimal antenna array using cvx variable w(n) complex minimize(max(abs(e *w))) e_tar *w == ; % Plot the antenna array response theta_plot_deg = linspace(-8,8,89); theta_plot = degrad(theta_plot_deg); e = exp(-j*(((wn*x)*cos(theta_plot)) + ((wn*y)*sin(theta_plot)))); G = e *w; plot(theta_plot_deg,*log(abs(g))) xlim([-8 8]) grid xlabel( $\theta$ (deg), Interpreter, LaeX, FontSize,) ylabel( $\left G\!\left( \theta \right) \right $ (db), Interpreter, LaeX, FontSize,)

Phonon dispersion relation and density of states of a simple cubic lattice

Phonon dispersion relation and density of states of a simple cubic lattice Phonon dispersion relation and density of states of a simple cubic lattice Student project for the course Molecular and Solid State Physics by Eva Meisterhofer Contents 1 The linear spring model 3 1.1

More information

EE364b Homework 4. L(y,ν) = (1/2) y x ν(1 T y 1), minimize (1/2) y x 2 2 subject to y 0, 1 T y = 1,

EE364b Homework 4. L(y,ν) = (1/2) y x ν(1 T y 1), minimize (1/2) y x 2 2 subject to y 0, 1 T y = 1, EE364b Prof. S. Boyd EE364b Homework 4 1. Projection onto the probability simplex. In this problem you will work out a simple method for finding the Euclidean projection y of x R n onto the probability

More information

ANSWERS TO SELECTED EXCERCISES, CH 4-5

ANSWERS TO SELECTED EXCERCISES, CH 4-5 ANSWERS O SELECED EXCERCISES, CH 4-5 Exercise 4.4 a. Peak detection is, in many cases, a simple process it's usually just a matter of identifying regions of your signal that rise above a certain threshold,

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fourier Series & Transform Summary x[n] = X[k] = 1 N k= n= X[k]e jkω

More information

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding

Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding Fast Fourier Transform Discrete-time windowing Discrete Fourier Transform Relationship to DTFT Relationship to DTFS Zero padding J. McNames Portland State University ECE 223 FFT Ver. 1.03 1 Fourier Series

More information

Final exam. June7 8orJune8 9,2006.

Final exam. June7 8orJune8 9,2006. EE364 Convex Optimization June7 8orJune8 9,2006. Prof. S. Boyd Final exam You may use any books, notes, or computer programs (e.g., Matlab, cvx), but you may not discuss the exam with anyone until June

More information

EE Applications of Convex Optimization in Signal Processing and Communications Dr. Andre Tkacenko, JPL Third Term

EE Applications of Convex Optimization in Signal Processing and Communications Dr. Andre Tkacenko, JPL Third Term EE 150 - Applications of Convex Optimization in Signal Processing and Communications Dr. Andre Tkacenko JPL Third Term 2011-2012 Due on Thursday May 3 in class. Homework Set #4 1. (10 points) (Adapted

More information

Homework Set #8 - Solutions

Homework Set #8 - Solutions EE 50 - Applications of Convex Optimization in Signal Processing and Communications Dr. Andre Tkacenko JPL Third Term 20-202 Homework Set #8 - Solutions. For all parts to this problem we will use the fact

More information

CMSC 426 Problem Set 2

CMSC 426 Problem Set 2 CMSC 426 Problem Set 2 Lorin Hochstein - 1684386 March 3, 23 1 Convolution with Gaussian Claim Let g(t, σ 2 ) be a Gaussian kernel, i.e. ( ) g(t, σ 2 1 ) = exp t2 2πσ 2 2σ 2 Then for any function x(t),

More information

Midterm 1 Solutions. 1. (2 points) Show that the Frobenius norm of a matrix A depends only on its singular values. Precisely, show that

Midterm 1 Solutions. 1. (2 points) Show that the Frobenius norm of a matrix A depends only on its singular values. Precisely, show that EE127A L. El Ghaoui YOUR NAME HERE: SOLUTIONS YOUR SID HERE: 42 3/27/9 Midterm 1 Solutions The eam is open notes, but access to the Internet is not allowed. The maimum grade is 2. When asked to prove something,

More information

2.161 Signal Processing: Continuous and Discrete

2.161 Signal Processing: Continuous and Discrete MI OpenCourseWare http://ocw.mit.edu.6 Signal Processing: Continuous and Discrete Fall 8 For information about citing these materials or our erms of Use, visit: http://ocw.mit.edu/terms. MASSACHUSES INSIUE

More information

EE364b Homework 5. A ij = φ i (x i,y i ) subject to Ax + s = 0, Ay + t = 0, with variables x, y R n. This is the bi-commodity network flow problem.

EE364b Homework 5. A ij = φ i (x i,y i ) subject to Ax + s = 0, Ay + t = 0, with variables x, y R n. This is the bi-commodity network flow problem. EE364b Prof. S. Boyd EE364b Homewor 5 1. Distributed method for bi-commodity networ flow problem. We consider a networ (directed graph) with n arcs and p nodes, described by the incidence matrix A R p

More information

MAT 275 Laboratory 6 Forced Equations and Resonance

MAT 275 Laboratory 6 Forced Equations and Resonance MAT 275 Laboratory 6 Forced Equations and Resonance In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate on equations with a periodic harmonic forcing

More information

Math 515 Fall, 2008 Homework 2, due Friday, September 26.

Math 515 Fall, 2008 Homework 2, due Friday, September 26. Math 515 Fall, 2008 Homework 2, due Friday, September 26 In this assignment you will write efficient MATLAB codes to solve least squares problems involving block structured matrices known as Kronecker

More information

16.31 Homework 2 Solution

16.31 Homework 2 Solution 16.31 Homework Solution Prof. S. R. Hall Issued: September, 6 Due: September 9, 6 Problem 1. (Dominant Pole Locations) [FPE 3.36 (a),(c),(d), page 161]. Consider the second order system ωn H(s) = (s/p

More information

Homework 3 Solutions

Homework 3 Solutions EECS Signals & Systems University of California, Berkeley: Fall 7 Ramchandran September, 7 Homework 3 Solutions (Send your grades to ee.gsi@gmail.com. Check the course website for details) Review Problem

More information

to have roots with negative real parts, the necessary and sufficient conditions are that:

to have roots with negative real parts, the necessary and sufficient conditions are that: THE UNIVERSITY OF TEXAS AT SAN ANTONIO EE 543 LINEAR SYSTEMS AND CONTROL H O M E W O R K # 7 Sebastian A. Nugroho November 6, 7 Due date of the homework is: Sunday, November 6th @ :59pm.. The following

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP 2. Use MATLAB solvers for solving higher order ODEs and

More information

Indian Institute of Technology Bombay

Indian Institute of Technology Bombay Indian Institute of Technology Bombay MA 5 Calculus Autumn SRG/AA/VDS/KSK Solutions and Marking Scheme for the Mid-Sem Exam Date: September, Weightage: 3 % Time: 8.3 AM.3 AM Max. Marks:. (i) Consider the

More information

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids

Core Concepts Review. Orthogonality of Complex Sinusoids Consider two (possibly non-harmonic) complex sinusoids Overview of Continuous-Time Fourier Transform Topics Definition Compare & contrast with Laplace transform Conditions for existence Relationship to LTI systems Examples Ideal lowpass filters Relationship

More information

Assignment 2 Solutions Fourier Series

Assignment 2 Solutions Fourier Series Assignment 2 Solutions Fourier Series ECE 223 Signals and Systems II Version.2 Spring 26. DT Fourier Series. Consider the following discrete-time periodic signal n = +7l n =+7l x[n] = n =+7l Otherwise

More information

Convex optimization examples

Convex optimization examples Convex optimization examples multi-period processor speed scheduling minimum time optimal control grasp force optimization optimal broadcast transmitter power allocation phased-array antenna beamforming

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MAT 75 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP. Use MATLAB solvers for solving higher order ODEs and systems

More information

EE364b Convex Optimization II May 30 June 2, Final exam

EE364b Convex Optimization II May 30 June 2, Final exam EE364b Convex Optimization II May 30 June 2, 2014 Prof. S. Boyd Final exam By now, you know how it works, so we won t repeat it here. (If not, see the instructions for the EE364a final exam.) Since you

More information

Solutions for examination in TSRT78 Digital Signal Processing,

Solutions for examination in TSRT78 Digital Signal Processing, Solutions for examination in TSRT78 Digital Signal Processing, 2014-04-14 1. s(t) is generated by s(t) = 1 w(t), 1 + 0.3q 1 Var(w(t)) = σ 2 w = 2. It is measured as y(t) = s(t) + n(t) where n(t) is white

More information

Overview of Discrete-Time Fourier Transform Topics Handy Equations Handy Limits Orthogonality Defined orthogonal

Overview of Discrete-Time Fourier Transform Topics Handy Equations Handy Limits Orthogonality Defined orthogonal Overview of Discrete-Time Fourier Transform Topics Handy equations and its Definition Low- and high- discrete-time frequencies Convergence issues DTFT of complex and real sinusoids Relationship to LTI

More information

Disciplined Convex Programming

Disciplined Convex Programming Disciplined Convex Programming Stephen Boyd Michael Grant Electrical Engineering Department, Stanford University University of Pennsylvania, 3/30/07 Outline convex optimization checking convexity via convex

More information

Problem Set 9 Solutions

Problem Set 9 Solutions Problem Set 9 Solutions EE23: Digital Signal Processing. From Figure below, we see that the DTFT of the windowed sequence approaches the actual DTFT as the window size increases. Gibb s phenomenon is absent

More information

EE 438 Supplementary Notes on Fourier Series and Linear Algebra.

EE 438 Supplementary Notes on Fourier Series and Linear Algebra. EE 38 Supplementary Notes on Fourier Series and Linear Algebra. Discrete-Time Fourier Series. How to write a vector s as a sum where {g,...,g m } are pairwise orthogonal? s m a k g k, k Answer: project

More information

EE263 homework 3 solutions

EE263 homework 3 solutions EE263 Prof. S. Boyd EE263 homework 3 solutions 2.17 Gradient of some common functions. Recall that the gradient of a differentiable function f : R n R, at a point x R n, is defined as the vector f(x) =

More information

6.003 Homework #10 Solutions

6.003 Homework #10 Solutions 6.3 Homework # Solutions Problems. DT Fourier Series Determine the Fourier Series coefficients for each of the following DT signals, which are periodic in N = 8. x [n] / n x [n] n x 3 [n] n x 4 [n] / n

More information

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011

Name: INSERT YOUR NAME HERE. Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 AMath 584 Name: INSERT YOUR NAME HERE Take-home Final UWNetID: INSERT YOUR NETID Due to dropbox by 6pm PDT, Wednesday, December 14, 2011 The main part of the assignment (Problems 1 3) is worth 80 points.

More information

MATH 552 Spectral Methods Spring Homework Set 5 - SOLUTIONS

MATH 552 Spectral Methods Spring Homework Set 5 - SOLUTIONS MATH 55 Spectral Methods Spring 9 Homework Set 5 - SOLUTIONS. Suppose you are given an n n linear system Ax = f where the matrix A is tridiagonal b c a b c. A =.........,. a n b n c n a n b n with x =

More information

Assignment 6, Math 575A

Assignment 6, Math 575A Assignment 6, Math 575A Part I Matlab Section: MATLAB has special functions to deal with polynomials. Using these commands is usually recommended, since they make the code easier to write and understand

More information

EE364b Homework 7. t=1

EE364b Homework 7. t=1 EE364b Prof. S. Boyd EE364b Homework 7 1. MPC for output tracking. We consider the linear dynamical system x(t + 1) = Ax(t) + Bu(t), y(t) = Cx(t), t = 0,...,T 1, with state x(t) R n, input u(t) R m, and

More information

Laboratory 10 Forced Equations and Resonance

Laboratory 10 Forced Equations and Resonance MATLAB sessions: Laboratory 9 Laboratory Forced Equations and Resonance ( 3.6 of the Edwards/Penney text) In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate

More information

Lab 6d: Self-Erecting Inverted Pendulum (SEIP)

Lab 6d: Self-Erecting Inverted Pendulum (SEIP) Lab 6d: Self-Erecting Inverted Pendulum (SEIP) Arthur Schopen- Life swings like a pendulum backward and forward between pain and boredom. hauer 1 Objectives The goal of this project is to design a controller

More information

Bayesian Analysis - A First Example

Bayesian Analysis - A First Example Bayesian Analysis - A First Example This script works through the example in Hoff (29), section 1.2.1 We are interested in a single parameter: θ, the fraction of individuals in a city population with with

More information

EE364b Homework 2. λ i f i ( x) = 0, i=1

EE364b Homework 2. λ i f i ( x) = 0, i=1 EE364b Prof. S. Boyd EE364b Homework 2 1. Subgradient optimality conditions for nondifferentiable inequality constrained optimization. Consider the problem minimize f 0 (x) subject to f i (x) 0, i = 1,...,m,

More information

EE364 Review Session 4

EE364 Review Session 4 EE364 Review Session 4 EE364 Review Outline: convex optimization examples solving quasiconvex problems by bisection exercise 4.47 1 Convex optimization problems we have seen linear programming (LP) quadratic

More information

Solution to EE 617 Mid-Term Exam, Fall November 2, 2017

Solution to EE 617 Mid-Term Exam, Fall November 2, 2017 Solution to EE 67 Mid-erm Exam, Fall 207 November 2, 207 EE 67 Solution to Mid-erm Exam - Page 2 of 2 November 2, 207 (4 points) Convex sets (a) (2 points) Consider the set { } a R k p(0) =, p(t) for t

More information

EE3210 Lab 3: Periodic Signal Representation by Fourier Series

EE3210 Lab 3: Periodic Signal Representation by Fourier Series City University of Hong Kong Department of Electronic Engineering EE321 Lab 3: Periodic Signal Representation by Fourier Series Prelab: Read the Background section. Complete Section 2.2(b), which asks

More information

Chapter 1: Introduction

Chapter 1: Introduction Chapter 1: Introduction Definition: A differential equation is an equation involving the derivative of a function. If the function depends on a single variable, then only ordinary derivatives appear and

More information

Introduction to Machine Learning. PCA and Spectral Clustering. Introduction to Machine Learning, Slides: Eran Halperin

Introduction to Machine Learning. PCA and Spectral Clustering. Introduction to Machine Learning, Slides: Eran Halperin 1 Introduction to Machine Learning PCA and Spectral Clustering Introduction to Machine Learning, 2013-14 Slides: Eran Halperin Singular Value Decomposition (SVD) The singular value decomposition (SVD)

More information

An Introduction to CVX

An Introduction to CVX An Introduction to CVX Amirpasha Shirazinia Signals and Systems Division Department of Engineering Sciences Uppsala University November 4, 2014 Amirpasha Shirazinia (UU) An Introduction to CVX Internal

More information

Assignment #09 - Solution Manual

Assignment #09 - Solution Manual Assignment #09 - Solution Manual 1. Choose the correct statements about representation of a continuous signal using Haar wavelets. 1.5 points The signal is approximated using sin and cos functions. The

More information

Fourier series. XE31EO2 - Pavel Máša. Electrical Circuits 2 Lecture1. XE31EO2 - Pavel Máša - Fourier Series

Fourier series. XE31EO2 - Pavel Máša. Electrical Circuits 2 Lecture1. XE31EO2 - Pavel Máša - Fourier Series Fourier series Electrical Circuits Lecture - Fourier Series Filtr RLC defibrillator MOTIVATION WHAT WE CAN'T EXPLAIN YET Source voltage rectangular waveform Resistor voltage sinusoidal waveform - Fourier

More information

Math 365 Homework 5 Due April 6, 2018 Grady Wright

Math 365 Homework 5 Due April 6, 2018 Grady Wright Math 365 Homework 5 Due April 6, 018 Grady Wright 1. (Polynomial interpolation, 10pts) Consider the following three samples of some function f(x): x f(x) -1/ -1 1 1 1/ (a) Determine the unique second degree

More information

ECE251DN: Homework #4 Solutions

ECE251DN: Homework #4 Solutions ECE51DN: Homework #4 Solutions Problem 4.1.5 (a) θ 0 = 0 Beam Pattern: The Kaiser window can be computed by ( ) n W kaiser [n] = I 0 β 1, N 1 n N 1 N Where β = 6, N = 11. For a broadside array, the separable

More information

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP

MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP MATLAB sessions: Laboratory 4 MAT 275 Laboratory 4 MATLAB solvers for First-Order IVP In this laboratory session we will learn how to. Use MATLAB solvers for solving scalar IVP 2. Use MATLAB solvers for

More information

Agenda. Applications of semidefinite programming. 1 Control and system theory. 2 Combinatorial and nonconvex optimization

Agenda. Applications of semidefinite programming. 1 Control and system theory. 2 Combinatorial and nonconvex optimization Agenda Applications of semidefinite programming 1 Control and system theory 2 Combinatorial and nonconvex optimization 3 Spectral estimation & super-resolution Control and system theory SDP in wide use

More information

Problem (a) θ 0 = 0

Problem (a) θ 0 = 0 Problem 4.1.11 (a) θ 0 = 0 Beam Pattern: 3 For circular symmetric beam pattern, the weights a nm are given by ( ψ R J 1 ψ R n ) + m a(n, m) = π n + m In order to be consistent with Problem 4.1.5, we take

More information

Fourier Series, Fourier Transforms, and Periodic Response to Periodic Forcing

Fourier Series, Fourier Transforms, and Periodic Response to Periodic Forcing Fourier Series, Fourier ransforms, and Periodic Response to Periodic Forcing CEE 54. Structural Dynamics Department of Civil and Environmental Engineering Duke University Henri P. Gavin Fall, 26 his document

More information

Homework 2 Solutions

Homework 2 Solutions MATH 6 / CME 37 Winter 06 Homework Solutions Some notations have been altered from the assignment for ease of presentation. When considering implementations of discrete Fourier transforms, there are painfully

More information

Structured matrix factorizations. Example: Eigenfaces

Structured matrix factorizations. Example: Eigenfaces Structured matrix factorizations Example: Eigenfaces An extremely large variety of interesting and important problems in machine learning can be formulated as: Given a matrix, find a matrix and a matrix

More information

Homework Assignment 3

Homework Assignment 3 ECE382/ME482 Fall 2008 Homework 3 Solution October 20, 2008 1 Homework Assignment 3 Assigned September 30, 2008. Due in lecture October 7, 2008. Note that you must include all of your work to obtain full

More information

Homework 6 Solutions

Homework 6 Solutions 8-290 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 208 Homework 6 Solutions. Part One. (2 points) Consider an LTI system with impulse response h(t) e αt u(t), (a) Compute the frequency response

More information

ω (rad/s)

ω (rad/s) 1. (a) From the figure we see that the signal has energy content in frequencies up to about 15rad/s. According to the sampling theorem, we must therefore sample with at least twice that frequency: 3rad/s

More information

LECTURE 12 Sections Introduction to the Fourier series of periodic signals

LECTURE 12 Sections Introduction to the Fourier series of periodic signals Signals and Systems I Wednesday, February 11, 29 LECURE 12 Sections 3.1-3.3 Introduction to the Fourier series of periodic signals Chapter 3: Fourier Series of periodic signals 3. Introduction 3.1 Historical

More information

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011

LAB 2: DTFT, DFT, and DFT Spectral Analysis Summer 2011 University of Illinois at Urbana-Champaign Department of Electrical and Computer Engineering ECE 311: Digital Signal Processing Lab Chandra Radhakrishnan Peter Kairouz LAB 2: DTFT, DFT, and DFT Spectral

More information

Assignment 4 Solutions Continuous-Time Fourier Transform

Assignment 4 Solutions Continuous-Time Fourier Transform Assignment 4 Solutions Continuous-Time Fourier Transform ECE 3 Signals and Systems II Version 1.01 Spring 006 1. Properties of complex numbers. Let c 1 α 1 + jβ 1 and c α + jβ be two complex numbers. a.

More information

Solutions - Homework #1

Solutions - Homework #1 Solutions - Homework #1 1. Problem 1: Below appears a summary of the paper The pattern of a host-parasite distribution by Schmid & Robinson (197). Using the gnat Culicoides crepuscularis as a host specimen

More information

EE263 homework 9 solutions

EE263 homework 9 solutions EE263 Prof S Boyd EE263 homework 9 solutions 1416 Frobenius norm of a matrix The Frobenius norm of a matrix A R n n is defined as A F = TrA T A (Recall Tr is the trace of a matrix, ie, the sum of the diagonal

More information

MAT 275 Laboratory 6 Forced Equations and Resonance

MAT 275 Laboratory 6 Forced Equations and Resonance MATLAB sessions: Laboratory 6 MAT 275 Laboratory 6 Forced Equations and Resonance In this laboratory we take a deeper look at second-order nonhomogeneous equations. We will concentrate on equations with

More information

MATLAB/SIMULINK Programs for Flutter

MATLAB/SIMULINK Programs for Flutter H MATLAB/SIMULINK Programs for Flutter In this appix, some sample MATLAB programs are given for the calculation of the aeroelastic behaviour of a binary aeroelastic system, its response to control surface

More information

Solutions. Chapter 1. Problem 1.1. Solution. Simulate free response of damped harmonic oscillator

Solutions. Chapter 1. Problem 1.1. Solution. Simulate free response of damped harmonic oscillator Chapter Solutions Problem. Simulate free response of damped harmonic oscillator ẍ + ζẋ + x = for different values of damping ration ζ and initial conditions. Plot the response x(t) and ẋ(t) versus t and

More information

6. Approximation and fitting

6. Approximation and fitting 6. Approximation and fitting Convex Optimization Boyd & Vandenberghe norm approximation least-norm problems regularized approximation robust approximation 6 Norm approximation minimize Ax b (A R m n with

More information

EE5138R: Problem Set 5 Assigned: 16/02/15 Due: 06/03/15

EE5138R: Problem Set 5 Assigned: 16/02/15 Due: 06/03/15 EE538R: Problem Set 5 Assigned: 6/0/5 Due: 06/03/5. BV Problem 4. The feasible set is the convex hull of (0, ), (0, ), (/5, /5), (, 0) and (, 0). (a) x = (/5, /5) (b) Unbounded below (c) X opt = {(0, x

More information

Lecture 4: Linear and quadratic problems

Lecture 4: Linear and quadratic problems Lecture 4: Linear and quadratic problems linear programming examples and applications linear fractional programming quadratic optimization problems (quadratically constrained) quadratic programming second-order

More information

STAT2201 Assignment 3 Semester 1, 2017 Due 13/4/2017

STAT2201 Assignment 3 Semester 1, 2017 Due 13/4/2017 Class Example 1. Single Sample Descriptive Statistics (a) Summary Statistics and Box-Plots You are working in factory producing hand held bicycle pumps and obtain a sample of 174 bicycle pump weights in

More information

Session 1 : Fundamental concepts

Session 1 : Fundamental concepts BRUFACE Vibrations and Acoustics MA1 Academic year 17-18 Cédric Dumoulin (cedumoul@ulb.ac.be) Arnaud Deraemaeker (aderaema@ulb.ac.be) Exercise 1 Session 1 : Fundamental concepts Consider the following

More information

Constrained optimization. Unconstrained optimization. One-dimensional. Multi-dimensional. Newton with equality constraints. Active-set method.

Constrained optimization. Unconstrained optimization. One-dimensional. Multi-dimensional. Newton with equality constraints. Active-set method. Optimization Unconstrained optimization One-dimensional Multi-dimensional Newton s method Basic Newton Gauss- Newton Quasi- Newton Descent methods Gradient descent Conjugate gradient Constrained optimization

More information

Linear Algebra Using MATLAB

Linear Algebra Using MATLAB Linear Algebra Using MATLAB MATH 5331 1 May 12, 2010 1 Selected material from the text Linear Algebra and Differential Equations Using MATLAB by Martin Golubitsky and Michael Dellnitz Contents 1 Preliminaries

More information

Robust multichannel sparse recovery

Robust multichannel sparse recovery Robust multichannel sparse recovery Esa Ollila Department of Signal Processing and Acoustics Aalto University, Finland SUPELEC, Feb 4th, 2015 1 Introduction 2 Nonparametric sparse recovery 3 Simulation

More information

Solution to Homework Assignment 1

Solution to Homework Assignment 1 ECE602 Fall 2008 Homework Solution September 2, 2008 Solution to Homework Assignment. Consider the two-input two-output system described by D (p)y (t)+d 2 (p)y 2 (t) N (p)u (t)+n 2 (p)u 2 (t) D 2 (p)y

More information

1* (10 pts) Let X be a random variable with P (X = 1) = P (X = 1) = 1 2

1* (10 pts) Let X be a random variable with P (X = 1) = P (X = 1) = 1 2 Math 736-1 Homework Fall 27 1* (1 pts) Let X be a random variable with P (X = 1) = P (X = 1) = 1 2 and let Y be a standard normal random variable. Assume that X and Y are independent. Find the distribution

More information

2. the basis functions have different symmetries. 1 k = 0. x( t) 1 t 0 x(t) 0 t 1

2. the basis functions have different symmetries. 1 k = 0. x( t) 1 t 0 x(t) 0 t 1 In the next few lectures, we will look at a few examples of orthobasis expansions that are used in modern signal processing. Cosine transforms The cosine-i transform is an alternative to Fourier series;

More information

This homework will not be collected or graded. It is intended to help you practice for the final exam. Solutions will be posted.

This homework will not be collected or graded. It is intended to help you practice for the final exam. Solutions will be posted. 6.003 Homework #14 This homework will not be collected or graded. It is intended to help you practice for the final exam. Solutions will be posted. Problems 1. Neural signals The following figure illustrates

More information

Fitting Linear Statistical Models to Data by Least Squares: Introduction

Fitting Linear Statistical Models to Data by Least Squares: Introduction Fitting Linear Statistical Models to Data by Least Squares: Introduction Radu Balan, Brian R. Hunt and C. David Levermore University of Maryland, College Park University of Maryland, College Park, MD Math

More information

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 You can work this exercise in either matlab or mathematica. Your choice. A simple harmonic oscillator is constructed from a mass m and a spring

More information

MATH 5524 MATRIX THEORY Problem Set 5

MATH 5524 MATRIX THEORY Problem Set 5 MATH 554 MATRIX THEORY Problem Set 5 Posted Tuesday April 07. Due Tuesday 8 April 07. [Late work is due on Wednesday 9 April 07.] Complete any four problems, 5 points each. Recall the definitions of the

More information

Chapter 1 Fundamental Concepts

Chapter 1 Fundamental Concepts Chapter 1 Fundamental Concepts Signals A signal is a pattern of variation of a physical quantity as a function of time, space, distance, position, temperature, pressure, etc. These quantities are usually

More information

Generation of bandlimited sync transitions for sine waveforms

Generation of bandlimited sync transitions for sine waveforms Generation of bandlimited sync transitions for sine waveforms Vadim Zavalishin May 4, 9 Abstract A common way to generate bandlimited sync transitions for the classical analog waveforms is the BLEP method.

More information

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 PROBLEM 1: Given the mass matrix and two undamped natural frequencies for a general two degree-of-freedom system with a symmetric stiffness matrix, find the stiffness

More information

Optimization for Compressed Sensing

Optimization for Compressed Sensing Optimization for Compressed Sensing Robert J. Vanderbei 2014 March 21 Dept. of Industrial & Systems Engineering University of Florida http://www.princeton.edu/ rvdb Lasso Regression The problem is to solve

More information

EE364a Homework 8 solutions

EE364a Homework 8 solutions EE364a, Winter 2007-08 Prof. S. Boyd EE364a Homework 8 solutions 9.8 Steepest descent method in l -norm. Explain how to find a steepest descent direction in the l -norm, and give a simple interpretation.

More information

Solutions to Assignment 4

Solutions to Assignment 4 EE35 Spectrum Analysis and Discrete Time Systems (Fall 5) Solutions to Assignment. Consider the continuous-time periodic signal: x(t) = sin(t 3) + sin(6t) (8) [] (a) Obviously, the fundamental frequency

More information

Solutions - Homework #2

Solutions - Homework #2 45 Scatterplot of Abundance vs. Relative Density Parasite Abundance 4 35 3 5 5 5 5 5 Relative Host Population Density Figure : 3 Scatterplot of Log Abundance vs. Log RD Log Parasite Abundance 3.5.5.5.5.5

More information

ECE 6390 Homework 2: Look Angles

ECE 6390 Homework 2: Look Angles ECE 6390 Homework 2: Look Angles Solutions Problem 1: Numerical Analysis of Orbits The continuous time equations we start with are: r = r θ 2 GM p r 2 θ = 2ṙ θ r First, let our discrete representations

More information

Polynomial Approximation: The Fourier System

Polynomial Approximation: The Fourier System Polynomial Approximation: The Fourier System Charles B. I. Chilaka CASA Seminar 17th October, 2007 Outline 1 Introduction and problem formulation 2 The continuous Fourier expansion 3 The discrete Fourier

More information

Fourier analysis of discrete-time signals. (Lathi Chapt. 10 and these slides)

Fourier analysis of discrete-time signals. (Lathi Chapt. 10 and these slides) Fourier analysis of discrete-time signals (Lathi Chapt. 10 and these slides) Towards the discrete-time Fourier transform How we will get there? Periodic discrete-time signal representation by Discrete-time

More information

22 APPENDIX 1: MATH FACTS

22 APPENDIX 1: MATH FACTS 22 APPENDIX : MATH FACTS 22. Vectors 22.. Definition A vector has a dual definition: It is a segment of a a line with direction, or it consists of its projection on a reference system xyz, usually orthogonal

More information

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University

H 2 Optimal State Feedback Control Synthesis. Raktim Bhattacharya Aerospace Engineering, Texas A&M University H 2 Optimal State Feedback Control Synthesis Raktim Bhattacharya Aerospace Engineering, Texas A&M University Motivation Motivation w(t) u(t) G K y(t) z(t) w(t) are exogenous signals reference, process

More information

MAE 143B - Homework 7

MAE 143B - Homework 7 MAE 143B - Homework 7 6.7 Multiplying the first ODE by m u and subtracting the product of the second ODE with m s, we get m s m u (ẍ s ẍ i ) + m u b s (ẋ s ẋ u ) + m u k s (x s x u ) + m s b s (ẋ s ẋ u

More information

Solutions - Homework #2

Solutions - Homework #2 Solutions - Homework #2 1. Problem 1: Biological Recovery (a) A scatterplot of the biological recovery percentages versus time is given to the right. In viewing this plot, there is negative, slightly nonlinear

More information

Stat 5421 Lecture Notes Proper Conjugate Priors for Exponential Families Charles J. Geyer March 28, 2016

Stat 5421 Lecture Notes Proper Conjugate Priors for Exponential Families Charles J. Geyer March 28, 2016 Stat 5421 Lecture Notes Proper Conjugate Priors for Exponential Families Charles J. Geyer March 28, 2016 1 Theory This section explains the theory of conjugate priors for exponential families of distributions,

More information

Support Detection in Super-resolution

Support Detection in Super-resolution Support Detection in Super-resolution Carlos Fernandez-Granda (Stanford University) 7/2/2013 SampTA 2013 Support Detection in Super-resolution C. Fernandez-Granda 1 / 25 Acknowledgements This work was

More information

EE 355 / GP 265 Homework 5 Solutions

EE 355 / GP 265 Homework 5 Solutions EE / GP Homework Solutions February,. Autofocus: subaperture shift algorithm Compress the signal (with chirp slope s = Hz/s) by correlating it with the reference chirp (with different chirp slope s ) twice:

More information

Experiment 1: Linear Regression

Experiment 1: Linear Regression Experiment 1: Linear Regression August 27, 2018 1 Description This first exercise will give you practice with linear regression. These exercises have been extensively tested with Matlab, but they should

More information

EE363 homework 1 solutions

EE363 homework 1 solutions EE363 Prof. S. Boyd EE363 homework 1 soluions 1. LQR for a riple accumulaor. We consider he sysem x +1 = Ax + Bu, y = Cx, wih 1 1 A = 1 1, B =, C = [ 1 ]. 1 1 This sysem has ransfer funcion H(z) = (z 1)

More information