EE 355 / GP 265 Homework 3 Solutions Winter

Size: px
Start display at page:

Download "EE 355 / GP 265 Homework 3 Solutions Winter"

Transcription

1 EE 355 / GP 265 Homework 3 Solutions Winter February 8, Doppler centroid (a) Plot of the azimuth spectrum of the data averaged over all valid range bins: 90 Problem 1a: average azimuth spectrum Magnitude (db) Frequency (Hz) First, create the reference chirp signal for ERS parameters, then correlate each range line with it to get the range-compressed image. Then keep only the valid data from the correlation. (The original ERS data in complex form has 4903 range bins, and the reference chirp has 703 samples, so I keep =4200 range bins in the range-compressed image.) Then compute the FFT of each azimuth line in the range-compressed image, and average the azimuth spectrum over the 4200 valid range bins. 1

2 (b) Determine the Doppler centroid using the spectrum in (a) and also the average phase change method. Using the spectrum in (a), the Doppler centroid frequency is at the maximum value, except for the anomalous spike at 0 Hz: -300 Hz. For the average phase change method, compute the phase shift ϕ(ir) at each range bin ir from line iaz to line iaz 1 in azimuth (here R is the range-compressed image): P (ir) = Naz iaz=2 R(ir, iaz)r 1 Im(P (ir)) (ir, iaz 1), ϕ(ir) = tan Re(P (ir)) (1) Average ϕ(ir) over all range bins to compute the Doppler centroid f D = Hz. ϕ = Nr ir=1 ϕ(ir), Nr ϕ 2π = f D prf f D = prf ϕ 2π (2) function c h i r p=makechirp ( s, tau, fs, fc, s t a r t, n) %s : s l o p e %tau : p u l s e l e n g t h %f s : sample r a t e %f c : c e n t e r frequency %s t a r t : s t a r t i n g l o c a t i o n of c h i r p %n : number o f samples dt=1/ f s ; % sampling time i n t e r v a l npts=floor ( tau / dt ) ; % number of p o i n t s of the c h i r p s i g n a l t=( npts / 2 : npts /2 1) dt ; phase=pi s t.ˆ2+2 pi f c t ; % c h i r p =[ z e r o s (1, s t a r t 1) exp (1 i phase ) z e r o s (1,n l e n g t h ( phase) s t a r t +1)] c h i r p=zeros (n, 1 ) ; c h i r p ( s t a r t : s t a r t+npts 1)=exp(1 i phase ) ; return % Unfocused SAR p r o c e s s o r p a r t 1 : range compression & determine d o p p l e r c e clear ; clc ; close a l l ; %% do we need to do range compression? i f so, s e t f l a g r g c p =1 f l a g r g c p =1; n l i n e =10100; nrgbin =( )/2; %% make c h i r p 2

3 s = e11 ; % Chirp slope, Hz/ s tau =37.12 e 6; % Pulse length, s f s =18.96 e6 ; % Complex sample rate, Hz f c =0; % Center frequency ( Carrier frequency ) Nsample =( )/2; % Number of samples N=Nsample ; % c h i r p l e n g t h dt=1/ f s ; % Sample spacing in time domain df=f s /N; % Sample spacing in frequency domain f=( N/ 2 :N/2 1) df ; r e f c h i r p=makechirp ( s, tau, fs, fc, 1, Nsample ) ; r e f s p e c t =( f f t ( r e f c h i r p ) ) ; r e f s p e c t d b =20 log10 ( abs ( r e f s p e c t )+1e 30); i f f l a g r g c p==1 %% read data f i d=fopen ( e r s d a t a. hw3, r ) ; data=fread ( f i d, [ , ], uint8 ) ; data=data ; fclose ( f i d ) ; data=data 15.5; n l i n e =10100; data1=data ( :, : ) ; r e a l d=data1 ( :, 1 : 2 : ) ; imagd=data1 ( :, 2 : 2 : ) ; datacp=complex ( reald, imagd ) ; %% range compression s p e c t d a t a=f f t ( datacp, Nsample, 2 ) ; data rgcp=zeros ( n line, nrgbin ) ; for i =1: n l i n e data rgcp ( i, : ) = ( i f f t ( s p e c t d a t a ( i, : ). conj ( r e f s p e c t. ) ) ) ; figure imagesc ( abs ( data rgcp ) ) colormap( gray ) t i t l e ( Range compressed image ) xlabel ( range ) ylabel ( azimuth ) axis on 3

4 save ( d a t r c, data rgcp ) %% Average azimuth s p e c t r a load d a t r c % azimuth parameters p r f =1679.9; % Pulse r e p e t i t i o n frequency, Hz r 0 =830000; % Near range, m v e l =7550; % Platform v e l o c i t y, m/ s wvlen =0.0566; % Wavelength, m dt2=1/ p r f ; df2=p r f / n l i n e ; n v a l i d=nsample floor ( tau f s ) ; rcomp=data rgcp ( :, 1 : n v a l i d ) ; s p e c t a z=f f t ( rcomp ) ; s p e c t a v e r a z=mean( abs ( s p e c t a z ), 2 ) ; spectdb az =20 log10 ( abs ( s p e c t a v e r a z ) ) ; f 2=linspace( p r f /2, p r f /2, n l i n e ) ; figure plot ( f2, f f t s h i f t ( spectdb az ) ) xlabel ( f ) ylabel ( S ( f ), db ) t i t l e ( Average Azimuth Spectrum ) grid on ; saveas ( gcf, pb1 a. t i f, t i f f ) % e s t i m a t e f d c e n t r o i d using the average phase change method for i =1: n v a l i d bin=rcomp ( 2 :, i ). conj ( rcomp ( 1 : 1, i ) ) ; r e s u l t=sum( bin ) ; phase ( i )=atan (imag( r e s u l t )/ real ( r e s u l t ) ) ; avgphase=mean( phase ) ; fdcen=avgphase /2/ pi p r f ; d i s p l a y ( fdcen, Doppler c e n t r o i d i s estimated to be ) save ( fdcen, fdcen ) 2. An unfocused SAR processor 4

5 (a) Parameters of an unfocused processor for the radar in (1). The azimuth resolution is: δ az = λr 0 = ( m)( m) = m (3) The pulse spacing in azimuth is: p = v prf 7550 m/s = = m (4) Hz The minimum number of pulses is (using Method 2 in Handout 19): δaz m min np = = = 49 pulses (5) p m Rounding up to the next highest power of 2, we use np = 64 pulses in a burst. The frequency resolution is δf = prf np The output pixel spacing is then = Hz 64 pulses = Hz (6) δx = (δf)λr 0 2v = (26.25 Hz)( m)( m) (2)(7550 m/s) = m (7) The burst length is δt = np prf The repeat cycle time for a 10 m long antenna is: 64 pulses = = s (8) Hz t cycle = r 0λ lv = ( m)( m) (10 m)(7550 m/s) = s (9) (b) Single-patch unfocused image from the first np = 64 lines of the file (with 4 range looks). The effect of the antenna pattern is clearly visible. The targets in the middle of the patch are brighter than the ones on the edges. To take range looks, we downsample in the range direction by a factor of 4 so that the output pixel spacing in the range direction is equal to the output pixel spacing in the azimuth direction (δx = m), which will give us square pixels. 5

6 Azimuth samples Problem 2b: Single patch unfocused image, 4 range looks Range samples (c) Patch to patch spacing (offset between patches) if we want to process all of the data: patch = ( p)(np) δx = (4.494 m)(64 pulses) (81.66 m) = pixels (10) The patch spacing is not a whole number, so we alternate between taking 3 and 4 pixels for the patch-to-patch spacing when computing the multi-looked image in part (d). (d) Image from multi-looked unfocused processor. First compute the number of looks (patches) given the amount of data: naz az lines nlooks = = = 157 looks (11) np 64 pulses Then compute the number of azimuth pixels in the multi-looked image, to preallocate space: N az,look = np + (nlooks 1) patch = 613 samples (12) Multi-look unfocused image, without taking range looks: Azimuth samples Problem 2d: Multi-look unfocused image Range samples

7 Multi-look unfocused image, with 4 range looks (so we have square pixels): this looks like a map of the San Francisco Bay Area. Azimuth samples Problem 2d: Multi-look unfocused image, 4 range looks Range samples % Unfocused SAR p r o c e s s o r part2 : % Range d o p p l e r p r o c e s s i n g clear ; clc ; close a l l % c h i r p parameter s = e11 ; % Chirp slope, Hz/ s tau =37.12 e 6; % Pulse length, s f s =18.96 e6 ; % Complex sample rate, Hz f c =0; % Center frequency ( Carrier frequency ) Nsample =( )/2; % Number of samples % more parameters load d a t r c load fdcen p r f =1679.9; % Pulse r e p e t i t i o n frequency, Hz r 0 =830000; % Near range, m v e l =7550; % Platform v e l o c i t y, m/ s wvlen =0.0566; % Wavelength, m l =10; % Antenna l e n g t h 7

8 n v a l i d=nsample floor ( tau f s ) ; % v a l i d number of range of b i n s rcomp=data rgcp ( :, 1 : n v a l i d ) ; Naz =10100; % range d o p p l e r mapping parameters d e l t a a z =(wvlen r0 ) ˆ 0. 5 ; % azimuth r e s o l u t i o n pulsp=v e l / p r f ; % p u l s e spacing Nmin=round( d e l t a a z / pulsp ) ; p a t c h s i z e =2ˆ c e i l ( log (Nmin)/ log ( 2 ) ) ; l e n b u r s t=p a t c h s i z e / p r f ; % b u r s t l e n g t h d e l t a f r e q=p r f / p a t c h s i z e ; % f r e q u e c y r e s o l u t i o n d e l t a x= d e l t a f r e q wvlen r0 /2/ v e l ; % output p i x e l spacing azbw= r0 wvlen / l ; % Azimuth beamwidth i n t e r v a l=azbw/ v e l ; % r e p e a t i n t e r v a l %% Doppler c e n t r o i d c o r r e c t i o n rcompfd=zeros (Naz, n v a l i d ) ; for i =1:Naz az=rcomp ( i, : ) exp( (1 j ) 2 pi fdcen i / p r f ) ; rcompfd ( i, : ) = az ; % check i f we have done doppler c e n t r o i d c o r r e c t i o n c o r r e c t l y s p e c t a z=f f t s h i f t ( f f t ( rcompfd, [ ], 1 ) ) ; s p e c t a v e r a z=mean( abs ( s p e c t a z ), 2 ) ; spectdb az =20 log10 ( abs ( s p e c t a v e r a z ) ) ; figure plot ( spectdb az ) xlabel ( f ) ylabel ( S ( f ), db ) t i t l e ( Average Azimuth Spectrum a f t e r Doppler c e n t r o i d c o r r e c t i o n ) grid on ; %% p r o c e s s the f i r s t patch n l i n e=p a t c h s i z e ; d a t a s i n g l e=rcompfd ( 1 : nline, : ) ; % azimuth transform d a t a s i n g l e f o u r=abs ( f f t s h i f t ( f f t ( d a t a s i n g l e, [ ], 1 ), 1 ) ) ; % average range l o o k s nrlook =4; 8

9 imagetest=zeros ( n line, floor ( n v a l i d / 4 ) ) ; for i =1: floor ( n v a l i d /4) imagetest ( :, i )=sum( d a t a s i n g l e f o u r ( :, ( i 1) nrlook +1: i nrlook ), 2 ) ; figure imagesc ( imagetest ) colormap( gray ) t i t l e ( Unfocused SAR image o f the f i r s t patch, 4 range l o o k s ) xlabel ( range ) ylabel ( azimuth ) cax=caxis ; caxis ( 0. 5 cax ) axis image saveas ( gcf, p b 2 s i n g l e p a t c h. eps, eps ) %% p r o c e s s a l l patches npatch=floor ( Naz/ p a t c h s i z e ) ; pix=pulsp p a t c h s i z e / d e l t a x ; n a z t o t a l=round( p a t c h s i z e +(npatch 1) pix ) ; % range compression a l r e a d y done! d a t a a l l=rcompfd ; % azimuth transform d a t a a l l f o u r=zeros ( naztotal, n v a l i d ) ; d a t a a l l f o u r ( 1 : patchsize, : ) = d a t a s i n g l e f o u r ; for i =2: npatch d i s p l a y ( i, p r o c e s s i n g the i t h patch ) d a t a s i n g l e=d a t a a l l ( ( i 1) p a t c h s i z e +1: i patchsize, : ) ; d a t a s i n g l e f o u r=abs ( f f t s h i f t ( f f t ( d a t a s i n g l e ), 1 ) ) ; o f f s e t=round ( ( i 1) pix ) ; d a t a a l l f o u r ( o f f s e t : o f f s e t+patchsize 1, : ) =... ( d a t a s i n g l e f o u r ( 1 : patchsize, : ) +... d a t a a l l f o u r ( o f f s e t : o f f s e t+patchsize 1, : ) ) ; %average range l o o k s nrlook =4; i m a g e f i n a l=zeros ( naztotal, floor ( n v a l i d / 4 ) ) ; for i =1: floor ( n v a l i d /4) i m a g e f i n a l ( :, i )=sum( d a t a a l l f o u r ( :, ( i 1) nrlook +1: i nrlook ), 2 ) ; 9

10 figure imagesc ( i m a g e f i n a l ) colormap( gray ) t i t l e ( Multi look unfocused image, 4 range l o o k s ) xlabel ( range ) ylabel ( azimuth ) set ( gca, YDir, normal ) cax=caxis ; caxis ( 0. 4 cax ) axis image saveas ( gcf, pb2. eps, eps ) 10

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

http://topex.ucsd.edu/gmtsar amplitude and phase coherence and pixel matching resolution: optical vs. microwave D s = 2H sinθ r = 2H λ L H = 800km. Optical : L = 1m λ = 0.5µm D s = 0.8m Microwave : L

More information

Analysis of Doppler signals from nadir altimeters over ocean. F. Boy (CNES)

Analysis of Doppler signals from nadir altimeters over ocean. F. Boy (CNES) Analysis of Doppler signals from nadir altimeters over ocean F. Boy (CNES) Delay-Doppler Phase Altimetry of Radar Altimeter Pulses Launched in 2016, Sentinel-3A has been measuring oceans, land, ice to

More information

The Radar Ambiguity. function Introduction. Chapter 4

The Radar Ambiguity. function Introduction. Chapter 4 Chapter 4 The Radar Ambiguity Function 4.1. Introduction The radar ambiguity function represents the output of the matched filter, and it describes the interference caused by the range and/or Doppler shift

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

Homework 5 Solutions

Homework 5 Solutions 18-290 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 2018 Homework 5 Solutions. Part One 1. (12 points) Calculate the following convolutions: (a) x[n] δ[n n 0 ] (b) 2 n u[n] u[n] (c) 2 n u[n]

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

3-Dimension Deformation Mapping from InSAR & Multiaperture. Hyung-Sup Jung The Univ. of Seoul, Korea Zhong Lu U.S. Geological Survey, U.S.A.

3-Dimension Deformation Mapping from InSAR & Multiaperture. Hyung-Sup Jung The Univ. of Seoul, Korea Zhong Lu U.S. Geological Survey, U.S.A. 3-Dimension Deformation Mapping from InSAR & Multiaperture InSAR Hyung-Sup Jung The Univ. of Seoul, Korea Zhong Lu U.S. Geological Survey, U.S.A. Outline Introduction to multiple-aperture InSAR (MAI) 3-D

More information

Homework 5 Solutions. Problem 1

Homework 5 Solutions. Problem 1 Homework 5 Solutions Problem 1 (a Closed form Chernoff upper-bound for the uncoded 4-QAM average symbol error rate over Rayleigh flat fading MISO channel with = 4, assuming transmit-mrc The vector channel

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

Homework 5 Solutions

Homework 5 Solutions 18-290 Signals and Systems Profs. Byron Yu and Pulkit Grover Fall 2017 Homework 5 Solutions Part One 1. (18 points) For each of the following impulse responses, determine whether the corresponding LTI

More information

EE368B Image and Video Compression

EE368B Image and Video Compression EE68B Image and Video Compression Solution to Homework Set # Prepared by Markus Flierl Blockwise 8 8 DCT A DCT-II of blocksize 8 8 is given by the 8 8 transform matrix A. The 8 8 transform coefficients

More information

Winter 2013 EECS 332 Digital Image Analysis Machine Problem 1 Connect Component Analysis

Winter 2013 EECS 332 Digital Image Analysis Machine Problem 1 Connect Component Analysis Winter 2013 EECS 332 Digital Image Analysis Machine Problem 1 Connect Component Analysis Jiangtao Gou Department of Statistics, Northwestern University Instructor: Prof. Ying Wu 22 January 2013 1 Introduction

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

Lecture 4. Programming

Lecture 4. Programming Lecture 4 Advanced Matlab Programming Announcements Hands-on Session on Friday 1318 EB Read Chapters 3-6 in your MATLAB book HW 2 opens up Friday evening Today Numerical analysis - I Visualization I Some

More information

Application of the Fractional Fourier Transform and S-Method in Doppler Radar Tomography

Application of the Fractional Fourier Transform and S-Method in Doppler Radar Tomography Application of the Fractional Fourier Transform and S-Method in Doppler Radar Tomography H.T. Tran and R. Melino Electronic Warfare and Radar Division Defence Science and Technology Organisation DSTO RR

More information

Problem 2 Distillation of air (20%) Solution

Problem 2 Distillation of air (20%) Solution Problem 2 Distillation of air (20%) A feed with two components (79 mole% N 2 and 21% O 2 ) is to be separated by continuous distillation. (a) Compute equilibrium data (y,x) at 1 atm for N 2 -O 2 at x=0,

More information

We know that f(x, y) and F (u, v) form a Fourier Transform pair, i.e. f(ax, by)e j2π(ux+vy) dx dy. x x. a 0 J = y y. = 0 b

We know that f(x, y) and F (u, v) form a Fourier Transform pair, i.e. f(ax, by)e j2π(ux+vy) dx dy. x x. a 0 J = y y. = 0 b 2 2 Problem 2:[10 pts] We know that f(x, y) and F (u, v) form a Fourier Transform pair, i.e. F (u, v) = Now, consider the integral G(u, v) = We make a change of variables [ x x ỹ x f(x, y)e j2π(ux+vy)

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

INTRODUCTION TO MICROWAVE REMOTE SENSING. Dr. A. Bhattacharya

INTRODUCTION TO MICROWAVE REMOTE SENSING. Dr. A. Bhattacharya 1 INTRODUCTION TO MICROWAVE REMOTE SENSING Dr. A. Bhattacharya Why Microwaves? More difficult than with optical imaging because the technology is more complicated and the image data recorded is more varied.

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

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

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

Tu: 9/3/13 Math 471, Fall 2013, Section 001 Lecture 1

Tu: 9/3/13 Math 471, Fall 2013, Section 001 Lecture 1 Tu: 9/3/13 Math 71, Fall 2013, Section 001 Lecture 1 1 Course intro Notes : Take attendance. Instructor introduction. Handout : Course description. Note the exam days (and don t be absent). Bookmark the

More information

Lecture 13: Pole/Zero Diagrams and All Pass Systems

Lecture 13: Pole/Zero Diagrams and All Pass Systems EE518 Digital Signal Processing University of Washington Autumn 2001 Dept. of Electrical Engineering Lecture 13: Pole/Zero Diagrams and All Pass Systems No4, 2001 Prof: J. Bilmes

More information

Lecture 4 Fiber Optical Communication Lecture 4, Slide 1

Lecture 4 Fiber Optical Communication Lecture 4, Slide 1 ecture 4 Dispersion in single-mode fibers Material dispersion Waveguide dispersion imitations from dispersion Propagation equations Gaussian pulse broadening Bit-rate limitations Fiber losses Fiber Optical

More information

Nonparametric Rotational Motion Compensation Technique for High-Resolution ISAR Imaging via Golden Section Search

Nonparametric Rotational Motion Compensation Technique for High-Resolution ISAR Imaging via Golden Section Search Progress In Electromagnetics Research M, Vol. 36, 67 76, 14 Nonparametric Rotational Motion Compensation Technique for High-Resolution ISAR Imaging via Golden Section Search Yang Liu *, Jiangwei Zou, Shiyou

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

Copyright 2015 California Institute of Technology. U.S. Government sponsorship acknowledged.

Copyright 2015 California Institute of Technology. U.S. Government sponsorship acknowledged. Copyright 2015 California Institute of Technology. U.S. Government sponsorship acknowledged. DOCUMENT CHANGE LOG Revision Date Sections Changed Reason for Change ii Copyright 2015 California Institute

More information

Math 56 Homework 5 Michael Downs

Math 56 Homework 5 Michael Downs 1. (a) Since f(x) = cos(6x) = ei6x 2 + e i6x 2, due to the orthogonality of each e inx, n Z, the only nonzero (complex) fourier coefficients are ˆf 6 and ˆf 6 and they re both 1 2 (which is also seen from

More information

Towed M-Sequence/ Long HLA Data Analysis

Towed M-Sequence/ Long HLA Data Analysis Towed M-Sequence/ Long HLA Data Analysis Harry DeFerrari University of Miami hdeferrari@rsmas.miamai.edu Last experiment of CALOPS I Five hour tow at 6 Knots (M-sequence 255 digit, 4.08 sec., 250 Hz center

More information

Radar Systems Engineering Lecture 3 Review of Signals, Systems and Digital Signal Processing

Radar Systems Engineering Lecture 3 Review of Signals, Systems and Digital Signal Processing Radar Systems Engineering Lecture Review of Signals, Systems and Digital Signal Processing Dr. Robert M. O Donnell Guest Lecturer Radar Systems Course Review Signals, Systems & DSP // Block Diagram of

More information

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) =

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) = Notes perso. - cb1 1 Tutorial : fft, psd & coherence with Matlab Version 3 - November 01 1 Fourier transform by Fast Fourier Transform (FFT) Definition of the Fourier transform : û(f) = F[u(t)] = As an

More information

E&CE 358, Winter 2016: Solution #2. Prof. X. Shen

E&CE 358, Winter 2016: Solution #2. Prof. X. Shen E&CE 358, Winter 16: Solution # Prof. X. Shen Email: xshen@bbcr.uwaterloo.ca Prof. X. Shen E&CE 358, Winter 16 ( 1:3-:5 PM: Solution # Problem 1 Problem 1 The signal g(t = e t, t T is corrupted by additive

More information

Comparison of Bi-Modal Coherent Sea Clutter Models

Comparison of Bi-Modal Coherent Sea Clutter Models 1 Comparison of Bi-Modal Coherent Sea Clutter Models Luke Rosenberg and Stephen Bocquet Defence Science and Technology Group, Australia Email: Luke.Rosenberg@dst.defence.gov.au Abstract Modelling and simulation

More information

MAE143A Signals & Systems - Homework 1, Winter 2014 due by the end of class Thursday January 16, 2014.

MAE143A Signals & Systems - Homework 1, Winter 2014 due by the end of class Thursday January 16, 2014. MAE43A Signals & Systems - Homework, Winter 4 due by the end of class Thursday January 6, 4. Question Time shifting [Chaparro Question.5] Consider a finite-support signal and zero everywhere else. Part

More information

MAE 107 HW 5 Solutions

MAE 107 HW 5 Solutions MAE 107 HW 5 Solutions 1. eulersmethod.m function [tn,xn] = eulersmethod(t0,tt,x0,n) % Objective % This function solves the ODE dx/dt = f(x,t) using Euler s method. % Inputs % t0 - initial time % tt -

More information

Lecture 29. Lidar Data Inversion (2)

Lecture 29. Lidar Data Inversion (2) Lecture 9. Lidar Data Inversion ) q Pre-process and Profile-process q Main Process Procedure to Derive T and V R Using Ratio Doppler Technique q Derivations of n c from narrowband resonance Doppler lidar

More information

Principles of Communications

Principles of Communications Principles of Communications Weiyao Lin, PhD Shanghai Jiao Tong University Chapter 4: Analog-to-Digital Conversion Textbook: 7.1 7.4 2010/2011 Meixia Tao @ SJTU 1 Outline Analog signal Sampling Quantization

More information

Polarimetric Calibration of the Ingara Bistatic SAR

Polarimetric Calibration of the Ingara Bistatic SAR Polarimetric Calibration of the Ingara Bistatic SAR Alvin Goh, 1,2 Mark Preiss, 1 Nick Stacy, 1 Doug Gray 2 1. Imaging Radar Systems Group Defence Science and Technology Organisation 2. School of Electrical

More information

Green Bank Telescope Performance

Green Bank Telescope Performance Green Bank Telescope Performance Dana S. Balser GBT Performance July 2007 Pune, NCRA Telescope Structure Unblocked Aperture Frequency Coverage Telescope Control Focus Surface Pointing Pointing Requirements

More information

Progress In Electromagnetics Research M, Vol. 21, 33 45, 2011

Progress In Electromagnetics Research M, Vol. 21, 33 45, 2011 Progress In Electromagnetics Research M, Vol. 21, 33 45, 211 INTERFEROMETRIC ISAR THREE-DIMENSIONAL IMAGING USING ONE ANTENNA C. L. Liu *, X. Z. Gao, W. D. Jiang, and X. Li College of Electronic Science

More information

J.-M Friedt. FEMTO-ST/time & frequency department. slides and references at jmfriedt.free.fr.

J.-M Friedt. FEMTO-ST/time & frequency department. slides and references at jmfriedt.free.fr. FEMTO-ST/time & frequency department jmfriedt@femto-st.fr slides and references at jmfriedt.free.fr February 21, 2018 1 / 17 Basics ADC: discrete time (aliasing) and discrete levels (quantization) V =

More information

RADAR TARGETS IN THE CONTEXT OF EARTH OBSERVATION. Dr. A. Bhattacharya

RADAR TARGETS IN THE CONTEXT OF EARTH OBSERVATION. Dr. A. Bhattacharya RADAR TARGETS IN THE CONTEXT OF EARTH OBSERVATION Dr. A. Bhattacharya 1 THE RADAR EQUATION The interaction of the incident radiation with the Earth s surface determines the variations in brightness in

More information

Simulation and Numerical Modeling of a Rectangular Patch Antenna Using Finite Difference Time Domain (FDTD) Method

Simulation and Numerical Modeling of a Rectangular Patch Antenna Using Finite Difference Time Domain (FDTD) Method Journal of Computer Science and Information Technology June 2014, Vol. 2, No. 2, pp. 01-08 ISSN: 2334-2366 (Print), 2334-2374 (Online) Copyright The Author(s). 2014. All Rights Reserved. Published by American

More information

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters. INTRODUCTION 2. IIR FILTER DESIGN 3. ANALOG FILTERS 4. THE BUTTERWORTH ANALOG FILTER 5. THE CHEBYSHEV-I

More information

ECG782: Multidimensional Digital Signal Processing

ECG782: Multidimensional Digital Signal Processing Professor Brendan Morris, SEB 3216, brendan.morris@unlv.edu ECG782: Multidimensional Digital Signal Processing Spring 2014 TTh 14:30-15:45 CBC C313 Lecture 05 Image Processing Basics 13/02/04 http://www.ee.unlv.edu/~b1morris/ecg782/

More information

The Z-Transform. For a phasor: X(k) = e jωk. We have previously derived: Y = H(z)X

The Z-Transform. For a phasor: X(k) = e jωk. We have previously derived: Y = H(z)X The Z-Transform For a phasor: X(k) = e jωk We have previously derived: Y = H(z)X That is, the output of the filter (Y(k)) is derived by multiplying the input signal (X(k)) by the transfer function (H(z)).

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

Sentinel-1 Mission Overview

Sentinel-1 Mission Overview Sentinel-1 Mission Overview N. Miranda, ESA S-1 Space Project Team S-1 PDGS Team PolinSAR 2013 Info day Outline Mission objectives S-1 Acquisition Modes S-1 Piloting Modes S-1 Product Family S-1 Product

More information

THE COMPARISON OF DIFFERENT METHODS OF CHRIP SIGNAL PROCESSING AND PRESENTATION OF A NEW METHOD FOR PROCESSING IT

THE COMPARISON OF DIFFERENT METHODS OF CHRIP SIGNAL PROCESSING AND PRESENTATION OF A NEW METHOD FOR PROCESSING IT Indian Journal of Fundamental and Applied Life Sciences ISSN: 3 6345 (Online) An Open Access, Online International Journal Available at www.cibtech.org/sp.ed/jls/04/03/jls.htm 04 Vol. 4 (S3), pp. 95-93/Shourangiz

More information

LAB # 5 HANDOUT. »»» The N-point DFT is converted into two DFTs each of N/2 points. N = -W N Then, the following formulas must be used. = k=0,...

LAB # 5 HANDOUT. »»» The N-point DFT is converted into two DFTs each of N/2 points. N = -W N Then, the following formulas must be used. = k=0,... EEE4 Lab Handout. FAST FOURIER TRANSFORM LAB # 5 HANDOUT Data Sequence A = x, x, x, x3, x4, x5, x6, x7»»» The N-point DFT is converted into two DFTs each of N/ points. x, x, x4, x6 x, x3, x5, x7»»» N =e

More information

Vector Fields and Solutions to Ordinary Differential Equations using MATLAB/Octave

Vector Fields and Solutions to Ordinary Differential Equations using MATLAB/Octave Vector Fields and Solutions to Ordinary Differential Equations using MATLAB/Octave Andreas Stahel 5th December 27 Contents Vector field for the logistic equation 2 Solutions of ordinary differential equations

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

MAE143A Signals & Systems - Homework 5, Winter 2013 due by the end of class Tuesday February 12, 2013.

MAE143A Signals & Systems - Homework 5, Winter 2013 due by the end of class Tuesday February 12, 2013. MAE43A Signals & Systems - Homework 5, Winter 23 due by the end of class Tuesday February 2, 23. If left under my door, then straight to the recycling bin with it. This week s homework will be a refresher

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

COURSE OUTLINE. Introduction Signals and Noise Filtering Sensors: Piezoelectric Force Sensors. Sensors, Signals and Noise 1

COURSE OUTLINE. Introduction Signals and Noise Filtering Sensors: Piezoelectric Force Sensors. Sensors, Signals and Noise 1 Sensors, Signals and Noise 1 COURSE OUTLINE Introduction Signals and Noise Filtering Sensors: Piezoelectric Force Sensors Piezoelectric Force Sensors 2 Piezoelectric Effect and Materials Piezoelectric

More information

ERS-ENVISAT Cross-interferometry for Coastal DEM Construction

ERS-ENVISAT Cross-interferometry for Coastal DEM Construction ERS-ENVISAT Cross-interferometry for Coastal DEM Construction Sang-Hoon Hong and Joong-Sun Won Department of Earth System Sciences, Yonsei University, 134 Shinchon-dong, Seodaemun-gu, 120-749, Seoul, Korea

More information

Lecture 15: Doppler Dilemma, Range and Velocity Folding, and Interpreting Doppler velocity patterns

Lecture 15: Doppler Dilemma, Range and Velocity Folding, and Interpreting Doppler velocity patterns MET 4410 Remote Sensing: Radar and Satellite Meteorology MET 5412 Remote Sensing in Meteorology Lecture 15: Doppler Dilemma, Range and Velocity Folding, and Interpreting Doppler velocity patterns Doppler

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

Lecture 30. Further Consideration on Lidar Data Inversion

Lecture 30. Further Consideration on Lidar Data Inversion Lecture 30. Further Consideration on Lidar Data Inversion Aerosol and Cloud Lidar -- Finish Remaining of Lecture 9 Resonance Doppler lidar data processing -- Further consideration on T c -- Na density

More information

Densità spettrale di clutter

Densità spettrale di clutter Densità spettrale di clutter Pierfrancesco Lombardo RRSN DIET, Università di Roma La Sapienza CLUTTER SPECTRA 1 Power Spectral Density (PSD) models Correct spectral shape impacts clutter cancellation and

More information

A SuperDARN Tutorial. Kile Baker

A SuperDARN Tutorial. Kile Baker A SuperDARN Tutorial Kile Baker Introduction n Multi-pulse Technique and ACFs Why ACFs? Bad and missing lags n Basic Theory of FITACF n Basic Fitting Technique Getting the Power and Width Getting the Velocity

More information

DSP Applications for Wireless Communications: Linear Equalisation of MIMO Channels

DSP Applications for Wireless Communications: Linear Equalisation of MIMO Channels DSP Applications for Wireless Communications: Dr. Waleed Al-Hanafy waleed alhanafy@yahoo.com Faculty of Electronic Engineering, Menoufia Univ., Egypt Digital Signal Processing (ECE407) Lecture no. 5 August

More information

Advanced Laser Technologies Homework #2

Advanced Laser Technologies Homework #2 Advanced Laser Technologies Homework #2 Chih-Han Lin student ID: r99245002 Graduate Institute of Applied Physics, National Taiwan University I. DEMONSTRATION OF MODE-LOCKING PULSES Assume that complex

More information

Burst overlapping of ALOS-2 PALSAR-2 ScanSAR-ScanSAR interferometry

Burst overlapping of ALOS-2 PALSAR-2 ScanSAR-ScanSAR interferometry Burst overlapping of ALOS-2 PALSAR-2 ScanSAR-ScanSAR interferometry Japan Aerospace Exploration Agency Earth Observation Research Center Ryo Natsuaki, Takeshi Motohka, Shinichi Suzuki and Masanobu Shimada

More information

Image Reconstruction Algorithms for 2D Aperture Synthesis Radiometers

Image Reconstruction Algorithms for 2D Aperture Synthesis Radiometers Image Reconstruction Algorithms for 2D Aperture Synthesis Radiometers E. Anterrieu 1 and A. Camps 2 1 Dept. Signal, Image & Instrumentation Laboratoire d Astrophysique de Toulouse-Tarbes Université de

More information

Sparse methods for improving gravitational wave detection. Ra Inta, The Australian National University

Sparse methods for improving gravitational wave detection. Ra Inta, The Australian National University Sparse methods for improving gravitational wave detection Ra Inta, The Australian National University ADA7, Cargèse, Corsica, May 17, 2012 Sparse methods Reminder: a vector is S-sparse (compressible) if

More information

Satellite project, AST 1100

Satellite project, AST 1100 Satellite project, AST 1100 Part 4: Skynet The goal in this part is to develop software that the satellite can use to orient itself in the star system. That is, that it can find its own position, velocity

More information

Modeling Surface and Subsurface Scattering from Saline Soils

Modeling Surface and Subsurface Scattering from Saline Soils Modeling Surface and Subsurface Scattering from Saline Soils PolInSAR 2007 Tony Freeman, Jet Propulsion Laboratory Tom Farr, Jet Propulsion Laboratory Philippe Paillou, Astronomical Observatory of Bordeaux

More information

Storm top detection and prediction

Storm top detection and prediction Page 1 of 21 Storm top detection and prediction Abstract ( 28 of 265070 ) United States Patent 7,714,767 Kronfeld, et al. May 11, 2010 A radar system is configured to predict future storm cell characteristics

More information

Applications of Time Domain Vector Potential Formulation to 3-D Electromagnetic Problems

Applications of Time Domain Vector Potential Formulation to 3-D Electromagnetic Problems Applications of Time Domain Vector Potential Formulation to 3-D Electromagnetic Problems F. De Flaviis, M. G. Noro, R. E. Diaz, G. Franceschetti and N. G. Alexopoulos Department of Electrical Engineering

More information

The Geometry of Spaceborne Synthetic Aperture Radar

The Geometry of Spaceborne Synthetic Aperture Radar 1 The Geometry of Spaceborne Synthetic Aperture Radar P. H. Robert Orth Abstract The paper defines the new coordinate system that was developed in 1977-78 for the world s first digital synthetic aperture

More information

Small-size space debris data collection with EISCAT radar facilities

Small-size space debris data collection with EISCAT radar facilities Small-size space debris data collection with EISCAT radar facilities Background - 3-4 - ) 5 7 4 - - 6 5 5 ) 5 -, - * 4 5 9 6 * ) + 5 + ) 6 6-4 4 ), 9 ) 8-5 = H = A A D J E A ) K K I A ) 8 A REAL-TIME SMALL-SIZE

More information

31545 Medical Imaging systems

31545 Medical Imaging systems 31545 Medical Imaging systems Lecture 2: Ultrasound physics Jørgen Arendt Jensen Department of Electrical Engineering (DTU Elektro) Biomedical Engineering Group Technical University of Denmark September

More information

Computational Foundations of Cognitive Science

Computational Foundations of Cognitive Science Computational Foundations of Cognitive Science Lecture 14: Inverses and Eigenvectors in Matlab; Plotting and Graphics Frank Keller School of Informatics University of Edinburgh keller@inf.ed.ac.uk February

More information

Outline of today Medical Imaging systems. Wave types. 1. Discussion assignment on B-mode imaging

Outline of today Medical Imaging systems. Wave types. 1. Discussion assignment on B-mode imaging Outline of today 3545 Medical Imaging systems. Discussion assignment on B-mode imaging Lecture : Ultrasound physics. Derivation of wave equation and role of speed of sound Jørgen Arendt Jensen Department

More information

Mandatory Assignment 2013 INF-GEO4310

Mandatory Assignment 2013 INF-GEO4310 Mandatory Assignment 2013 INF-GEO4310 Deadline for submission: 12-Nov-2013 e-mail the answers in one pdf file to vikashp@ifi.uio.no Part I: Multiple choice questions Multiple choice geometrical optics

More information

Gravitational-Wave Data Analysis: Lecture 2

Gravitational-Wave Data Analysis: Lecture 2 Gravitational-Wave Data Analysis: Lecture 2 Peter S. Shawhan Gravitational Wave Astronomy Summer School May 29, 2012 Outline for Today Matched filtering in the time domain Matched filtering in the frequency

More information

Quick Review. ESE319 Introduction to Microelectronics. and Q1 = Q2, what is the value of V O-dm. If R C1 = R C2. s.t. R C1. Let Q1 = Q2 and R C1

Quick Review. ESE319 Introduction to Microelectronics. and Q1 = Q2, what is the value of V O-dm. If R C1 = R C2. s.t. R C1. Let Q1 = Q2 and R C1 Quick Review If R C1 = R C2 and Q1 = Q2, what is the value of V O-dm? Let Q1 = Q2 and R C1 R C2 s.t. R C1 > R C2, express R C1 & R C2 in terms R C and ΔR C. If V O-dm is the differential output offset

More information

P. Cipollini, H. Snaith - A short course on Altimetry. Altimetry 2 - Data processing (from satellite height to sea surface height)

P. Cipollini, H. Snaith - A short course on Altimetry. Altimetry 2 - Data processing (from satellite height to sea surface height) P. Cipollini, H. Snaith - A short course on Altimetry Altimetry 2 - Data processing (from satellite height to sea surface height) 1 2 Satellite height to sea surface height The altimeter measures the altitude

More information

L3: Review of linear algebra and MATLAB

L3: Review of linear algebra and MATLAB L3: Review of linear algebra and MATLAB Vector and matrix notation Vectors Matrices Vector spaces Linear transformations Eigenvalues and eigenvectors MATLAB primer CSCE 666 Pattern Analysis Ricardo Gutierrez-Osuna

More information

Front End Electronics Internal Noise Source Characterization

Front End Electronics Internal Noise Source Characterization Front End Electronics Internal Noise Source Characterization Joe Brendler and R.H. Tillman May 14, 2015 Contents 1 Introduction 2 2 System Model 2 3 Measurement Process 3 3.1 G r Measurement....................................

More information

GISM Global Ionospheric Scintillation Model

GISM Global Ionospheric Scintillation Model GISM Global Ionospheric Scintillation Model http://www.ieea.fr/en/gism-web-interface.html Y. Béniguel, IEEA Béniguel Y., P. Hamel, A Global Ionosphere Scintillation Propagation Model for Equatorial Regions,

More information

u(t)u (t + τ) exp(j2πνt)dt 3.1 MAIN PROPERTIES OF THE AMBIGUITY FUNCTION

u(t)u (t + τ) exp(j2πνt)dt 3.1 MAIN PROPERTIES OF THE AMBIGUITY FUNCTION 3 AMBIGUITY FUNCTION The ambiguity function (AF) represents the time response of a filter matched to a given finite energy signal when the signal is received with a delay τ and a Doppler shift ν relative

More information

IMPROVED MOTION COMPENSATION FOR WIDE- BEAM WIDE-SWATH AIRBORNE SAR

IMPROVED MOTION COMPENSATION FOR WIDE- BEAM WIDE-SWATH AIRBORNE SAR Progress In Electromagnetics Research Letters, Vol. 36, 1 7, 2013 IMPROVED MOTION COMPENSATION FOR WIDE- BEAM WIDE-SWATH AIRBORNE SAR Shaoshi Yan *, Yueli Li, Tian Jin, Zhi-Min Zhou, and Dao-Xiang An UWB

More information

DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS

DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS Ian Cooper School of Physics, University of Sydney ian.cooper@sydney.edu.au DOWNLOAD DIRECTORY FOR MATLAB SCRIPTS maths_ft_01.m mscript used

More information

Synthetic Aperture Radar Imaging and Motion Estimation via Robust Principal Component Analysis

Synthetic Aperture Radar Imaging and Motion Estimation via Robust Principal Component Analysis SIAM J. IMAGING SCIENCES Vol. 6, No. 3, pp. 5 76 c 3 Society for Industrial and Applied Mathematics Synthetic Aperture Radar Imaging and Motion Estimation via Robust Principal Component Analysis Liliana

More information

Finite Element Analysis of a Fiber Bragg Grating Accelerometer for Performance Optimization

Finite Element Analysis of a Fiber Bragg Grating Accelerometer for Performance Optimization Finite Element Analysis of a Fiber Bragg Grating Accelerometer for Performance Optimization N. Basumallick*, P. Biswas, K. Dasgupta and S. Bandyopadhyay Fiber Bragg Grating (FBG) b 2n eff P e - strain

More information

Signals and Systems: Part 2

Signals and Systems: Part 2 Signals and Systems: Part 2 The Fourier transform in 2πf Some important Fourier transforms Some important Fourier transform theorems Convolution and Modulation Ideal filters Fourier transform definitions

More information

Carrier Phase Techniques

Carrier Phase Techniques Carrier Phase Techniques Michael P Vitus August 30, 2005 Introduction This paper provides an explanation of the methods as well as the wor performed on the GPS project under Professor Ng ding the summer

More information

Vector Fields and Solutions to Ordinary Differential Equations using Octave

Vector Fields and Solutions to Ordinary Differential Equations using Octave Vector Fields and Solutions to Ordinary Differential Equations using Andreas Stahel 6th December 29 Contents Vector fields. Vector field for the logistic equation...............................2 Solutions

More information

living planet symposium

living planet symposium living planet symposium!!the Sentinel-3 Surface Topography!!Mission and Products C. Mavrocordatos ESA-ESTEC (Netherlands) P. Féménias ESA-ESRIN (Italy) N. Picot CNES (France) H. Bonekamp EUMETSAT (Germany)

More information

Iterative Algorithms for Radar Signal Processing

Iterative Algorithms for Radar Signal Processing Iterative Algorithms for Radar Signal Processing Dib Samira*, Barkat Mourad**, Grimes Morad*, Ghemit Amal* and amel Sara* *Department of electronics engineering, University of Jijel, Algeria **Department

More information

The Doppler effect for SAR 1

The Doppler effect for SAR 1 The Doppler effect for SAR 1 Semyon Tsynkov 2,3 3 Department of Mathematics North Carolina State University, Raleigh, NC 2016 AFOSR Electromagnetics Contractors Meeting January 5 7, 2016, Arlington, VA

More information

Sentinel-1A SAR Interferometry Verification

Sentinel-1A SAR Interferometry Verification Sentinel-1A SAR Interferometry Verification Dirk Geudtner1, Pau Prats2, Nestor Yaguee-Martinez2, Andrea Monti Guarnieri3, Itziar Barat1, Björn Rommen1 and Ramón Torres1 1ESA ESTEC 2DLR, Microwave and Radar

More information

Orbit and Transmit Characteristics of the CloudSat Cloud Profiling Radar (CPR) JPL Document No. D-29695

Orbit and Transmit Characteristics of the CloudSat Cloud Profiling Radar (CPR) JPL Document No. D-29695 Orbit and Transmit Characteristics of the CloudSat Cloud Profiling Radar (CPR) JPL Document No. D-29695 Jet Propulsion Laboratory California Institute of Technology Pasadena, CA 91109 26 July 2004 Revised

More information

Soil moisture retrieval over periodic surfaces using PolSAR data

Soil moisture retrieval over periodic surfaces using PolSAR data Soil moisture retrieval over periodic surfaces using PolSAR data Sandrine DANIEL Sophie ALLAIN Laurent FERRO-FAMIL Eric POTTIER IETR Laboratory, UMR CNRS 6164, University of Rennes1, France Contents Soil

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 9 Solutions April 18, 011 Problem 1: Chapter 9, Problem

More information

ANALYSIS OF THE EGLIN RADAR DEBRIS FENCE

ANALYSIS OF THE EGLIN RADAR DEBRIS FENCE ANALYSIS OF THE EGLIN RADAR DEBRIS FENCE Thomas J. Settecerri, Alan D. Skillicorn (The MITRE Corporation), Paul C. Spikes (AFMC ESC/Det. 5) BACKGROUND The Eglin FPS-85 space surveillance radar is a bi-static

More information