EE 355 / GP 265 Homework 5 Solutions

Size: px
Start display at page:

Download "EE 355 / GP 265 Homework 5 Solutions"

Transcription

1 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: once with the first subaperture of the reference chirp, consisting of positive frequencies (half its bandwidth), and another time with the second subaperture of the reference chirp, which consists of negative frequencies (the other half of its bandwidth). The compressed signals from both subapertures will be slightly offset from each other (see figures), so cross-correlate them to compute the pixel offset p (see second column in table). Convert to time shift t by dividing by the sample rate f s (see third column in table): t = p f s () Then compute the chirp slope correction s (see fourth column in table). This should match the expected slope correction s exp = s s we get from subtraction, since we know the true chirp slope s. s = s t BW = s t = s t () sτ τ s (Hz/s) (a) pixel offset t (s) (b) s (Hz/s)

2 % EE HW Problem close all; clear; set(, defaultaxesfontsize, ); %%%%%%%%%%%%%%%%%%%%%%%%% Problem %%%%%%%%%%%%%%%%%%%%%%% % pb: autofocus using sub-aperture shift algorithm clear;clc;close all; %% signal chirp s_sig=e; tau=e-; fs=e; Nmin=round(fs*tau); N=^ceil(log(Nmin)/log()); signal=makechirp(s_sig,tau,fs,,,n); spect_sig=fft(signal); %% ref chirp s=e;

3 s=.e; s=.e; s=.9e; sr=[s,s,s,s]; % reference chirp slopes for k=:numel(sr) sp=sr(k); bw=tau*sp; fullrefchirp=makechirp(sp,tau,fs,,,n); subchirp=makechirp(sp,tau/,fs,-bw/,,n); subchirp=makechirp(sp,tau/,fs,bw/,round(tau/*fs+),n); spect_ref=fft(subchirp); spect_ref=fft(subchirp); compsig=ifft(spect_sig.*conj(spect_ref)); compsig=ifft(spect_sig.*conj(spect_ref)); t=/fs*(-n/:n/-); t=e*t; % figure: Compressed looks, showing their misregistration figure() subplot(,,k) plot(t,fftshift(abs(ifft(spect_sig.*conj(spect_sig)))), linewidth,) hold on plot(t,fftshift(abs(compsig)), linewidth,) hold on plot(t,fftshift(abs(compsig)), linewidth,) hold off xlabel( t,us ) ylabel( amplitude ) xlim([-tau/,tau/]*e) leg( full aperture, sub-negative freq, sub-positive freq ) % saveas(gcf, pb.png, png ) % find the offset delta_t by correlating the two sub-aperture images shift=fftshift(ifft(fft(abs(compsig)).*conj(fft(abs(compsig))))); [maxnum,index]=max(abs(shift)); delta_t(k)=(index-n/-)/fs; delta_s(k)=*delta_t(k)*sp^/bw/e; pixeloffset(k)=(index-n/-); function chirp = makechirp(s,tau,fs,fc,start,n) %s : slope %tau : pulse length %fs : sample rate %fc : center frequency %start: starting location of chirp

4 %n : number of samples dt=/fs; % sampling time interval npts=floor(tau/dt); % number of points of the chirp signal t=(-npts/:npts/-)*dt; phase=pi*s*t.^+*pi*fc*t; chirp=zeros(n,); chirp(start:start+npts-)=exp(i*phase); return. Range migration with simulated data: cut and paste raw data lines bins We observe migration in the magnitude of the raw data from simlband.dat: a slant of about - pixels. The signal boundaries are not present within a single bin. (a) Range migration is still evident in the compressed data (left), especially when we zoom in on bins - (right). The signal does not stay in the same bin, but instead curves as the position changes.

5 compressed data compressed data, zoom lines lines bins bins (b) After transforming the compressed data in the direction (left), we still see migration between the two tail s of the spectra (about - pixels), especially when we zoom in on bins - (right). Notice that f DC is around prf/ (part c), which explains why the s of the spectra come together around - Hz. Also, the frequency can have an ambiguity of n*prf, so we only plot the axis label as [-prf/ prf/]. Azimuth-transformed image Azimuth-transformed image, zoom - - frequency in (Hz) - frequency in (Hz) - bins bins (c) After computing the average Doppler spectrum over all valid bins, we find that it peaks at a frequency of f DC, =.9 Hz, which we estimate as the Doppler centroid. Other possible values of f DC are possible because of ambiguity from sampling the Doppler spectrum. I can also have f DC = f DC, + n P RF, where n is an integer. Letting n =,,,,, I get these possible values of f DC, respectively: -9. Hz, -. Hz,.9 Hz,.9 Hz,.9 Hz.

6 Average spectrum Average spectrum magnitude (db) frequency (Hz) (d) We use the same focused SAR processing algorithm from Homework, compressing the data in both the and directions, trying all possible f DC values from problem c. We process only patch (with samples). We plot images that are zoomed in both and, to examine the impulse response more closely. The impulse responses for f DC = -. Hz and.9 Hz look the sharpest in both and, but there is still some blurring over a few pixels in both directions. The other f DC values are not at the correct ambiguity because the impulse response is too smeared out in the direction, and we can see some migration. Focused image, f dc = -9.9 Hz Focused image, f dc = -.9 Hz Focused image, f dc =.9 Hz Focused image, f dc =.9 Hz Focused image, f dc =.9 Hz

7 (e) Range migration with the cut and paste algorithm improved the resolution of the impulse response. It was not very obvious with the original processing results, but the images after migration clearly show that the absolute (unwrapped) Doppler centroid is at f DC = -. Hz (when n = ), where the image is sharpest, and sharper than all images from problem d. Note that the migration process increased the sensitivity to the Doppler centroid ambiguity. Range migration, image, f dc = -9.9 Hz Range migration, image, f dc = -.9 Hz Range migration, image, f dc =.9 Hz Range migration, image, f dc =.9 Hz Range migration, image, f dc =.9 Hz % EE HW Problem close all; clear; set(, defaultaxesfontsize, ); %%%%%%%%%%%%%%%%%%%%%%%%% Problem %%%%%%%%%%%%%%%%%%%%%%% % Read in data nr = ; naz = ; fid=fopen( simlband.dat ); dat = fread(fid, [nr* naz], float, l ); fclose(fid); signal = dat(::,:) + i*dat(::,:);

8 % Plot raw data imagesc(abs(signal). ); title( raw data ); colormap gray; colorbar; ylabel( lines ); xlabel( bins ); % Part a): Range compression s = e; tau = e-; fs = e; r=makechirp(s,tau,fs,,,nr); R=fft(r); S=fft(signal); Sc=zeros(size(S)); for jj=:naz Sc(:,jj)=S(:,jj).*conj(R. ); rcomp=ifft(sc); nvalid = nr - fs*tau; % valid bins rcomp=rcomp(:nvalid,:). ; imagesc(abs(rcomp)); title( compressed data ); ylabel( lines ); xlabel( bins ); colormap gray; colorbar; imagesc(abs(rcomp)); title( compressed data, zoom ); ylabel( lines ); xlabel( bins ); xlim([ ]); colormap gray; colorbar; % Part b): Transform in Rcomp=fft(rcomp); prf = ; fq=linspace(-prf/,prf/,naz); imagesc(:nvalid, fq, fftshift(abs(rcomp),)); ylabel( frequency in (Hz) ); xlabel( bins ); title( Azimuth-transformed image ) colormap gray; colorbar;

9 imagesc(:nvalid, fq, fftshift(abs(rcomp),)); ylabel( frequency in (Hz) ); xlabel( bins ); xlim([ ]); title( Azimuth-transformed image, zoom ) colormap gray; colorbar; % Part c): Estimate Doppler centroid with average spectrum Saz=zeros(naz,); for jj=:nvalid Saz=Saz+abs(Rcomp(:,jj)); Saz=Saz/nvalid; ind_max = find(fftshift(saz) == max(fftshift(saz))); fdc_est = fq(ind_max); plot(fq,*log(fftshift(saz)), linewidth,); xlabel( frequency (Hz) ); ylabel( Average spectrum magnitude (db) ); title( Average spectrum ); % Part d): Process image with original (non-migrating) focused SAR lambda=.; r=; % to first bin v=; l=; c =.999e; % speed of light (m/s) dr = c/(*fs); % slant bin spacing (m) nn = [- - ]; % Doppler centroid ambiguity: integer fdc_arr = fdc_est + prf*nn; % Possible Doppler centroid frequencies (Hz) for k=:numel(nn) fdc = fdc_arr(k); % get Doppler centroid rmax = r+(nvalid-)*dr; % to last bin rdcmax = sqrt(rmax^+(fdc*rmax*lambda/(*v))^); % max at antenna boresight (m) tazmax =.*rdcmax*lambda/(l*v); % maximum illumination time (s) validperpatch=floor(naz-tazmax*prf); % number of valid samples per patch % Apply compression for this fdc ( patch, bins) s_focus=zeros(naz,nvalid); for bin=:nvalid =r+(bin-)*dr; rdc=sqrt(^+(fdc**lambda/(*v))^); frate=-*v^/(rdc*lambda); taz=.*rdc*lambda/(v*l); ref=makechirp(frate,taz,prf,fdc,,naz); Ref=fft(ref); 9

10 s_focus(:,bin)=ifft(rcomp(:,bin).*conj(ref. )); % Plot focused SAR image for this fdc imagesc(abs(s_focus)); colorbar; caxis([ e]); colormap( jet ); xlim([ ]); ylim([ ]); xlabel( ); ylabel( ); title([ Focused image, f_{dc} =, numstr(fdc), Hz ]); % Part e): Range migration with cut-and-paste % Rcomp is -compressed, -transformed data Rcomp=zeros(size(Rcomp)); % Allocate array for -migrated data df = prf/naz; for k=:numel(nn) fdc = fdc_arr(k); % get Doppler centroid fmin = nn(k)*prf; % minimum frequency % Apply migration with cut-and-paste for bin=:nvalid for jj=:naz freq=fmin+(jj-)*df; dist_offset = (freq^-fdc^)*(r/)*(lambda/v)^; % offset distance (m) rshift=floor(dist_offset/dr); % number of offset bins if((bin+rshift <= nvalid) && (bin+rshift > )) % array bounds check Rcomp(jj,bin)=Rcomp(jj,bin+rshift); % Apply compression for this fdc ( patch, bins) s_rm_focus=zeros(naz,nvalid); for bin=:nvalid =r+(bin-)*dr; rdc=sqrt(^+(fdc**lambda/(*v))^); frate=-*v^/(rdc*lambda); taz=.*rdc*lambda/(v*l); ref=makechirp(frate,taz,prf,fdc,,naz); Ref=fft(ref); s_rm_focus(:,bin)=ifft(rcomp(:,bin).*conj(ref. )); % Plot focused, migrated SAR image for this fdc imagesc(abs(s_rm_focus)); colorbar; caxis([ e]); colormap( jet ); xlim([ ]); ylim([ ]); xlabel( ); ylabel( ); title([ Range migration, image, f_{dc} =, numstr(fdc), Hz ]);

11 . We can consider the radar geometry as two concentric spheres; the outer sphere is the orbital sphere of the satellite, the inner sphere is the Earth. Point A is the point of closest approach of the satellite to point C, and point B is some later position of the satellite. We want to find the r from B to C. We derived the effective velocity for the point P (directly under the satellite) in Handout. The relative height history z(t) between the point P and the satellite can be written as (from Handout ): v t z(t) = z () (z + R e ) From geometry, the height difference between point P (directly under the satellite) and point C (not directly under the satellite) is: cos β = R e z R e z = R e R e cos β () Now write the expression for as a function of time, r (t), but replace z(t) with z(t)+ z: r (t) = v t + y + (z(t) + z) r (t) = v t + y + (z(t)) + z(t) z + ( z) () Plug in Eq. into Eq.. Here we neglect the higher order v t term: ( r (t) = v t + y + z v t ) ( + z (z + R e ) r (t) = v t + y + z z v t z + R e + ( z v t ) z + ( z) (z + R e ) ) () z + ( z) v t (z + R e )

12 Gather all terms in Eq. with v t, and call everything else constant (not changing with time): r (t) = y + z + z z + ( z) + v t z v t ( z + R e v t (z + R e ) r (t) = const + v t [ z z + R e ) z z ] () z + R e The effective velocity v eff is the term in Eq. in brackets, times v, so simplify: v eff = v [ z z + R e v eff = v [ z + R e z + R e z z + R e z z + R e z ] z + R e [ ] veff = Re z v z + R e Plug in Eq. into Eq., and take the square root: [ ] veff = Re (R e R e cos β) v z + R e [ ] veff = Re cos β v z + R e Re cos β v eff = v z + R e ] () (9)

EE 355 / GP 265 Homework 3 Solutions Winter

EE 355 / GP 265 Homework 3 Solutions Winter EE 355 / GP 265 Homework 3 Solutions Winter 2017-2018 February 8, 2018 1. Doppler centroid (a) Plot of the azimuth spectrum of the data averaged over all valid range bins: 90 Problem 1a: average azimuth

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

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

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

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

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

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

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

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

A NEW IMAGING ALGORITHM FOR GEOSYNCHRON- OUS SAR BASED ON THE FIFTH-ORDER DOPPLER PARAMETERS

A NEW IMAGING ALGORITHM FOR GEOSYNCHRON- OUS SAR BASED ON THE FIFTH-ORDER DOPPLER PARAMETERS Progress In Electromagnetics Research B, Vol. 55, 195 215, 2013 A NEW IMAGING ALGORITHM FOR GEOSYNCHRON- OUS SAR BASED ON THE FIFTH-ORDER DOPPLER PARAMETERS Bingji Zhao 1, *, Yunzhong Han 1, Wenjun Gao

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

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

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

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

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

TIME-FREQUENCY ANALYSIS: TUTORIAL. Werner Kozek & Götz Pfander

TIME-FREQUENCY ANALYSIS: TUTORIAL. Werner Kozek & Götz Pfander TIME-FREQUENCY ANALYSIS: TUTORIAL Werner Kozek & Götz Pfander Overview TF-Analysis: Spectral Visualization of nonstationary signals (speech, audio,...) Spectrogram (time-varying spectrum estimation) TF-methods

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

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

Estimation of the Cosmic Microwave Background Radiation

Estimation of the Cosmic Microwave Background Radiation S.P.Spirydovich Abstract Estimation of the Cosmic Microwave Background Radiation The author discusses some aspects of experiment, which was built to measure temperature of cosmic microwave background (CMB)

More information

NAS Report MTI FROM SAR. Prof. Chris Oliver, CBE NASoftware Ltd. 19th January 2007

NAS Report MTI FROM SAR. Prof. Chris Oliver, CBE NASoftware Ltd. 19th January 2007 NAS Report MTI FROM SAR Prof. Chris Oliver, CBE NASoftware Ltd. 19th January 27 1. Introduction NASoftware have devised and implemented a series of algorithms for deriving moving target information from

More information

Airborne Holographic SAR Tomography at L- and P-band

Airborne Holographic SAR Tomography at L- and P-band Airborne Holographic SAR Tomography at L- and P-band O. Ponce, A. Reigber and A. Moreira. Microwaves and Radar Institute (HR), German Aerospace Center (DLR). 1 Outline Introduction to 3-D SAR Holographic

More information

Lecture 23. Lidar Error and Sensitivity Analysis (2)

Lecture 23. Lidar Error and Sensitivity Analysis (2) Lecture 3. Lidar Error and Sensitivity Analysis ) q Derivation of Errors q Background vs. Noise q Sensitivity Analysis q Summary 1 Accuracy vs. Precision in Lidar Measurements q The precision errors caused

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

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

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

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

A Lecture on Selective RF-pulses in MRI

A Lecture on Selective RF-pulses in MRI A Lecture on Selective RF-pulses in MRI Charles L. Epstein February, 23 Introduction We describe the notion of selective excitation and explain how the Bloch equation is used to design selective RF-pulses.

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

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

Let us consider a typical Michelson interferometer, where a broadband source is used for illumination (Fig. 1a).

Let us consider a typical Michelson interferometer, where a broadband source is used for illumination (Fig. 1a). 7.1. Low-Coherence Interferometry (LCI) Let us consider a typical Michelson interferometer, where a broadband source is used for illumination (Fig. 1a). The light is split by the beam splitter (BS) and

More information

MAE 143B - Homework 7

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

More information

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 1 Solutions September 1, 5 Problem 1: If we assume, as suggested in the

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

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

Mobile Radio Communications

Mobile Radio Communications Course 3: Radio wave propagation Session 3, page 1 Propagation mechanisms free space propagation reflection diffraction scattering LARGE SCALE: average attenuation SMALL SCALE: short-term variations in

More information

Distributed Real-Time Control Systems

Distributed Real-Time Control Systems Distributed Real-Time Control Systems Chapter 9 Discrete PID Control 1 Computer Control 2 Approximation of Continuous Time Controllers Design Strategy: Design a continuous time controller C c (s) and then

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

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

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

Assignment 4 Solutions Continuous-Time Fourier Transform

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

More information

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

2.13 Linearization and Differentials

2.13 Linearization and Differentials Linearization and Differentials Section Notes Page Sometimes we can approimate more complicated functions with simpler ones These would give us enough accuracy for certain situations and are easier to

More information

J. McNames Portland State University ECE 223 DT Fourier Series Ver

J. McNames Portland State University ECE 223 DT Fourier Series Ver Overview of DT Fourier Series Topics Orthogonality of DT exponential harmonics DT Fourier Series as a Design Task Picking the frequencies Picking the range Finding the coefficients Example J. McNames Portland

More information

Master s Thesis Defense. Illumination Optimized Transmit Signals for Space-Time Multi-Aperture Radar. Committee

Master s Thesis Defense. Illumination Optimized Transmit Signals for Space-Time Multi-Aperture Radar. Committee Master s Thesis Defense Illumination Optimized Transmit Signals for Space-Time Multi-Aperture Radar Vishal Sinha January 23, 2006 Committee Dr. James Stiles (Chair) Dr. Chris Allen Dr. Glenn Prescott OUTLINE

More information

Research Article Study on Zero-Doppler Centroid Control for GEO SAR Ground Observation

Research Article Study on Zero-Doppler Centroid Control for GEO SAR Ground Observation Antennas and Propagation Article ID 549269 7 pages http://dx.doi.org/1.1155/214/549269 Research Article Study on Zero-Doppler Centroid Control for GEO SAR Ground Observation Yicheng Jiang Bin Hu Yun Zhang

More information

A REFINED TWO-DIMENSIONAL NONLINEAR CHIRP SCALING ALGORITHM FOR GEOSYNCHRONOUS EARTH ORBIT SAR

A REFINED TWO-DIMENSIONAL NONLINEAR CHIRP SCALING ALGORITHM FOR GEOSYNCHRONOUS EARTH ORBIT SAR Progress In Electromagnetics Research, Vol. 143, 19 46, 213 A REFINED TWO-DIMENSIONAL NONLINEAR CHIRP SCALING ALGORITHM FOR GEOSYNCHRONOUS EARTH ORBIT SAR Tao Zeng, Wenfu Yang, Zegang Ding *, Dacheng Liu,

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

EECS 556, 2002 Exam #1 1. Solutions to Take-Home Exam #1

EECS 556, 2002 Exam #1 1. Solutions to Take-Home Exam #1 EECS 556, 00 Exam # Solutions to Take-Home Exam #. [40 pts.] In this problem, you will create a Matlab script to investigate methods to suppress particular spectral features in an image. The image sensor

More information

A Radar Eye on the Moon: Potentials and Limitations for Earth Imaging

A Radar Eye on the Moon: Potentials and Limitations for Earth Imaging PIERS ONLINE, VOL. 6, NO. 4, 2010 330 A Radar Eye on the Moon: Potentials and Limitations for Earth Imaging M. Calamia 1, G. Fornaro 2, G. Franceschetti 3, F. Lombardini 4, and A. Mori 1 1 Dipartimento

More information

High resolution spaceborne SAR focusing by SVD-STOLT

High resolution spaceborne SAR focusing by SVD-STOLT High resolution spaceborne SAR focusing by SVD-STOLT D. D Aria, A. Monti Guarnieri. ARESYS - Via Garofalo, 39-33 Milano -Italy Tel +39399937 - e-mail:davide.daria@aresys.it Dipartimento di Elettronica

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

BNG/ECE 487 FINAL (W16)

BNG/ECE 487 FINAL (W16) BNG/ECE 487 FINAL (W16) NAME: 4 Problems for 100 pts This exam is closed-everything (no notes, books, etc.). Calculators are permitted. Possibly useful formulas and tables are provided on this page. Fourier

More information

1. Solve each linear system using Gaussian elimination or Gauss-Jordan reduction. The augmented matrix of this linear system is

1. Solve each linear system using Gaussian elimination or Gauss-Jordan reduction. The augmented matrix of this linear system is Solutions to Homework Additional Problems. Solve each linear system using Gaussian elimination or Gauss-Jordan reduction. (a) x + y = 8 3x + 4y = 7 x + y = 3 The augmented matrix of this linear system

More information

NAIC NAIC PLANETARY RADAR ASTRONOMY STUDYING SOLAR SYSTEM BODIES WITH RADAR DON CAMPBELL

NAIC NAIC PLANETARY RADAR ASTRONOMY STUDYING SOLAR SYSTEM BODIES WITH RADAR DON CAMPBELL NAIC PLANETARY RADAR ASTRONOMY or STUDYING SOLAR SYSTEM BODIES WITH RADAR DON CAMPBELL NAIC NAIC PLANETARY RADAR ASTRONOMY NAIC GOOD ASPECTS Transmitted signal Can control: Power Polarization Frequency

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

Temporal &Spatial Dependency of the MOS RMF

Temporal &Spatial Dependency of the MOS RMF Temporal &Spatial Dependency of the RMF 1ES0102-72 1 Thin filter 0447 2 Thin filter 0447 0433 1ES0102 0.1-0.35 kev images Good spectra clean images Bad spectra bright patch - Able to do spectral analysis

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

Rotation. I. Kinematics - Angular analogs

Rotation. I. Kinematics - Angular analogs Rotation I. Kinematics - Angular analogs II. III. IV. Dynamics - Torque and Rotational Inertia Work and Energy Angular Momentum - Bodies and particles V. Elliptical Orbits The student will be able to:

More information

MA 137 Calculus 1 with Life Science Applications The Chain Rule and Higher Derivatives (Section 4.4)

MA 137 Calculus 1 with Life Science Applications The Chain Rule and Higher Derivatives (Section 4.4) MA 137 Calculus 1 with Life Science Applications and (Section 4.4) Alberto Corso alberto.corso@uky.edu Department of Mathematics University of Kentucky March 2, 2016 1/15 Theorem Rules of Differentiation

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

PASSIVE MICROWAVE IMAGING. Dr. A. Bhattacharya

PASSIVE MICROWAVE IMAGING. Dr. A. Bhattacharya 1 PASSIVE MICROWAVE IMAGING Dr. A. Bhattacharya 2 Basic Principles of Passive Microwave Imaging Imaging with passive microwave is a complementary technology that needs an introduction to identify its role

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

Calibration Activities the MOS perspective

Calibration Activities the MOS perspective Calibration Activities the perspective Changing the Quantum Efficiency Calibration: Motivation and Justification. Flux comparison using a sample (17) of AGN observations: as presented at MPE (May 2006)

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

A Low-Power Radar Imaging System

A Low-Power Radar Imaging System EM Group A Low-Power Radar Imaging System BY GREGORY L. CHARVAT Introduction Through lossy dielectric slab imaging has been receiving much attention recently Current research is very diverse; using various

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

ENSC327 Communications Systems 2: Fourier Representations. Jie Liang School of Engineering Science Simon Fraser University

ENSC327 Communications Systems 2: Fourier Representations. Jie Liang School of Engineering Science Simon Fraser University ENSC327 Communications Systems 2: Fourier Representations Jie Liang School of Engineering Science Simon Fraser University 1 Outline Chap 2.1 2.5: Signal Classifications Fourier Transform Dirac Delta Function

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

Laboratory III: Operational Amplifiers

Laboratory III: Operational Amplifiers Physics 33, Fall 2008 Lab III - Handout Laboratory III: Operational Amplifiers Introduction Operational amplifiers are one of the most useful building blocks of analog electronics. Ideally, an op amp would

More information

FREQUENCY-DOMAIN RECONSTRUCTION OF THE POINT-SPREAD FUNCTION FOR MOVING SOURCES

FREQUENCY-DOMAIN RECONSTRUCTION OF THE POINT-SPREAD FUNCTION FOR MOVING SOURCES FREQUENCY-DOMAIN RECONSTRUCTION OF THE POINT-SPREAD FUNCTION FOR MOVING SOURCES Sébastien Guérin and Christian Weckmüller DLR, German Aerospace Center Institute of Propulsion Technology, Engine Acoustics

More information

Seismic Wave Propagation: HW2 Due 13/5

Seismic Wave Propagation: HW2 Due 13/5 Reading: Scales Chapter 5.1-5.3, 6, 7, 9, Kallweit and Wood (198), Schneider (1978) Problems.1-.8 should be done on your own. You may work together to solve problems.9-.10, but you must hand in your own

More information

Diffuser plate spectral structures and their influence on GOME slant columns

Diffuser plate spectral structures and their influence on GOME slant columns Diffuser plate spectral structures and their influence on GOME slant columns A. Richter 1 and T. Wagner 2 1 Insitute of Environmental Physics, University of Bremen 2 Insitute of Environmental Physics,

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

An Error Analysis of Elliptical Orbit Transfer Between Two Coplanar Circular Orbits

An Error Analysis of Elliptical Orbit Transfer Between Two Coplanar Circular Orbits An Error Analysis of Elliptical Orbit Transfer Between Two Coplanar Circular Orbits Marc A. Murison U.S. Naval Observatory, Washington, DC murison@usno.navy.mil 9 November, 006 Abstract We consider transfer

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

EE4512 Analog and Digital Communications Chapter 4. Chapter 4 Receiver Design

EE4512 Analog and Digital Communications Chapter 4. Chapter 4 Receiver Design Chapter 4 Receiver Design Chapter 4 Receiver Design Probability of Bit Error Pages 124-149 149 Probability of Bit Error The low pass filtered and sampled PAM signal results in an expression for the probability

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

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

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

Microelectronic Circuit Design 4th Edition Errata - Updated 4/4/14

Microelectronic Circuit Design 4th Edition Errata - Updated 4/4/14 Chapter Text # Inside back cover: Triode region equation should not be squared! i D = K n v GS "V TN " v & DS % ( v DS $ 2 ' Page 49, first exercise, second answer: -1.35 x 10 6 cm/s Page 58, last exercise,

More information

Considerations on radar localization in multi-target environments

Considerations on radar localization in multi-target environments Adv. Radio Sci., 7, 5 10, 2009 Author(s) 2009. This work is distributed under the Creative Commons Attribution 3.0 License. Advances in Radio Science Considerations on radar localization in multi-target

More information

Evaluation of a new autofocus algorithm within the framework of Fast Factorized Back-Projection

Evaluation of a new autofocus algorithm within the framework of Fast Factorized Back-Projection Technical Report, Earth and Space Sciences No. 8, 2011 Evaluation of a new autofocus algorithm within the framework of Fast Factorized Back-Projection Jan Torgrimsson CHALMERS UNIVERSITY OF TECHNOLOGY

More information

chap5_fourier_series_lr_circuit.doc 1/18 Consider the rectangular pulse train of example 3.2 of the text as the input to the series LR circuit.

chap5_fourier_series_lr_circuit.doc 1/18 Consider the rectangular pulse train of example 3.2 of the text as the input to the series LR circuit. chap5_fourier_series_lr_circuit.doc /8 Consider the rectangular pulse train of eample 3.2 of the tet as the input to the series LR circuit. t () -3-2 - 2 3 Rectangular pulse train (t) input signal. t (sec)

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

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

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

Solutions - Homework #2

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

More information

TIME-FREQUENCY ANALYSIS EE3528 REPORT. N.Krishnamurthy. Department of ECE University of Pittsburgh Pittsburgh, PA 15261

TIME-FREQUENCY ANALYSIS EE3528 REPORT. N.Krishnamurthy. Department of ECE University of Pittsburgh Pittsburgh, PA 15261 TIME-FREQUENCY ANALYSIS EE358 REPORT N.Krishnamurthy Department of ECE University of Pittsburgh Pittsburgh, PA 56 ABSTRACT - analysis, is an important ingredient in signal analysis. It has a plethora of

More information

Math Theory of Number Homework 1

Math Theory of Number Homework 1 Math 4050 Theory of Number Homework 1 Due Wednesday, 015-09-09, in class Do 5 of the following 7 problems. Please only attempt 5 because I will only grade 5. 1. Find all rational numbers and y satisfying

More information

ECE 501b Homework #6 Due: 11/26

ECE 501b Homework #6 Due: 11/26 ECE 51b Homework #6 Due: 11/26 1. Principal Component Analysis: In this assignment, you will explore PCA as a technique for discerning whether low-dimensional structure exists in a set of data and for

More information

Lecture 14 Dispersion engineering part 1 - Introduction. EECS Winter 2006 Nanophotonics and Nano-scale Fabrication P.C.Ku

Lecture 14 Dispersion engineering part 1 - Introduction. EECS Winter 2006 Nanophotonics and Nano-scale Fabrication P.C.Ku Lecture 14 Dispersion engineering part 1 - Introduction EEC 598-2 Winter 26 Nanophotonics and Nano-scale Fabrication P.C.Ku chedule for the rest of the semester Introduction to light-matter interaction

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

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

High Precision Spin Manipulation at COSY

High Precision Spin Manipulation at COSY Matter and Technologies High Precision Spin Manipulation at COSY Sebastian Mey Hamburg, February 26, 2015 Forschungszentrum Jülich 2 s.mey@fz-juelich.de High Precision Spin Manipulation at COSY Spin Motion

More information

Optics for Engineers Chapter 11

Optics for Engineers Chapter 11 Optics for Engineers Chapter 11 Charles A. DiMarzio Northeastern University Nov. 212 Fourier Optics Terminology Field Plane Fourier Plane C Field Amplitude, E(x, y) Ẽ(f x, f y ) Amplitude Point Spread

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

SWITCHED CAPACITOR AMPLIFIERS

SWITCHED CAPACITOR AMPLIFIERS SWITCHED CAPACITOR AMPLIFIERS AO 0V 4. AO 0V 4.2 i Q AO 0V 4.3 Q AO 0V 4.4 Q i AO 0V 4.5 AO 0V 4.6 i Q AO 0V 4.7 Q AO 0V 4.8 i Q AO 0V 4.9 Simple amplifier First approach: A 0 = infinite. C : V C = V s

More information

3 Chemical exchange and the McConnell Equations

3 Chemical exchange and the McConnell Equations 3 Chemical exchange and the McConnell Equations NMR is a technique which is well suited to study dynamic processes, such as the rates of chemical reactions. The time window which can be investigated in

More information

Supporting Materials

Supporting Materials Supporting Materials Figure S1 Experimental Setup Page Figure S (a) (b) (c) Feynman Diagrams Page 3-6 Figure S3 D IR Spectra Page 7 Figure S4 Kinetic Model Page 8 Figure S5 Van t Hoff Plots Page 9 1 k

More information