Problem (a) θ 0 = 0

Size: px
Start display at page:

Download "Problem (a) θ 0 = 0"

Transcription

1 Problem (a) θ 0 = 0 Beam Pattern: 3

2 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 ψ R to be BW NN = 0.497π, where BW NN is the null-to-null beam width in Problem Assume the array has a circular boundary and we want to apply a Kaiser window with β = 6 ) ] I 0 [β W kaiser (n, m) = 1 ( n +m I 0 (β) N, N 1 n, m N 1 where N=11. So the final weights for the array are { a(n, m) wkaiser (n, m), when n w(n, m) = + m N 0, otherwise (circular boundary) The beam pattern can be computed by B(ψ x, ψ y ) = N 1 n= N 1 The plot of B(ψ x, ψ y ) is shown in Figure 3. Directivity: For normalized beam pattern, N 1 m= N 1 D = [W H BW ] 1 w (n, m) e j(nψ x+mψ y ) where matrix B is exactly the same as we computed in Problem By plugging in B and W, we get D = HPBW: In this problem, we can NOT use equation (4..7) in the text to calculate θ H and ψ H, because we don t have any knowledge about the HPBW θx 0 and θy 0 corresponding to a(n, m) W kaiser (n, m). So we estimate HPBW ψ x and ψ y from simulated data. ψ x = ψ y =.03 u x = u y = (b) θ 0 = 45, ϕ 0 = 30 Beam Pattern: The new weight is W (n, m) = W (n, m) e j(nψx 0+mψy 0 ) 4

3 where ψ x0 = sin θ 0 cos ϕ 0, and ψ y0 = π sin θ 0 sin ϕ 0. The beam pattern is B (ψ x, ψ y ) = N 1 n= N 1 The plot of B (ψ x, ψ y ) is shown in Figure 4. Directivity: N 1 m= N 1 D = [W H BW ] 1 = W (n, m) e j(nψx+mψy) HPBW: ψ x = ψ y =.03 u x = u y = 0.646

4 B Matlab Code for Prob % Matlab code for problem in the text close all clear all % % % (a) theta0 = 0 % % N = 11; M = 11; theta0 = 0; psix0 = 0; psiy0 = 0; psir = 0.497*pi; psix = pi*(-1:1/100:1); psiy = pi*(-1:1/100:1); beta = 6; w = zeros(m,n); BXY = zeros(length(psiy), length(psix)); for n = -(N-1)/:(N-1)/ for m = -(M-1)/:(M-1)/ t = sqrt(n^ + m^); if (t<=(n-1)/) & (t>0) a_nm = psir*besselj(1,psir*t)//pi/t; wkaiser = besseli(0,beta*sqrt(1-(t/5.5)^))/besseli(0,beta); wnow = a_nm * wkaiser; w(m+(m-1)/+1,n+(n-1)/+1) = wnow; identicalvector = ones(1,length(psix)); V = exp(j*(n*psix. *identicalvector + m*identicalvector. *psiy)); BXY = BXY + conj(wnow) * V; elseif (t==0) wnow = pi*psir^/(4*pi^); w(m+(m-1)/+1,n+(n-1)/+1) = wnow; identicalvector = ones(1,length(psix)); v = exp(j*(n*psiy. *identicalvector + m*identicalvector. *psix)); BXY = BXY + conj(wnow) * v; end end end BXY = BXY. /max(max(abs(bxy))); figure(1) subplot(,,1); [x,y] = meshgrid(psix,psiy); meshc(x,y,0*log10(abs(bxy))); xlabel( \psi_x ); ylabel( \psi_y ); zlabel( B(\psi_x,\psi_y) (db) ); title( Circular symmetric beam pattern, when \theta_0=90^o ) % compute directivity B = zeros(n*m,n*m); for ii=1:n*m for jj=1:n*m deltapy = floor(ii/n) - floor(jj/n); deltapx = mod(ii,m)-mod(jj,m); rho = sqrt(deltapx^ + deltapy^); B(ii,jj) = sinc(rho); 7

5 end end % finish constructing matrix B n = -(N-1)/:(N-1)/; m = -(M-1)/:(M-1)/; identicalvector = ones(1,n); v0 = exp(j*(n. *psiy0*identicalvector + identicalvector. *m*psix0)); v0 = v0(:); w = w(:); disp( Directivity of broadside array: ) D = abs(w *v0)^/(w *B*w) % plot the contour of HPBW figure(1) subplot(,,) [x,y] = meshgrid(psix,psiy); contour(x,y,0*log10(abs(bxy)), [-3-3]); grid xlabel( \psi_x ); ylabel( \psi_y ); title( Contour plot of HPBW, when \theta_0=90^o ) figure(1) subplot(,,3) plot(psix, 0*log10( abs(bxy( (size(bxy,1)+1) /,:)) )) xlabel( \psi_r ); ylabel( B(\psi_x, \psi_y) (db) ) title( Cut of B(\psi_x,\psi_y), when \phi = 0^o ) figure(1) subplot(,,4) plot(psiy, 0*log10(abs(BXY(:, (size(bxy,1)+1) /)) )) xlabel( \psi_r ); ylabel( B(\psi_x, \psi_y) (db) ) title( Cut of B(\psi_x,\psi_y), when \phi = 90^o ) % % % (b) theta0 = 45 degrees, phi0 = 30 degrees % % N = 11; M = 11; theta0 = pi/4; phi0 = pi/6; psix0 = pi*sin(theta0)*cos(phi0); psiy0 = pi*sin(theta0)*sin(phi0); psir = 0.497*pi; psix = pi*(-1:1/100:1); psiy = pi*(-1:1/100:1); beta = 6; w = zeros(m,n); BXY = zeros(length(psiy), length(psix)); for n = -(N-1)/:(N-1)/ for m = -(M-1)/:(M-1)/ t = sqrt(n^ + m^); if (t<=(n-1)/) & (t>0) a_nm = psir*besselj(1,psir*t)//pi/t; wkaiser = besseli(0,beta*sqrt(1-(t/5.5)^))/besseli(0,beta); wnow = a_nm * wkaiser * exp(j*(n*psix0 + m*psiy0)); w(m+(m-1)/+1,n+(n-1)/+1) = wnow; identicalvector = ones(1,length(psix)); V = exp(j*(n*psix. *identicalvector + m*identicalvector. *psiy)); BXY = BXY + conj(wnow) * V; elseif (t==0) wnow = pi*psir^/(4*pi^) * exp(j*(n*psix0 + m*psiy0)); w(m+(m-1)/+1,n+(n-1)/+1) = wnow; identicalvector = ones(1,length(psix)); v = exp(j*(n*psiy. *identicalvector + m*identicalvector. *psix)); BXY = BXY + conj(wnow) * v; end end end BXY = BXY. /max(max(abs(bxy))); figure() subplot(,,1); [x,y] = meshgrid(psix,psiy); meshc(x,y,0*log10(abs(bxy))); xlabel( \psi_x ); ylabel( \psi_y ); zlabel( B(\psi_x,\psi_y) (db) ); title( Circular symmetric beam pattern, when \theta_0=45^o \phi_0=30^o ) % compute directivity B = zeros(n*m,n*m); for ii=1:n*m 8

6 for jj=1:n*m deltapy = floor(ii/n) - floor(jj/n); deltapx = mod(ii,m)-mod(jj,m); rho = sqrt(deltapx^ + deltapy^); B(ii,jj) = sinc(rho); end end % finish constructing matrix B n = -(N-1)/:(N-1)/; m = -(M-1)/:(M-1)/; identicalvector = ones(1,n); v0 = exp(j*(n. *psiy0*identicalvector + identicalvector. *m*psix0)); v0 = v0(:); w = w(:); disp( Directivity when theta0=45 phi0=30: ) D = abs(w *v0)^/(w *B*w) % plot the contour of HPBW figure() subplot(,,) [x,y] = meshgrid(psix,psiy); contour(x,y,0*log10(abs(bxy)), [-3-3]); grid xlabel( \psi_x ); ylabel( \psi_y ); title( Contour plot of HPBW, when \theta_0=45^o \phi_0=30^o ) figure() subplot(,,3) plot(psix, 0*log10( abs(bxy( (size(bxy,1)+1) /,:)) )) xlabel( \psi_r ); ylabel( B(\psi_x, \psi_y) (db) ) title( Cut of B(\psi_x,\psi_y), when \phi = 0^o ) lengthpsix = length(psix); n = -(lengthpsix-1)/:(lengthpsix-1)/; ypos = round(n*tan(phi0)) + (lengthpsix-1)/ + 1; BXY_Cut = []; for ii=1:length(ypos) BXY_Cut = [BXY_Cut, BXY(yPos(ii), n(ii) + (lengthpsix-1)/ + 1) ]; end figure() subplot(,,4) plot(psix/cos(phi0), 0*log10(abs(BXY_Cut) )) xlabel( \psi_r ); ylabel( B(\psi_x, \psi_y) (db) ) title( Cut of B(\psi_x,\psi_y), when \phi = 30^o ) 9

7 Figure 3: Beam pattern plots for Problem (a) 1

8 Figure 4: Beam pattern plots for Problem (b) 13

9 Problem 4..1 Consider an 8-element circular array with equal spacing between elements. It could also be viewed as two 4-element rectangular arrays with the first array oriented along the x-y axes and the second array rotated by 45. (a)using this model, find the beam pattern and compare your result to the result in the text. The distance between two elements on the same axis is d. Then, the elements for one rectangular array are at (d/, 0, 0), ( d/, 0, 0), (0, d/, 0) and (0, d/, 0). The weights are 1/8 each. So the beampattern is given by [e jk 0 d sin θ cos φ + e jk 0 d sin θ cos φ + e jk 0 d sin θ sin φ + e jk 0 d sin θ sin φ] where k 0 = π λ. B R1 (θ, φ) = 1 8 = 1 ( 4 cos d k 0 sin θ cos φ ) + 14 sin ( ) d k 0 sin θ sin φ Similarly, for the other array, rotated by 45 around the x-y axis, the beam pattern is given by B R (θ, φ) = B R1 (θ, φ π 4 ) = 1 ( 4 cos d k 0 (φ sin θ cos π ) ) + 1 ( 4 4 sin d k 0 (φ sin θ sin π ) ) 4 Thus, the beam patern is given by B(θ, ϕ) = (B R1 (θ, φ) + B R (θ, φ)) = 1 [ ( ) d cos k 0 sin θ cos φ 4 ( d + cos k 0 (φ sin θ cos π 4 ( d + sin k 0 ) sin θ sin φ ) ) + sin ( k 0 d sin θ sin (φ π 4 The beam pattern of circular array with N = 8 is given by (eq ) B(θ, φ) = N 1 m=0 1 B m (θ, φ) ) )] (1)

10 where B m (θ, φ) = w m e jkr sin θ cos(φ φ m)+jβ n β n = kr sin θ 0 cos(φ φ n ) Setting w m = 1/N = 1/8, β n = 0 since θ 0 = 0, φ m = πm N, and R = d/, the expression for beam pattern is and B(θ, φ) = Examining the first term: m=0 B m (θ, φ) = 1 8 ejk 0 d 7 B m (θ, φ) = n=0 sin θ cos(φ πm 8 ) 3 B m (θ, φ) + m=0 3 B m+1 (θ, φ) 3 B m (θ, φ) = 1 3 e jk 0 d sin θ cos(φ π m) 8 m=0 = 1 [e jk 0 d sin θ cos φ + e jk 0 d sin θ cos(φ π L ) + e jk 0 d sin θ cos(φ π) + e jk 0 d sin θ cos(φ 3π )] 8 = 1 [e jk 0 d sin θ cos φ + e jk 0 d sin θ sin φ + e jk 0 d sin θ cos φ + e jk 0 d sin θ sin φ] 8 = 1 [ ] d cos(k 0 4 sin θ cos φ) + cos(k d 0 sin θ sin φ) = B R1 (θ, φ) m=0 Similarly, 3 B m+1 (θ, φ) = B R (θ, φ) m=0 B(θ, φ) = B R1 (θ, φ) + B R (θ, φ) The same as Equation 1. (b) Assume d = λ in the rectangular arrays. Plot the resulting beam pattern. Substituting d = λ in Equation 1, we have B(θ, ϕ) = 1 4 [ ( ( cos(π sin θ cos φ) + sin(π sin θ sin φ) + cos π sin θ cos φ π )) ( ( + sin π sin θ sin φ π ))] 4 4 We plot the beam pattern cuts of this function in Figure 1. The matlab code is attached in Appendix A. We have normalized the beam pattern thus the peak value is 0 db, not near 10 db.

11 5 Circular Array Beam pattern Cut Beam pattern (db) φ = 0 45 φ = 45 φ= u r Figure 1: Beam pattern cuts for a uniformly weighted circular array (N=8) for different values of φ. A Matlab Code for Prob % File: t41b.m % Created: Wed 11/03/04 03:13: % Last Updated: Thu 11/04/04 03:13: % Description: ECE 51D - Fa04 - HW5-4..1b van Trees % : Beam Pattern Cuts - Circular Array % : N=8, d = lambda %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % We have developed upon the files provided by Prof. Bell (GMU) at % %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% % close all clear all N = 8; ur = -1:1/1000:1; theta = pi/ * ur; sintheta = sin(theta); PHI_SET = [0 pi/4 pi/]; B = zeros(length(phi_set), length(ur)); for k=1:length(phi_set) phi = PHI_SET(k); B(k,:) = B(k,:) + cos(pi * cos(phi) * sintheta); B(k,:) = B(k,:) + sin(pi * sin(phi) * sintheta); B(k,:) = B(k,:) + cos(pi * cos(phi-pi/4) * sintheta); B(k,:) = B(k,:) + sin(pi * sin(phi-pi/4) * sintheta); end B = B./max(max(abs(B))); figure; hold off plot(ur, 10 * log10(abs(b(1,:))), b- ); 3

12 hold on plot(ur, 10 * log10(abs(b(,:))), g-- ); plot(ur, 10 * log10(abs(b(3,:))), r-. ); axis([ ]); xlabel( \it u_r, Fontsize,14); ylabel( Beam pattern (db), Fontsize,14); title( Circular Array Beam pattern Cut ); h=legend( \phi = 0^\circ, \phi = 45^\circ, \phi=90^\circ, 3); set(h, Fontsize,1) 4

13 Problem - MPDR ˆ Recall that we had a 3-element ULA with six different plane waves impinging on the array. The snapshot vector: yrns 6 l1 s l rnsvpθ l q zrns, n 1,,..., M (1) where the angle of arrivals are θ 1 45 o, θ 60 o, θ 3 60 o, θ 4 90 o, θ o, and θ o. s 1 6rns are given as white noise sequences with variances as 0.5, 0.1, 0.1, 0.1, 0.15, and 0.1, respectively. zrns is a temporally and spatially zero mean white random vector with unit variance. ˆ We also have two different values of 5 o and 15 o. ˆ In this problem, we wish to plot the power spectrum of the MPDR beamformer which is given by the following equation: P pθq 1 v H pθqs x 1 vpθq where 0 θ π. Here S x is the (sample) covariance matrix of yrns and is given as: S x 1 N M n1 () yrnsy H rns (3) ˆ We plot the power spectrum P pθq for the two different values of. ˆ Figures 1 and show the required spatial spectra. 0.4 = 5 o P( ) o 45 o 60 o 60 o + 90 o 110 o 150 o 180 o Figure 1: Spatial spectrum with MPDR beamformer in a 3-element ULA with 5 o 1

14 0.35 = 15 o P( ) o 45 o 60 o 60 o + 90 o 110 o 150 o 180 o Figure : Spatial spectrum with MPDR beamformer in a 3-element ULA with 15 o The MATLAB code is given below: 1 % ECE 51D (Spring 017) HW #4 Problem 3 % Author: Govind Ravikumar Gopal (A ) 3 4 clear all; 5 close all; 6 clc; 7 8 % Initializations 9 N = 3; 10 M = 100; 11 L = 6; 1 13 l iter = (0:N 1).'; 14 y1 = zeros(n,m); 15 y = zeros(n,m); 16 delta = [5 15]; % in degrees v1 = exp(j*pi* (l iter (N 1)/) * cos(pi*45/180)); 19 v = exp(j*pi* (l iter (N 1)/) * cos(pi*60/180)); 0 v31 = exp(j*pi* (l iter (N 1)/) * cos(pi*(60+delta(1))/180)); 1 v3 = exp(j*pi* (l iter (N 1)/) * cos(pi*(60+delta())/180)); v4 = exp(j*pi* (l iter (N 1)/) * cos(pi*90/180)); 3 v5 = exp(j*pi* (l iter (N 1)/) * cos(pi*110/180)); 4 v6 = exp(j*pi* (l iter (N 1)/) * cos(pi*150/180)); 5 6 for n = 1:M 7 8 s1 = sqrt(0.5)*randn(1,m); 9 s = sqrt(0.1)*randn(1,m); 30 s3 = sqrt(0.1)*randn(1,m); 31 s4 = sqrt(0.)*randn(1,m); 3 s5 = sqrt(0.15)*randn(1,m); 33 s6 = sqrt(0.1)*randn(1,m); 34 z = randn(n,m); % random noise

15 35 y1(:,n) = v1.*s1(n) + v.*s(n) + v31.*s3(n) + v4.*s4(n) + v5.*s5(n) + v6.*s6(n) + z(:,n); 36 y(:,n) = v1.*s1(n) + v.*s(n) + v3.*s3(n) + v4.*s4(n) + v5.*s5(n) + v6.*s6(n) + z(:,n); 37 end % delta = 5 deg % calculate Sx 4 Sx = 0; 43 for ii = 1:M 44 Sx = Sx + y1(:,ii)*y1(:,ii)'; 45 end 46 Sx = Sx/M; theta = 0:0.001:pi; % array manifold 51 v theta = exp(j*pi * (l iter (N 1)/) * cos(theta)); 5 53 % spectrum 54 P = zeros(length(theta),1); 55 for ii = 1:length(theta) 56 P(ii) = 1./(v theta(:,ii)'*inv(sx)*v theta(:,ii)); 57 end % plot 60 figure; 61 plot(theta,abs(p),'linewidth',1.5); 6 xticks([0 pi*45/180 pi*60/180 pi*(60+delta(1))/180 pi*90/180 pi*110/180 pi*150/180 pi]); 63 xticklabels({'0ˆ{o}','45ˆ{o}','60ˆ{o}',' 60ˆ{o}+\Delta','90ˆ{o}','110ˆ{o}','150ˆ{o}','180ˆ 64 xlim([0 pi]); 65 xlabel('\theta'); 66 ylabel('p(\theta)'); 67 title('\delta = 5ˆ{o}'); 68 grid on; % delta = 15 deg 71 7 Sx = 0; 73 for ii = 1:M 74 Sx = Sx + y(:,ii)*y(:,ii)'; 75 end 76 Sx = Sx/M; P = zeros(length(theta),1); 79 for ii = 1:length(theta) 80 P(ii) = 1./(v theta(:,ii)'*inv(sx)*v theta(:,ii)); 81 end 8 83 figure; 84 plot(theta,abs(p),'linewidth',1.5); 85 xticks([0 pi*45/180 pi*60/180 pi*(60+delta())/180 pi*90/180 pi*110/180 pi*150/180 pi]); 86 xticklabels({'0ˆ{o}','45ˆ{o}','60ˆ{o}','60ˆ{o}+\delta','90ˆ{o}','110ˆ{o}','150ˆ{o}','180ˆ{o}'}); 87 xlim([0 pi]); 88 xlabel('\theta'); 89 ylabel('p(\theta)'); 90 title('\delta = 15ˆ{o}'); 91 grid on; 3

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

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

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

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

Appendix A Solution of Waveform Design Optimization Problem

Appendix A Solution of Waveform Design Optimization Problem Appix A Solution of Waveform Design Optimization Problem A.1 Preliminaries This section presents some preliminary results used in the proofs throughout the paper. For proofs of the following theorems,

More information

Homework Set #7 - Solutions

Homework Set #7 - Solutions 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

More information

Array Antennas. Chapter 6

Array Antennas. Chapter 6 Chapter 6 Array Antennas An array antenna is a group of antenna elements with excitations coordinated in some way to achieve desired properties for the combined radiation pattern. When designing an array

More information

Warning, the protected names norm and trace have been redefined and unprotected

Warning, the protected names norm and trace have been redefined and unprotected 22M:28 Spring 5 J. Simon An example of computing a triple integral with several coordinate systems > > with(plots):with(linalg): Warning, the name changecoords has been redefined Warning, the protected

More information

Statistical methods. Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra

Statistical methods. Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra Statistical methods Mean value and standard deviations Standard statistical distributions Linear systems Matrix algebra Statistical methods Generating random numbers MATLAB has many built-in functions

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

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

Terminology Suppose we have N observations {x(n)} N 1. Estimators as Random Variables. {x(n)} N 1

Terminology Suppose we have N observations {x(n)} N 1. Estimators as Random Variables. {x(n)} N 1 Estimation Theory Overview Properties Bias, Variance, and Mean Square Error Cramér-Rao lower bound Maximum likelihood Consistency Confidence intervals Properties of the mean estimator Properties of the

More information

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this:

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this: UCSD SIOC 221A: (Gille) 1 Lecture 17: Recap We ve now spent some time looking closely at coherence and how to assign uncertainties to coherence. Can we think about coherence in a different way? There are

More information

2D Plotting with Matlab

2D Plotting with Matlab GEEN 1300 Introduction to Engineering Computing Class Meeting #22 Monday, Nov. 9 th Engineering Computing and Problem Solving with Matlab 2-D plotting with Matlab Script files User-defined functions Matlab

More information

Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as

Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as Chapter 5 Solutions Problem 5.1 Consider the driven, two-well Duffing s oscillator which can be written in state variable form as ẍ + ɛγẋ x + x 3 = ɛf cos(ωt) ẋ = v v = x x 3 + ɛ( γv + F cos(ωt)). In the

More information

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1 HW3 Solutions Pr..8 (a) The DTFT of c[n] is C(e jω ) = = =.5 n e jωn + n=.5e jω + n= m=.5 n e jωn.5 m e jωm.5e jω +.5e jω.75 =.5 cos(ω) }{{}.5e jω /(.5e jω ) C(e jω ) is the power spectral density. (b)

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

ENGR Spring Exam 2

ENGR Spring Exam 2 ENGR 1300 Spring 013 Exam INSTRUCTIONS: Duration: 60 minutes Keep your eyes on your own work! Keep your work covered at all times! 1. Each student is responsible for following directions. Read carefully..

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

4 Gaussian Mixture Models

4 Gaussian Mixture Models 4 Gaussian Mixture Models Once you have a collection of feature vectors you will need to describe their distribution. You will do this using a Gaussian Mixture Model. The GMM comprises a collection of

More information

New Mexico Tech Hyd 510

New Mexico Tech Hyd 510 Vectors vector - has magnitude and direction (e.g. velocity, specific discharge, hydraulic gradient) scalar - has magnitude only (e.g. porosity, specific yield, storage coefficient) unit vector - a unit

More information

Beamforming. A brief introduction. Brian D. Jeffs Associate Professor Dept. of Electrical and Computer Engineering Brigham Young University

Beamforming. A brief introduction. Brian D. Jeffs Associate Professor Dept. of Electrical and Computer Engineering Brigham Young University Beamforming A brief introduction Brian D. Jeffs Associate Professor Dept. of Electrical and Computer Engineering Brigham Young University March 2008 References Barry D. Van Veen and Kevin Buckley, Beamforming:

More information

ADAPTIVE ANTENNAS. SPATIAL BF

ADAPTIVE ANTENNAS. SPATIAL BF ADAPTIVE ANTENNAS SPATIAL BF 1 1-Spatial reference BF -Spatial reference beamforming may not use of embedded training sequences. Instead, the directions of arrival (DoA) of the impinging waves are used

More information

The Selection of Weighting Functions For Linear Arrays Using Different Techniques

The Selection of Weighting Functions For Linear Arrays Using Different Techniques The Selection of Weighting Functions For Linear Arrays Using Different Techniques Dr. S. Ravishankar H. V. Kumaraswamy B. D. Satish 17 Apr 2007 Rajarshi Shahu College of Engineering National Conference

More information

Introduction to Signal Analysis Parts I and II

Introduction to Signal Analysis Parts I and II 41614 Dynamics of Machinery 23/03/2005 IFS Introduction to Signal Analysis Parts I and II Contents 1 Topics of the Lecture 11/03/2005 (Part I) 2 2 Fourier Analysis Fourier Series, Integral and Complex

More information

January 18, 2008 Steve Gu. Reference: Eta Kappa Nu, UCLA Iota Gamma Chapter, Introduction to MATLAB,

January 18, 2008 Steve Gu. Reference: Eta Kappa Nu, UCLA Iota Gamma Chapter, Introduction to MATLAB, Introduction to MATLAB January 18, 2008 Steve Gu Reference: Eta Kappa Nu, UCLA Iota Gamma Chapter, Introduction to MATLAB, Part I: Basics MATLAB Environment Getting Help Variables Vectors, Matrices, and

More information

Beamspace Adaptive Beamforming and the GSC

Beamspace Adaptive Beamforming and the GSC April 27, 2011 Overview The MVDR beamformer: performance and behavior. Generalized Sidelobe Canceller reformulation. Implementation of the GSC. Beamspace interpretation of the GSC. Reduced complexity of

More information

1.1.3 The narrowband Uniform Linear Array (ULA) with d = λ/2:

1.1.3 The narrowband Uniform Linear Array (ULA) with d = λ/2: Seminar 1: Signal Processing Antennas 4ED024, Sven Nordebo 1.1.3 The narrowband Uniform Linear Array (ULA) with d = λ/2: d Array response vector: a() = e e 1 jπ sin. j(π sin )(M 1) = 1 e jω. e jω(m 1)

More information

Chapter 3 + some notes on counting the number of degrees of freedom

Chapter 3 + some notes on counting the number of degrees of freedom Chapter 3 + some notes on counting the number of degrees of freedom Minimum number of independent parameters = Some number of dependent parameters minus the number of relationships (equations) you can

More information

Solutions - Homework # 3

Solutions - Homework # 3 ECE-34: Signals and Systems Summer 23 PROBLEM One period of the DTFS coefficients is given by: X[] = (/3) 2, 8. Solutions - Homewor # 3 a) What is the fundamental period 'N' of the time-domain signal x[n]?

More information

Filtering Color Mapped Textures and Surfaces

Filtering Color Mapped Textures and Surfaces Filtering Color Mapped Textures and Surfaces Eric Heitz, Derek Nowrouzezahrai Pierre Poulin Fabrice Neyret Universite de Grenoble and CNRS Universite de Montre al Abstract This document provides additional

More information

COMP MATLAB.

COMP MATLAB. COMP1131 MATLAB chenyang@fudan.edu.cn 1 2 (x, y ) [(x 1,y 1 ) (x 2,y 2 ) (x n,y n )] Y=f(X) X [x 1,x 2,...,x n ] Y [y 1,y 2,,y n ] 3 MATLAB 4 figure figure figure(n): n figure(n) 5 y = x + sin x (x [ π

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

Milankowitch Cycles. 1 Coordinates. 2 Rotation matrix of Eulerian angles. (%i1) kill(all); (%o0) done

Milankowitch Cycles. 1 Coordinates. 2 Rotation matrix of Eulerian angles. (%i1) kill(all); (%o0) done 369(9-rot.wxm 1 / 1 Milankowitch Cycles (%i1 kill(all; (%o one 1 Coorinates (%i1 epens([x,y,theta,phi,psi,theta_1,t,u,l,r,omega],t; (%o1 [x( t,y( t,( t,'( t,( t, 1 ( t,t( t,u( t,l( t,r( t,!( t ] (%i e_r:

More information

Linear and Nonlinear Properties of Pancharatnam s Phase in Polarization Optics. Hyrum Richardson

Linear and Nonlinear Properties of Pancharatnam s Phase in Polarization Optics. Hyrum Richardson Linear and Nonlinear Properties of Pancharatnam s Phase in Polarization Optics Hyrum Richardson A senior thesis submitted to the faculty of Brigham Young University in partial fulfillment of the requirements

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

Real-Valued Khatri-Rao Subspace Approaches on the ULA and a New Nested Array

Real-Valued Khatri-Rao Subspace Approaches on the ULA and a New Nested Array Real-Valued Khatri-Rao Subspace Approaches on the ULA and a New Nested Array Huiping Duan, Tiantian Tuo, Jun Fang and Bing Zeng arxiv:1511.06828v1 [cs.it] 21 Nov 2015 Abstract In underdetermined direction-of-arrival

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

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

Laboratory handout 1 Mathematical preliminaries

Laboratory handout 1 Mathematical preliminaries laboratory handouts, me 340 2 Laboratory handout 1 Mathematical preliminaries In this handout, an expression on the left of the symbol := is defined in terms of the expression on the right. In contrast,

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

2. MATLAB Basics. (d) array1([1 3],end) consists of the elements in the first and third rows on the last column of array1:

2. MATLAB Basics. (d) array1([1 3],end) consists of the elements in the first and third rows on the last column of array1: 2. MATLAB Basics 2.1 (a) The size of array1 is 4 5. (b) The value of array1(1,4) is -3.5. (c) array1(:,1:2:5) is a 4 3 array consisting of the first, third, and fifth columns of array1: >> array1(:,1:2:5)

More information

LAB 1: MATLAB - Introduction to Programming. Objective:

LAB 1: MATLAB - Introduction to Programming. Objective: LAB 1: MATLAB - Introduction to Programming Objective: The objective of this laboratory is to review how to use MATLAB as a programming tool and to review a classic analytical solution to a steady-state

More information

S(c)/ c = 2 J T r = 2v, (2)

S(c)/ c = 2 J T r = 2v, (2) M. Balda LMFnlsq Nonlinear least squares 2008-01-11 Let us have a measured values (column vector) y depent on operational variables x. We try to make a regression of y(x) by some function f(x, c), where

More information

Homework 6. April 11, H(s) = Y (s) X(s) = s 1. s 2 + 3s + 2

Homework 6. April 11, H(s) = Y (s) X(s) = s 1. s 2 + 3s + 2 Homework 6 April, 6 Problem Steady state of LTI systems The transfer function of an LTI system is H(s) = Y (s) X(s) = s s + 3s + If the input to this system is x(t) = + cos(t + π/4), < t

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.685 Electric Machines Problem Set solutions September 8, 3 e dλ dt Problem : Torque is, for this system,

More information

EEM 409. Random Signals. Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Problem 2:

EEM 409. Random Signals. Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Problem 2: EEM 409 Random Signals Problem Set-2: (Power Spectral Density, LTI Systems with Random Inputs) Problem 1: Consider a random process of the form = + Problem 2: X(t) = b cos(2π t + ), where b is a constant,

More information

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2 Norwegian University of Science and Technology Department of Electronics and Telecommunications TTT42 Digital Signal Processing Suggested Solutions for Problem Set 2 Problem (a) The spectrum X(ω) can be

More information

On the implementation of effective methods to solve inverse scattering problems with multiply scattering point targets

On the implementation of effective methods to solve inverse scattering problems with multiply scattering point targets On the implementation of effective methods to solve inverse scattering problems with multiply scattering point targets Luis E. Tirado ltirado@gmail.com ECE G293 December 5, 2008 Electrical and Computer

More information

Solutions to Homework 8 - Continuous-Time Markov Chains

Solutions to Homework 8 - Continuous-Time Markov Chains Solutions to Homework 8 - Continuous-Time Markov Chains 1) Insurance cash flow. A) CTMC states. Since we assume that c, d and X max are integers, while the premiums that the customers pay are worth 1,

More information

Generalized Sidelobe Canceller and MVDR Power Spectrum Estimation. Bhaskar D Rao University of California, San Diego

Generalized Sidelobe Canceller and MVDR Power Spectrum Estimation. Bhaskar D Rao University of California, San Diego Generalized Sidelobe Canceller and MVDR Power Spectrum Estimation Bhaskar D Rao University of California, San Diego Email: brao@ucsd.edu Reference Books 1. Optimum Array Processing, H. L. Van Trees 2.

More information

Delay-and-Sum Beamforming for Plane Waves

Delay-and-Sum Beamforming for Plane Waves Delay-and-Sum Beamforming for Plane Waves ECE 6279: Spatial Array Processing Spring 2011 Lecture 6 Prof. Aaron D. Lanterman School of Electrical & Computer Engineering Georgia Institute of Technology AL:

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.685 Electric Machines Problem Set Solutions September 17, 5 Problem 1: First, note that λ 1 = L 1 i 1 +

More information

ME352 Project 4. Internal Combustion Engine Analysis. Jeremy Bourque Lab Division 9 April 24 th, 2018

ME352 Project 4. Internal Combustion Engine Analysis. Jeremy Bourque Lab Division 9 April 24 th, 2018 ME352 Project 4 Internal Combustion Engine Analysis Jeremy Bourque Lab Division 9 April 24 th, 2018 Summary of Report This project aims to model an internal combustion engine from a lawnmower as a slidercrank

More information

EEO 401 Digital Signal Processing Prof. Mark Fowler

EEO 401 Digital Signal Processing Prof. Mark Fowler EEO 4 Digital Signal Processing Pro. Mark Fowler ote Set # Using the DFT or Spectral Analysis o Signals Reading Assignment: Sect. 7.4 o Proakis & Manolakis Ch. 6 o Porat s Book /9 Goal o Practical Spectral

More information

EGR 140 Lab 6: Functions and Function Files Topics to be covered : Practice :

EGR 140 Lab 6: Functions and Function Files Topics to be covered : Practice : EGR 140 Lab 6: Functions and Function Files Topics to be covered : Creating a Function File Structure of a Function File Function Definition Line Input and Output Arguments Function Body Local and Global

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems Problem Set 3 Solutions February 14, 2011 Problem 1: Voltage across

More information

An Introduction to MatLab

An Introduction to MatLab Introduction to MatLab 1 An Introduction to MatLab Contents 1. Starting MatLab... 3 2. Workspace and m-files... 4 3. Help... 5 4. Vectors and Matrices... 5 5. Objects... 8 6. Plots... 10 7. Statistics...

More information

Continuous time Markov chains (week 8) Solutions

Continuous time Markov chains (week 8) Solutions Continuous time Markov chains (week 8) Solutions 1 Insurance cash flow. A CTMC states. Because c and d are assumed to be integers, and the premiums are each 1, the cash flow X(t) of the insurance company

More information

Using Matlab for Laboratory Data Reduction

Using Matlab for Laboratory Data Reduction Data Collected Using Matlab for Laboratory Data Reduction Munson, Young, and Okiishi [1] provide laboratory data for the measurement of the viscosity of water with a capillary tube viscometer. The viscometer

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

Introduction. Matlab output for Problems 1 2. SOLUTIONS (Carl Tape) Ge111, Assignment #3: Gravity April 25, 2006

Introduction. Matlab output for Problems 1 2. SOLUTIONS (Carl Tape) Ge111, Assignment #3: Gravity April 25, 2006 SOLUTIONS (Carl Tape) Ge111, Assignment #3: Gravity April 25, 26 Introduction The point of this solution set is merely to plot the gravity data and show the basic computations. This document contains a

More information

While the poor efficiency of the small antennas discussed in the last unit limits their

While the poor efficiency of the small antennas discussed in the last unit limits their Unit 3 Linear Wire Antennas and Antenna Arrays While the poor efficiency of the small antennas discussed in the last unit limits their practicality, the ideas encountered in analyzing them are very useful

More information

From Fourier Series to Analysis of Non-stationary Signals - X

From Fourier Series to Analysis of Non-stationary Signals - X From Fourier Series to Analysis of Non-stationary Signals - X prof. Miroslav Vlcek December 14, 21 Contents Stationary and non-stationary 1 Stationary and non-stationary 2 3 Contents Stationary and non-stationary

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

Written Examination. Antennas and Propagation (AA ) June 22, 2018.

Written Examination. Antennas and Propagation (AA ) June 22, 2018. Written Examination Antennas and Propagation (AA. 7-8 June, 8. Problem ( points A circular loop of radius a = cm is positioned at a height h over a perfectly electric conductive ground plane as in figure,

More information

Technische Universität Berlin SS 2015 Institut für Mathematik Prof. Dr. G. Bärwolff Sekr. MA

Technische Universität Berlin SS 2015 Institut für Mathematik Prof. Dr. G. Bärwolff Sekr. MA Technische Universität Berlin SS 2015 Institut für Mathematik Prof. Dr. G. Bärwolff Sekr. MA 4-5 2.06.2015 3. Exercise sheet - Solutions 1 FV/FD-Methods for the solution of pde s Discussion: 8.6.15-15.6.15

More information

Two-Dimensional Sparse Arrays with Hole-Free Coarray and Reduced Mutual Coupling

Two-Dimensional Sparse Arrays with Hole-Free Coarray and Reduced Mutual Coupling Two-Dimensional Sparse Arrays with Hole-Free Coarray and Reduced Mutual Coupling Chun-Lin Liu and P. P. Vaidyanathan Dept. of Electrical Engineering, 136-93 California Institute of Technology, Pasadena,

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science Electric Machines Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.685 Electric Machines Problem Set 11 Solutions November 27, 211 Problem 1: Variable Reluctance Motor Much

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

ECE580 Solution to Problem Set 4

ECE580 Solution to Problem Set 4 ECE580 Fall 05 Solution to Problem Set 4 December 8, 05 ECE580 Solution to Problem Set 4 These problems are from the textbook by Chong and Zak, 4th edition, which is the textbook for the ECE580 Fall 05

More information

Temperature measurement

Temperature measurement Luleå University of Technology Johan Carlson Last revision: July 22, 2009 Measurement Technology and Uncertainty Analysis - E7021E Lab 3 Temperature measurement Introduction In this lab you are given a

More information

CHAPTER 7. The Discrete Fourier Transform 436

CHAPTER 7. The Discrete Fourier Transform 436 CHAPTER 7. The Discrete Fourier Transform 36 hfa figconfg( P7a, long ); subplot() stem(k,abs(ck), filled );hold on stem(k,abs(ck_approx), filled, color, red ); xlabel( k, fontsize,lfs) title( Magnitude

More information

Math 343 Lab 7: Line and Curve Fitting

Math 343 Lab 7: Line and Curve Fitting Objective Math 343 Lab 7: Line and Curve Fitting In this lab, we explore another use of linear algebra in statistics. Specifically, we discuss the notion of least squares as a way to fit lines and curves

More information

Problem 1 (10 points)

Problem 1 (10 points) y x CHEN 1703 - HOMEWORK 4 Submit your MATLAB solutions via the course web site. Be sure to include your name and UNID in your m-file. Submit each solution seperately. Also be sure to document your solutions

More information

ECE 3793 Matlab Project 3 Solution

ECE 3793 Matlab Project 3 Solution ECE 3793 Matlab Project 3 Solution Spring 27 Dr. Havlicek. (a) In text problem 9.22(d), we are given X(s) = s + 2 s 2 + 7s + 2 4 < Re {s} < 3. The following Matlab statements determine the partial fraction

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

ECE2111 Signals and Systems UMD, Spring 2013 Experiment 1: Representation and manipulation of basic signals in MATLAB

ECE2111 Signals and Systems UMD, Spring 2013 Experiment 1: Representation and manipulation of basic signals in MATLAB ECE2111 Signals and Systems UMD, Spring 2013 Experiment 1: Representation and manipulation of basic signals in MATLAB MATLAB is a tool for doing numerical computations with matrices and vectors. It can

More information

Introduction to Dynamical Systems. Tuesday, September 9, 14

Introduction to Dynamical Systems. Tuesday, September 9, 14 Introduction to Dynamical Systems 1 Dynamical Systems A dynamical system is a set of related phenomena that change over time in a deterministic way. The future states of the system can be predicted from

More information

ROBUST ADAPTIVE BEAMFORMING BASED ON CO- VARIANCE MATRIX RECONSTRUCTION FOR LOOK DIRECTION MISMATCH

ROBUST ADAPTIVE BEAMFORMING BASED ON CO- VARIANCE MATRIX RECONSTRUCTION FOR LOOK DIRECTION MISMATCH Progress In Electromagnetics Research Letters, Vol. 25, 37 46, 2011 ROBUST ADAPTIVE BEAMFORMING BASED ON CO- VARIANCE MATRIX RECONSTRUCTION FOR LOOK DIRECTION MISMATCH R. Mallipeddi 1, J. P. Lie 2, S.

More information

the robot in its current estimated position and orientation (also include a point at the reference point of the robot)

the robot in its current estimated position and orientation (also include a point at the reference point of the robot) CSCI 4190 Introduction to Robotic Algorithms, Spring 006 Assignment : out February 13, due February 3 and March Localization and the extended Kalman filter In this assignment, you will write a program

More information

ECE Spring Prof. David R. Jackson ECE Dept. Notes 32

ECE Spring Prof. David R. Jackson ECE Dept. Notes 32 ECE 6345 Spring 215 Prof. David R. Jackson ECE Dept. Notes 32 1 Overview In this set of notes we extend the spectral-domain method to analyze infinite periodic structures. Two typical examples of infinite

More information

ECE Spring Prof. David R. Jackson ECE Dept. Notes 1

ECE Spring Prof. David R. Jackson ECE Dept. Notes 1 ECE 6341 Spring 16 Prof. David R. Jackson ECE Dept. Notes 1 1 Fields in a Source-Free Region Sources Source-free homogeneous region ( ε, µ ) ( EH, ) Note: For a lossy region, we replace ε ε c ( / ) εc

More information

Matlab Section. November 8, 2005

Matlab Section. November 8, 2005 Matlab Section November 8, 2005 1 1 General commands Clear all variables from memory : clear all Close all figure windows : close all Save a variable in.mat format : save filename name of variable Load

More information

Nonlinear Least Squares Curve Fitting

Nonlinear Least Squares Curve Fitting Nonlinear Least Squares Curve Fitting Jack Merrin February 12, 2017 1 Summary There is no general solution for the minimization of chi-squared to find the best estimates of the parameters when the model

More information

HW6. 1. Book problems 8.5, 8.6, 8.9, 8.23, 8.31

HW6. 1. Book problems 8.5, 8.6, 8.9, 8.23, 8.31 HW6 1. Book problems 8.5, 8.6, 8.9, 8.3, 8.31. Add an equal strength sink and a source separated by a small distance, dx, and take the limit of dx approaching zero to obtain the following equations for

More information

GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING

GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING ECE 2026 Summer 2018 Problem Set #1 Assigned: May 14, 2018 Due: May 22, 2018 Reading: Chapter 1; App. A on Complex Numbers,

More information

Homework 1 Solutions

Homework 1 Solutions 18-9 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 18 Homework 1 Solutions Part One 1. (8 points) Consider the DT signal given by the algorithm: x[] = 1 x[1] = x[n] = x[n 1] x[n ] (a) Plot

More information

Bfh Ti Control F Ws 2008/2009 Lab Matlab-1

Bfh Ti Control F Ws 2008/2009 Lab Matlab-1 Bfh Ti Control F Ws 2008/2009 Lab Matlab-1 Theme: The very first steps with Matlab. Goals: After this laboratory you should be able to solve simple numerical engineering problems with Matlab. Furthermore,

More information

Differential Lengths, Surfaces and Volumes

Differential Lengths, Surfaces and Volumes Differential Lengths, Surfaces and Volumes When integrating along lines, over surfaces, or throughout volumes, the ranges of the respective variables define the limits of the respective integrations. In

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 212-12-2 1. (a) The forgetting factor balances the accuracy and the adaptation speed of the RLS algorithm. This as the forgetting factor controls

More information

George Mason University ECE 201: Introduction to Signal Analysis Spring 2017

George Mason University ECE 201: Introduction to Signal Analysis Spring 2017 Assigned: March 20, 2017 Due Date: Week of April 03, 2017 George Mason University ECE 201: Introduction to Signal Analysis Spring 2017 Laboratory Project #6 Due Date Your lab report must be submitted on

More information

Naive Bayes & Introduction to Gaussians

Naive Bayes & Introduction to Gaussians Naive Bayes & Introduction to Gaussians Andreas C. Kapourani 2 March 217 1 Naive Bayes classifier In the previous lab we illustrated how to use Bayes Theorem for pattern classification, which in practice

More information

Statistics Assignment 2 HET551 Design and Development Project 1

Statistics Assignment 2 HET551 Design and Development Project 1 Statistics Assignment HET Design and Development Project Michael Allwright - 74634 Haddon O Neill 7396 Monday, 3 June Simple Stochastic Processes Mean, Variance and Covariance Derivation The following

More information

Digital Signal Processing: Signal Transforms

Digital Signal Processing: Signal Transforms Digital Signal Processing: Signal Transforms Aishy Amer, Mohammed Ghazal January 19, 1 Instructions: 1. This tutorial introduces frequency analysis in Matlab using the Fourier and z transforms.. More Matlab

More information

1 Mechanistic and generative models of network structure

1 Mechanistic and generative models of network structure 1 Mechanistic and generative models of network structure There are many models of network structure, and these largely can be divided into two classes: mechanistic models and generative or probabilistic

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

ECE Spring Prof. David R. Jackson ECE Dept. Notes 26

ECE Spring Prof. David R. Jackson ECE Dept. Notes 26 ECE 6345 Spring 05 Prof. David R. Jackson ECE Dept. Notes 6 Overview In this set of notes we use the spectral-domain method to find the mutual impedance between two rectangular patch ennas. z Geometry

More information

Probability review (week 3) Solutions

Probability review (week 3) Solutions Probability review (week 3) Solutions 1 Decision making. A Simulate individual experiment. Solution: Here, you can find three versions of the function. Each one revealing a programming technique (The ideas

More information

Mathematics Review Exercises. (answers at end)

Mathematics Review Exercises. (answers at end) Brock University Physics 1P21/1P91 Mathematics Review Exercises (answers at end) Work each exercise without using a calculator. 1. Express each number in scientific notation. (a) 437.1 (b) 563, 000 (c)

More information