EE 355 / GP 265 Homework 2 Solutions Winter

Size: px
Start display at page:

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

Transcription

1 EE 355 / GP 265 Homework 2 Solutions Winter Chirp Compression (a) The bandwidth measured at 3 db down from the peak of the chirp spectrum is 9.5 MHz, which is reasonably close to the theoretical bandwidth BW = sτ = (1 12 Hz/s)(1 5 s) = 1 7 Hz = 1 MHz. 5 Problem 1a: Chirp spectrum 4 Chirp spectrum magnitude (db) Frequency (Hz) 1 7 1

2 (b) Compressing the chirp with the original reference signal gives the ideal impulse response. The first sidelobe is 13.5 db lower than the main lobe. 6 Problem 1b: Compressed signal, s = 1.e12 Hz/s 5 Compressed signal (db) Time (s) 1-7 (c) Compressing the chirp with 1% error in reference chirp slope (s = Hz/s): the first sidelobe is only 12.2 db below the main lobe, in effect decreasing the SNR. 6 Problem 1c: Compressed signal, s = 1.1e12 Hz/s 55 Compressed signal (db) Time (s) 1-7 2

3 Compressing the chirp with 3% error in reference chirp slope (s = Hz/s): the first sidelobe is 5.6 db below the main lobe. 6 Problem 1c: Compressed signal, s = 1.3e12 Hz/s 55 Compressed signal (db) Time (s) 1-7 % EE 355 HW 2 Problem 1 close all; clear; set(, defaultaxesfontsize, 16); s=1.e12; sr=1.e12;%1.1*1^12 or 1.3*1^12 for prob c tau=1.e-5; fs=1.e8; fc=; N=248; % Part a: Chirp and bandwidth si=makechirp(s,tau,fs,fc,1,n); S=fftshift(fft(si)); freq=linspace(-fs/2,fs/2,n); plot(freq,2*log1(abs(s))); xlabel( Frequency (Hz) ); ylabel( Chirp spectrum magnitude (db) ); title( Problem 1a: Chirp spectrum ); % Part b: Compress with perfect reference signal r=makechirp(sr,tau,fs,fc,1,n); 3

4 R=fftshift(fft(r)); Sc = S.*conj(R); rcomp=fftshift(ifft(fftshift(sc))); t=linspace(-123,124,n); plot(t/fs,2*log1(abs(rcomp)), linewidth,2); xlim([-4 4]*1^-7); ylim([-2 6]); xlabel( Time (s) ); ylabel( Compressed signal (db) ); title( Problem 1b: Compressed signal, s = 1.e12 Hz/s ); % Part c: Compress with different reference signal sr=[1.1e12 1.3e12]; srstr={ 1.1e12, 1.3e12 }; for k=1:length(sr) r=makechirp(sr(k),tau,fs,fc,1,n); R=fftshift(fft(r)); Sc = S.*conj(R); rcomp=fftshift(ifft(fftshift(sc))); t=linspace(-123,124,n); plot(t/fs,2*log1(abs(rcomp)), linewidth,2); xlim([-4 4]*1^-7); ylim([2 6]); xlabel( Time (s) ); ylabel( Compressed signal (db) ); title([ Problem 1c: Compressed signal, s = srstr{k} Hz/s ]); function chirp = makechirp(s,tau,fs,fc,start,n) %Function to compute chirp - reused in all problems %s: slope %tau: pulse length %fs: sample rate %fc: center frequency %start: location of chirp %n: the length of the chirp including zero dt=1/fs; npts=tau*fs; t=[-npts/2:npts/2-1]*dt; phase=pi*s*t.^2+2*pi*fc*t; chirp=[zeros(1,start-1) exp(1i*phase) zeros(1,n-length(phase)-start+1)]; 4

5 2. Separating multiple chirps (a) The chirps in the raw signal cannot be separated because they overlap in time. Each chirp is 1 points long (Npts = τ fs), so chirps starting at location 1, 4, and 5 will interfere with each other. 8 Problem 2a: Raw signal amplitude 7 6 Amplitude Time (s) 1-5 (b) The chirps no longer overlap after compression, so they are easy to separate. There is a peak at each chirp location (1, 4, and 5 samples), scaled properly according to each chirp s amplitude (1, 5, and 2, respectively). 5 Problem 2b: Compressed signal amplitude Amplitude Time (s) 1-5 % EE 355 HW 2 Problem 2 5

6 close all; clear; set(, defaultaxesfontsize, 16); s=1.e12; tau=1.e-5; fs=1.e8; fc=; N=248; dt=1/fs; % Part a: Raw signal amplitude vs. time r1=makechirp(s,tau,fs,fc,11,n); r2=5*makechirp(s,tau,fs,fc,41,n); r3=2*makechirp(s,tau,fs,fc,51,n); si=r1+r2+r3; t=linspace(,n*dt,n); plot(t,abs(si), linewidth,1.5); xlim([t(1) t()]); xlabel( Time (s) ); ylabel( Amplitude ); title( Problem 2a: Raw signal amplitude ); % Part b: Compressed signal amplitude r=makechirp(s,tau,fs,fc,1,n); S=(fft(si)); R=(fft(r)); Sc = S.*conj(R); rcomp=(ifft(sc)); plot(t,abs(rcomp), linewidth,1.5); xlim([t(1) t()]); xlabel( Time (s) ); ylabel( Amplitude ); title( Problem 2b: Compressed signal amplitude ); 6

7 3. Actual data (a) The ERS byte file has 124 lines, each line with 412 header bytes, followed by 986 data samples. The data samples were multiplied by 8 to fill the color table. Problem 3a: ERS data, byte file display 124 lines samples (b) Chirp spectrum for the ERS parameters. Chirp spectrum magnitude (db) 4 Problem 3b: ERS chirp spectrum Frequency (Hz) (c) Average range spectrum of ERS data. Compared to part (b), it has the same overall shape, but is tilted (due to the average value of the data not being exactly 15.5). 7

8 Average spectrum magnitude (db) 65 Problem 3c: Average range spectrum Frequency (Hz) 1 7 (d) Range-compressed image. Problem 3d: Range compressed image azimuth range % EE 355 HW 2 Problem 3 close all; clear; set(, defaultaxesfontsize, 16); % Part a: Display byte file nhdr = 412; nsamp = 1218; nlines = 124; fid=fopen( ersdata ); dat=fread(fid,[nsamp, nlines], uint8 );

9 fclose(fid); dat_disp = dat; dat_disp(nhdr+1:,:) = 8*dat_disp(nhdr+1:,:); % scale by 8, fill color table imagesc(dat_disp ); colormap( gray ); colorbar; xlabel( 1218 samples ); ylabel( 124 lines ); title( Problem 3a: ERS data, byte file display ); % Part b: ERS chirp spectrum s= e11; tau=37.12e-6; fs=18.96e6; fc=; N=(nsamp-nhdr)/2; % number of range samples in complex data r=makechirp(s,tau,fs,fc,1,n); R=fft(r); freq=linspace(-fs/2,fs/2,n); plot(freq,fftshift(2*log1(abs(r)))); xlabel( Frequency (Hz) ); ylabel( Chirp spectrum magnitude (db) ); title( Problem 3b: ERS chirp spectrum ); % Part c: average of 124 spectra A=dat(nhdr+1:nsamp,:); signal=(a(1:2:,:)-15.5)+1i*(a(2:2:,:)-15.5); S=fft(signal); % FFT each range line (column) avs=abs(s(:,1)); for ii=2:nlines avs=avs+abs(s(:,ii)); avs=avs/nlines; plot(freq,fftshift(2*log1(abs(avs)))); xlabel( Frequency (Hz) ); ylabel( Average spectrum magnitude (db) ); title( Problem 3c: Average range spectrum ); % Part d: Range compressed image Sc=zeros(size(S)); for jj=1:nlines Sc(:,jj)=S(:,jj).*conj(R. ); rcomp=(ifft(sc)); imagesc(abs(rcomp )); 9

10 colormap( gray ); axis image; colorbar; xlabel( range ); ylabel( azimuth ); title( Problem 3d: Range compressed image ); 4. I/Q and offset video processing (a) Here is the impulse response for the chirp signal, for an I/Q system. 6 Problem 4a: Impulse response, I/Q system 5 Compressed signal (db) Time (s) 1-5 (b) The impulse response of the offset video system should be identical to the impulse response for the I/Q system. There may be some slight numerical differences. 1

11 6 Problem 4b: Impulse response, offset video 5 Compressed signal (db) Time (s) 1-5 The bandwidth is BW = sτ = (1 11 Hz/s)(3 1 6 s) = Hz = 3 MHz (1) The minimum chirp frequency is: f min = f c BW 2 = 1 MHz 3 MHz 2 = 8.5 MHz (2) and the maximum chirp frequency is: f max = f c + BW 2 = 1 MHz + 3 MHz 2 = 11.5 MHz (3) % EE 355 HW 2 Problem 4 close all; clear; set(, defaultaxesfontsize, 16); % Part a: Impulse response, I/Q system s=1e11; tau=3e-5; fs=2e7; fc=1e7; 11

12 N=124; dt=1/fs; r=makechirp(s,tau,fs,fc,1,n); sig=makechirp(s,tau,fs,fc,1,n); R=(fft(r)); Sig=(fft(sig)); Rc=Sig.*conj(R); rcomp=fftshift(ifft(rc)); t=(-n/2:n/2-1)*dt; figure(1) plot(t,2*log1(abs(rcomp))); xlim([-1 1]*1e-5); ylim([-4 6]); title( Problem 4a: Impulse response, I/Q system ); xlabel( Time (s) ); ylabel( Compressed signal (db) ); % Part b: Impulse response, offset video % Reference chirp ref=makechirp(s,tau,fs,fc,1,n); REF=fft(ref); % Real chirp, twice the sample rate & array size si=real(makechirp(s,tau,2*fs,fc,1,n*2)); S=fft(si); S_side=S(1:N); % Save only positive frequencies (one sideband) % Compress the chirp R_c=S_side.*conj(REF); r_comp=fftshift(ifft(r_c)); figure(2); plot(t,2*log1(abs(r_comp)), r ); xlim([-1 1]*1e-5); ylim([-4 6]); title( Problem 4b: Impulse response, offset video ); xlabel( Time (s) ); ylabel( Compressed signal (db) ); 12

13 5. Sidelobe filtering For the chirp in problem 4, the peak sidelobe level ratio (PSLR) is db. The integrated sidelobe level ratio (ISLR) is db. Next, we weight the chirp according to W (f) = w + (1 w) cos (2π(f f c )/BW ), letting w vary from.4 to 1. Here is the plot of ISLR and PSLR as a function of w: The PSLR is minimized at w =.56, which is consistent with the equation for the Hamming window (w =.54) that best suppresses the amplitude of the first side lobe. The ISLR is minimized at w =.52, which is consistent with the equation for the Hann window that minimizes total side lobe energy. % EE355 pb5: sidelobe filtering clear;close all;clc set(,'defaultaxesfontsize',16) s=1e11; % Chirp slope, Hz/s tau=3e-6; % Pulse length, s fs=2e6; % Complex sample rate, Hz fc=1e6; % Center frequency (Carrier frequency) Nsample=ceil(fs*tau); % Number of samples fftlen=2^ceil(log(nsample)/log(2)); dt=1/fs; % Sample spacing in time domain df=fs/fftlen; % Sample spacing in frequency domain f=(:fftlen-1)*df; t=(-fftlen/2:fftlen/2-1)*dt; 13

14 %% construct ref chirp ref_chirp=makechirp(s,tau,fs,fc,1,fftlen); spect_chirp=fft(ref_chirp); %% construct impulse response impres=fftshift(ifft(spect_chirp.*conj(spect_chirp))); figure plot(t,2*log1(abs(impres)),'linewidth',2) xlabel('t') ylabel('compressed signal,db') title('impulse response') grid on; xlim([-2,2]*1e-7) % calculate PSLR and ISLR impres_pw = abs(impres).^2; figure plot(t,impres_pw) xlim([-2,2]*1e-7) %% impulse response weighting ww=.4:.2:1; bw=s*tau; for i=1:length(ww) w=ww(i); weight=w+(1-w)*cos(2*pi/bw.*(f-fc)); spect_newref=spect_chirp.*weight'; newimpres=fftshift(ifft(spect_chirp.*conj(spect_newref))); newimprespw=abs(newimpres).^2; [islr(i),pslr(i)]=property_imp(newimprespw); figure plot(ww,islr,'linewidth',2) hold on plot(ww,pslr,'linewidth',2) xlabel('w') ylabel('sidelobe level ratio (db)') title('islr,pslr vs. w') leg('islr','pslr') saveas(gcf,'pb5_pslr_islr','tiff') [v,idx1]=min(islr); ww(idx1) [v,idx2]=min(pslr); ww(idx2) 14

15 function [ISLR,PSLR]=property_imp(imprespw) % this function computes ISLR and PSLR of a given impulse response (power) % it also requires that the imprespw is symmetric about the peak n = length(imprespw); % first, find the position of the peak [pkv,pkidx]=max(imprespw); % then, find the first null point location for m=pkidx+1:n-1 if(imprespw(m)<imprespw(m-1) &&... imprespw(m)<imprespw(m+1)) null_indx = m; break; % lastly, find the first sidelobe location for m=null_indx+1:n-1 if(imprespw(m)>imprespw(m-1) &&... imprespw(m)>imprespw(m+1)) sidelobe_indx = m; break; % PSLR PSLR = imprespw(sidelobe_indx)/imprespw(pkidx); PSLR = 1*log1(PSLR); % ISLR sidelobepw = sum(imprespw(null_indx:n)); pkpw = sum(imprespw(pkidx:null_indx)); ISLR = sidelobepw/pkpw; ISLR = 1*log1(ISLR); return 15

16 16

EECS 455 Solution to Problem Set 3

EECS 455 Solution to Problem Set 3 EECS 455 Solution to Problem Set 3. (a) Is it possible to have reliably communication with a data rate of.5mbps using power P 3 Watts with a bandwidth of W MHz and a noise power spectral density of N 8

More information

Application of pulse compression technique to generate IEEE a-compliant UWB IR pulse with increased energy per bit

Application of pulse compression technique to generate IEEE a-compliant UWB IR pulse with increased energy per bit Application of pulse compression technique to generate IEEE 82.15.4a-compliant UWB IR pulse with increased energy per bit Tamás István Krébesz Dept. of Measurement and Inf. Systems Budapest Univ. of Tech.

More information

Faculty of Engineering Electrical Engineering Department Communication Engineering I Lab (EELE 3170) Eng. Adam M. Hammad

Faculty of Engineering Electrical Engineering Department Communication Engineering I Lab (EELE 3170) Eng. Adam M. Hammad Faculty of Engineering Electrical Engineering Department Communication Engineering I Lab (EELE 3170) Eng. Adam M. Hammad EXPERIMENT #5 DSB-SC AND SSB MODULATOR Theory The amplitude-modulated signal is

More information

Pulse Compression. Since each part of the pulse has unique frequency, the returns can be completely separated.

Pulse Compression. Since each part of the pulse has unique frequency, the returns can be completely separated. Pulse Compression Pulse compression is a generic term that is used to describe a waveshaping process that is produced as a propagating waveform is modified by the electrical network properties of the transmission

More information

Optimum Bandpass Filter Bandwidth for a Rectangular Pulse

Optimum Bandpass Filter Bandwidth for a Rectangular Pulse M. A. Richards, Optimum Bandpass Filter Bandwidth for a Rectangular Pulse Jul., 015 Optimum Bandpass Filter Bandwidth for a Rectangular Pulse Mark A. Richards July 015 1 Introduction It is well-known that

More information

Impulse Response as a Measurement of the Quality of Chirp Radar Pulses

Impulse Response as a Measurement of the Quality of Chirp Radar Pulses Impulse Response as a Measurement of the Quality of Chirp Radar Pulses Thomas Hill and Shigetsune Torin RF Products (RTSA) Tektronix, Inc. Abstract Impulse Response can be performed on a complete radar

More information

Time and Frequency Domain Windowing of LFM Pulses Mark A. Richards

Time and Frequency Domain Windowing of LFM Pulses Mark A. Richards Time and Frequency Domain Mark A. Richards September 29, 26 1 Frequency Domain Windowing of LFM Waveforms in Fundamentals of Radar Signal Processing Section 4.7.1 of [1] discusses the reduction of time

More information

Problems from the 3 rd edition

Problems from the 3 rd edition (2.1-1) Find the energies of the signals: a) sin t, 0 t π b) sin t, 0 t π c) 2 sin t, 0 t π d) sin (t-2π), 2π t 4π Problems from the 3 rd edition Comment on the effect on energy of sign change, time shifting

More information

Exercise 2: Simulation of ultrasound field using Field II

Exercise 2: Simulation of ultrasound field using Field II Exercise 2: Simulation of ultrasound field using Field II The purposes of this exercise is to learn how to: Set up the simulation environment and model a transducer in Field II o Single element transducer

More information

EXPERIMENT 4 INTRODUCTION TO AMPLITUDE MODULATION SUBMITTED BY

EXPERIMENT 4 INTRODUCTION TO AMPLITUDE MODULATION SUBMITTED BY EXPERIMENT 4 INTRODUCTION TO AMPLITUDE MODULATION SUBMITTED BY NAME:. STUDENT ID:.. ROOM: INTRODUCTION TO AMPLITUDE MODULATION Purpose: The objectives of this laboratory are:. To introduce the spectrum

More information

CHAPTER 5. Additional Problems (a) The AM signal is defined by st () = A c. k a A c 1

CHAPTER 5. Additional Problems (a) The AM signal is defined by st () = A c. k a A c 1 CHAPTER 5 Additional Problems 5.7 (a) The AM signal is defined by st () A c ( + k a mt ()) cos( ω c k a A c + ------------ + t cos( ω c To obtain 5% modulation, we choose k a, which results in the modulated

More information

Chapter 5 Window Functions. periodic with a period of N (number of samples). This is observed in table (3.1).

Chapter 5 Window Functions. periodic with a period of N (number of samples). This is observed in table (3.1). Chapter 5 Window Functions 5.1 Introduction As discussed in section (3.7.5), the DTFS assumes that the input waveform is periodic with a period of N (number of samples). This is observed in table (3.1).

More information

Pulse Compression Time-Bandwidth Product. Chapter 5

Pulse Compression Time-Bandwidth Product. Chapter 5 Chapter 5 Pulse Compression Range resolution for a given radar can be significantly improved by using very short pulses. Unfortunately, utilizing short pulses decreases the average transmitted power, which

More information

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY 2 Basic Definitions Time and Frequency db conversion Power and dbm Filter Basics 3 Filter Filter is a component with frequency

More information

Antenna Measurements using Modulated Signals

Antenna Measurements using Modulated Signals Antenna Measurements using Modulated Signals Roger Dygert MI Technologies, 1125 Satellite Boulevard, Suite 100 Suwanee, GA 30024-4629 Abstract Antenna test engineers are faced with testing increasingly

More information

Communication Systems. Department of Electronics and Electrical Engineering

Communication Systems. Department of Electronics and Electrical Engineering COMM 704: Communication Lecture 6: Oscillators (Continued) Dr Mohamed Abd El Ghany Dr. Mohamed Abd El Ghany, Mohamed.abdel-ghany@guc.edu.eg Course Outline Introduction Multipliers Filters Oscillators Power

More information

C/N Ratio at Low Carrier Frequencies in SFQ

C/N Ratio at Low Carrier Frequencies in SFQ Application Note C/N Ratio at Low Carrier Frequencies in SFQ Products: TV Test Transmitter SFQ 7BM09_0E C/N ratio at low carrier frequencies in SFQ Contents 1 Preliminaries... 3 2 Description of Ranges...

More information

Solution Set for Mini-Project #2 on Octave Band Filtering for Audio Signals

Solution Set for Mini-Project #2 on Octave Band Filtering for Audio Signals EE 313 Linear Signals & Systems (Fall 2018) Solution Set for Mini-Project #2 on Octave Band Filtering for Audio Signals Mr. Houshang Salimian and Prof. Brian L. Evans 1- Introduction (5 points) A finite

More information

Other Effects in PLLs. Behzad Razavi Electrical Engineering Department University of California, Los Angeles

Other Effects in PLLs. Behzad Razavi Electrical Engineering Department University of California, Los Angeles Other Effects in PLLs Behzad Razavi Electrical Engineering Department University of California, Los Angeles Example of Up and Down Skew and Width Mismatch Approximating the pulses on the control line by

More information

Log Booklet for EE2 Experiments

Log Booklet for EE2 Experiments Log Booklet for EE2 Experiments Vasil Zlatanov DFT experiment Exercise 1 Code for sinegen.m function y = sinegen(fsamp, fsig, nsamp) tsamp = 1/fsamp; t = 0 : tsamp : (nsamp-1)*tsamp; y = sin(2*pi*fsig*t);

More information

Frequency Domain Representation of Signals

Frequency Domain Representation of Signals Frequency Domain Representation of Signals The Discrete Fourier Transform (DFT) of a sampled time domain waveform x n x 0, x 1,..., x 1 is a set of Fourier Coefficients whose samples are 1 n0 X k X0, X

More information

EE228 Applications of Course Concepts. DePiero

EE228 Applications of Course Concepts. DePiero EE228 Applications of Course Concepts DePiero Purpose Describe applications of concepts in EE228. Applications may help students recall and synthesize concepts. Also discuss: Some advanced concepts Highlight

More information

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY

TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY TSEK02: Radio Electronics Lecture 2: Modulation (I) Ted Johansson, EKS, ISY An Overview of Modulation Techniques: chapter 3.1 3.3.1 2 Introduction (3.1) Analog Modulation Amplitude Modulation Phase and

More information

Signal Processing. Introduction

Signal Processing. Introduction Signal Processing 0 Introduction One of the premiere uses of MATLAB is in the analysis of signal processing and control systems. In this chapter we consider signal processing. The final chapter of the

More information

EE390 Final Exam Fall Term 2002 Friday, December 13, 2002

EE390 Final Exam Fall Term 2002 Friday, December 13, 2002 Name Page 1 of 11 EE390 Final Exam Fall Term 2002 Friday, December 13, 2002 Notes 1. This is a 2 hour exam, starting at 9:00 am and ending at 11:00 am. The exam is worth a total of 50 marks, broken down

More information

The Effect of Notch Filter on RFI Suppression

The Effect of Notch Filter on RFI Suppression Wireless Sensor Networ, 9, 3, 96-5 doi:.436/wsn.9.36 Published Online October 9 (http://www.scirp.org/journal/wsn/). The Effect of Notch Filter on RFI Suppression Wenge CHANG, Jianyang LI, Xiangyang LI

More information

22 AIRCRAFT IN WINDS 69

22 AIRCRAFT IN WINDS 69 22 AIRCRAFT IN WINDS 69 22 Aircraft in Winds This problem builds on the previous one: you will use the same wind gust spectrum, and study the response of an air vehicle that is being buffeted by it. Here

More information

Subtractive Synthesis. Describing a Filter. Filters. CMPT 468: Subtractive Synthesis

Subtractive Synthesis. Describing a Filter. Filters. CMPT 468: Subtractive Synthesis Subtractive Synthesis CMPT 468: Subtractive Synthesis Tamara Smyth, tamaras@cs.sfu.ca School of Computing Science, Simon Fraser University November, 23 Additive synthesis involves building the sound by

More information

Phase demodulation using the Hilbert transform in the frequency domain

Phase demodulation using the Hilbert transform in the frequency domain Phase demodulation using the Hilbert transform in the frequency domain Author: Gareth Forbes Created: 3/11/9 Revised: 7/1/1 Revision: 1 The general idea A phase modulated signal is a type of signal which

More information

MAE143A Signals & Systems - Homework 9, Winter 2015 due by the end of class Friday March 13, 2015.

MAE143A Signals & Systems - Homework 9, Winter 2015 due by the end of class Friday March 13, 2015. MAEA Signals & Systems - Homework 9, Winter due by the end of class Friday March,. Question Three audio files have been placed on the class website: Waits.wav, WaitsAliased.wav, WaitsDecimated.wav. These

More information

Signal Processing Toolbox

Signal Processing Toolbox Signal Processing Toolbox Perform signal processing, analysis, and algorithm development Signal Processing Toolbox provides industry-standard algorithms for analog and digital signal processing (DSP).

More information

6.02 Practice Problems: Modulation & Demodulation

6.02 Practice Problems: Modulation & Demodulation 1 of 12 6.02 Practice Problems: Modulation & Demodulation Problem 1. Here's our "standard" modulation-demodulation system diagram: at the transmitter, signal x[n] is modulated by signal mod[n] and the

More information

Fourier Transform Analysis of Signals and Systems

Fourier Transform Analysis of Signals and Systems Fourier Transform Analysis of Signals and Systems Ideal Filters Filters separate what is desired from what is not desired In the signals and systems context a filter separates signals in one frequency

More information

1 Introduction: frequency stability and accuracy

1 Introduction: frequency stability and accuracy Content 1 Introduction: frequency stability and accuracy... Measurement methods... 4 Beat Frequency method... 4 Advantages... 4 Restrictions... 4 Spectrum analyzer method... 5 Advantages... 5 Restrictions...

More information

SIDELOBES REDUCTION USING SIMPLE TWO AND TRI-STAGES NON LINEAR FREQUENCY MODULA- TION (NLFM)

SIDELOBES REDUCTION USING SIMPLE TWO AND TRI-STAGES NON LINEAR FREQUENCY MODULA- TION (NLFM) Progress In Electromagnetics Research, PIER 98, 33 52, 29 SIDELOBES REDUCTION USING SIMPLE TWO AND TRI-STAGES NON LINEAR FREQUENCY MODULA- TION (NLFM) Y. K. Chan, M. Y. Chua, and V. C. Koo Faculty of Engineering

More information

Synthesis: From Frequency to Time-Domain

Synthesis: From Frequency to Time-Domain Synthesis: From Frequency to Time-Domain I Synthesis is a straightforward process; it is a lot like following a recipe. I Ingredients are given by the spectrum X (f )={(X 0, 0), (X 1, f 1 ), (X 1, f 1),...,

More information

STABLE32 FREQUENCY DOMAIN FUNCTIONS W.J. Riley, Hamilton Technical Services

STABLE32 FREQUENCY DOMAIN FUNCTIONS W.J. Riley, Hamilton Technical Services STABLE32 FREQUENCY DOMAIN FUNCTIONS W.J. Riley, Hamilton Technical Services ABSTRACT This document shows an example of a time and frequency domain stability analysis using Stable32. First, a set of simulated

More information

ECE 2713 Design Project Solution

ECE 2713 Design Project Solution ECE 2713 Design Project Solution Spring 218 Dr. Havlicek 1. (a) Matlab code: ---------------------------------------------------------- P1a Make a 2 second digital audio signal that contains a pure cosine

More information

Practice 2. Baseband Communication

Practice 2. Baseband Communication PRACTICE : Practice. Baseband Communication.. Objectives To learn to use the software Simulink of MATLAB so as to analyze baseband communication systems... Practical development... Unipolar NRZ signal

More information

Signal Processing for Digitizers

Signal Processing for Digitizers Signal Processing for Digitizers Modular digitizers allow accurate, high resolution data acquisition that can be quickly transferred to a host computer. Signal processing functions, applied in the digitizer

More information

Chapter 3, Sections Electrical Filters

Chapter 3, Sections Electrical Filters Chapter 3, Sections 3.2.4-3.2.5 Electrical Filters Signals DC and AC Components - Many signals can be constructed as sums of AC and DC components: 2.5 2 1.5 2 1.5 1.5 1 2 3 4 1.5 -.5-1 1 2 3 4 = + 2.5

More information

ADC Clock Jitter Model, Part 2 Random Jitter

ADC Clock Jitter Model, Part 2 Random Jitter db ADC Clock Jitter Model, Part 2 Random Jitter In Part 1, I presented a Matlab function to model an ADC with jitter on the sample clock, and applied it to examples with deterministic jitter. Now we ll

More information

IMPLEMENTATION OF GMSK MODULATION SCHEME WITH CHANNEL EQUALIZATION

IMPLEMENTATION OF GMSK MODULATION SCHEME WITH CHANNEL EQUALIZATION IMPLEMENTATION OF GMSK MODULATION SCHEME WITH CHANNEL EQUALIZATION References MX589 GMSK MODEM Application Modem Techniques in Satellite Communication Practical GMSK Data Transmission GMSK MODEM Application

More information

Complex Sounds. Reading: Yost Ch. 4

Complex Sounds. Reading: Yost Ch. 4 Complex Sounds Reading: Yost Ch. 4 Natural Sounds Most sounds in our everyday lives are not simple sinusoidal sounds, but are complex sounds, consisting of a sum of many sinusoids. The amplitude and frequency

More information

EEM478-WEEK8 Finite Impulse Response (FIR) Filters

EEM478-WEEK8 Finite Impulse Response (FIR) Filters EEM478-WEEK8 Finite Impulse Response (FIR) Filters Learning Objectives Introduction to the theory behind FIR filters: Properties (including aliasing). Coefficient calculation. Structure selection. Implementation

More information

EXAMINATION FOR THE DEGREE OF B.E. Semester 1 June COMMUNICATIONS IV (ELEC ENG 4035)

EXAMINATION FOR THE DEGREE OF B.E. Semester 1 June COMMUNICATIONS IV (ELEC ENG 4035) EXAMINATION FOR THE DEGREE OF B.E. Semester 1 June 2007 101902 COMMUNICATIONS IV (ELEC ENG 4035) Official Reading Time: Writing Time: Total Duration: 10 mins 120 mins 130 mins Instructions: This is a closed

More information

Implementing Orthogonal Binary Overlay on a Pulse Train using Frequency Modulation

Implementing Orthogonal Binary Overlay on a Pulse Train using Frequency Modulation Implementing Orthogonal Binary Overlay on a Pulse Train using Frequency Modulation As reported recently, overlaying orthogonal phase coding on any coherent train of identical radar pulses, removes most

More information

Memorial University of Newfoundland Faculty of Engineering and Applied Science. Lab Manual

Memorial University of Newfoundland Faculty of Engineering and Applied Science. Lab Manual Memorial University of Newfoundland Faculty of Engineering and Applied Science Engineering 6871 Communication Principles Lab Manual Fall 2014 Lab 1 AMPLITUDE MODULATION Purpose: 1. Learn how to use Matlab

More information

Agilent Pulsed Measurements Using Narrowband Detection and a Standard PNA Series Network Analyzer

Agilent Pulsed Measurements Using Narrowband Detection and a Standard PNA Series Network Analyzer Agilent Pulsed Measurements Using Narrowband Detection and a Standard PNA Series Network Analyzer White Paper Contents Introduction... 2 Pulsed Signals... 3 Pulsed Measurement Technique... 5 Narrowband

More information

Phase demodulation using the Hilbert transform in the frequency domain

Phase demodulation using the Hilbert transform in the frequency domain Phase demodulation using the Hilbert transform in the frequency domain Author: Gareth Forbes Created: 3/11/9 Revision: The general idea A phase modulated signal is a type of signal which contains information

More information

Implementation of Orthogonal Frequency Coded SAW Devices Using Apodized Reflectors

Implementation of Orthogonal Frequency Coded SAW Devices Using Apodized Reflectors Implementation of Orthogonal Frequency Coded SAW Devices Using Apodized Reflectors Derek Puccio, Don Malocha, Nancy Saldanha Department of Electrical and Computer Engineering University of Central Florida

More information

Measuring and generating signals with ADC's and DAC's

Measuring and generating signals with ADC's and DAC's Measuring and generating signals with ADC's and DAC's 1) Terms used Full Scale Range, Least Significant Bit (LSB), Resolution, Linearity, Accuracy, Gain Error, Offset, Monotonicity, Conversion time, Settling

More information

AM Limitations. Amplitude Modulation II. DSB-SC Modulation. AM Modifications

AM Limitations. Amplitude Modulation II. DSB-SC Modulation. AM Modifications Lecture 6: Amplitude Modulation II EE 3770: Communication Systems AM Limitations AM Limitations DSB-SC Modulation SSB Modulation VSB Modulation Lecture 6 Amplitude Modulation II Amplitude modulation is

More information

B.Tech II Year II Semester (R13) Supplementary Examinations May/June 2017 ANALOG COMMUNICATION SYSTEMS (Electronics and Communication Engineering)

B.Tech II Year II Semester (R13) Supplementary Examinations May/June 2017 ANALOG COMMUNICATION SYSTEMS (Electronics and Communication Engineering) Code: 13A04404 R13 B.Tech II Year II Semester (R13) Supplementary Examinations May/June 2017 ANALOG COMMUNICATION SYSTEMS (Electronics and Communication Engineering) Time: 3 hours Max. Marks: 70 PART A

More information

UNIT TEST I Digital Communication

UNIT TEST I Digital Communication Time: 1 Hour Class: T.E. I & II Max. Marks: 30 Q.1) (a) A compact disc (CD) records audio signals digitally by using PCM. Assume the audio signal B.W. to be 15 khz. (I) Find Nyquist rate. (II) If the Nyquist

More information

Code No: R Set No. 1

Code No: R Set No. 1 Code No: R05220405 Set No. 1 II B.Tech II Semester Regular Examinations, Apr/May 2007 ANALOG COMMUNICATIONS ( Common to Electronics & Communication Engineering and Electronics & Telematics) Time: 3 hours

More information

Amplitude Modulation II

Amplitude Modulation II Lecture 6: Amplitude Modulation II EE 3770: Communication Systems Lecture 6 Amplitude Modulation II AM Limitations DSB-SC Modulation SSB Modulation VSB Modulation Multiplexing Mojtaba Vaezi 6-1 Contents

More information

Spur Detection, Analysis and Removal Stable32 W.J. Riley Hamilton Technical Services

Spur Detection, Analysis and Removal Stable32 W.J. Riley Hamilton Technical Services Introduction Spur Detection, Analysis and Removal Stable32 W.J. Riley Hamilton Technical Services Stable32 Version 1.54 and higher has the capability to detect, analyze and remove discrete spectral components

More information

Project 0: Part 2 A second hands-on lab on Speech Processing Frequency-domain processing

Project 0: Part 2 A second hands-on lab on Speech Processing Frequency-domain processing Project : Part 2 A second hands-on lab on Speech Processing Frequency-domain processing February 24, 217 During this lab, you will have a first contact on frequency domain analysis of speech signals. You

More information

Outline. Communications Engineering 1

Outline. Communications Engineering 1 Outline Introduction Signal, random variable, random process and spectra Analog modulation Analog to digital conversion Digital transmission through baseband channels Signal space representation Optimal

More information

Panasonic, 2 Channel FFT Analyzer VS-3321A. DC to 200kHz,512K word memory,and 2sets of FDD

Panasonic, 2 Channel FFT Analyzer VS-3321A. DC to 200kHz,512K word memory,and 2sets of FDD Panasonic, 2 Channel FFT Analyzer VS-3321A DC to 200kHz,512K word memory,and 2sets of FDD New generation 2CH FFT Anal General The FFT analyzer is a realtime signal analyzer using the Fast Fourier Transform

More information

CHAPTER 6 Frequency Response, Bode. Plots, and Resonance

CHAPTER 6 Frequency Response, Bode. Plots, and Resonance CHAPTER 6 Frequency Response, Bode Plots, and Resonance CHAPTER 6 Frequency Response, Bode Plots, and Resonance 1. State the fundamental concepts of Fourier analysis. 2. Determine the output of a filter

More information

Lecture 13. Introduction to OFDM

Lecture 13. Introduction to OFDM Lecture 13 Introduction to OFDM Ref: About-OFDM.pdf Orthogonal frequency division multiplexing (OFDM) is well-known to be effective against multipath distortion. It is a multicarrier communication scheme,

More information

Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective

Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective Wireless Communication Systems Laboratory Lab#1: An introduction to basic digital baseband communication through MATLAB simulation Objective The objective is to teach students a basic digital communication

More information

EE 422G - Signals and Systems Laboratory

EE 422G - Signals and Systems Laboratory EE 422G - Signals and Systems Laboratory Lab 5 Filter Applications Kevin D. Donohue Department of Electrical and Computer Engineering University of Kentucky Lexington, KY 40506 February 18, 2014 Objectives:

More information

ELT DIGITAL COMMUNICATIONS

ELT DIGITAL COMMUNICATIONS ELT-43007 DIGITAL COMMUNICATIONS Matlab Exercise #2 Baseband equivalent digital transmission in AWGN channel: Transmitter and receiver structures - QAM signals, Gray coding and bit error probability calculations

More information

Charan Langton, Editor

Charan Langton, Editor Charan Langton, Editor SIGNAL PROCESSING & SIMULATION NEWSLETTER Baseband, Passband Signals and Amplitude Modulation The most salient feature of information signals is that they are generally low frequency.

More information

The Fundamentals of FFT-Based Signal Analysis and Measurement Michael Cerna and Audrey F. Harvey

The Fundamentals of FFT-Based Signal Analysis and Measurement Michael Cerna and Audrey F. Harvey Application ote 041 The Fundamentals of FFT-Based Signal Analysis and Measurement Michael Cerna and Audrey F. Harvey Introduction The Fast Fourier Transform (FFT) and the power spectrum are powerful tools

More information

Analysis of Persistent RFI Signals Captured Using the CISR Coherent Sampling Mode

Analysis of Persistent RFI Signals Captured Using the CISR Coherent Sampling Mode Analysis of Persistent RFI Signals Captured Using the CISR Coherent Sampling Mode S.W. Ellingson and K.H. Lee February 13, 26 Contents 1 Introduction 2 2 Methodology 2 2.1 Hardware Configuration and Data

More information

Signals and Systems Lecture 9 Communication Systems Frequency-Division Multiplexing and Frequency Modulation (FM)

Signals and Systems Lecture 9 Communication Systems Frequency-Division Multiplexing and Frequency Modulation (FM) Signals and Systems Lecture 9 Communication Systems Frequency-Division Multiplexing and Frequency Modulation (FM) April 11, 2008 Today s Topics 1. Frequency-division multiplexing 2. Frequency modulation

More information

Dive deep into interference analysis

Dive deep into interference analysis Dive deep into interference analysis Dive deep into interference analysis Contents 1. Introducing Narda Outstanding features 2. Basics IDA 2 3. IDA 2 presentation How IDA 2 is used: 1) Detect 2) Analyze

More information

Advanced RF Measurements You Didn t Know Your Oscilloscope Could Make. Brad Frieden Philip Gresock

Advanced RF Measurements You Didn t Know Your Oscilloscope Could Make. Brad Frieden Philip Gresock Advanced RF Measurements You Didn t Know Your Oscilloscope Could Make Brad Frieden Philip Gresock Agenda RF measurement challenges Oscilloscope platform overview Typical RF characteristics Bandwidth vs.

More information

ELT COMMUNICATION THEORY

ELT COMMUNICATION THEORY ELT 41307 COMMUNICATION THEORY Project work, Fall 2017 Experimenting an elementary single carrier M QAM based digital communication chain 1 ASSUMED SYSTEM MODEL AND PARAMETERS 1.1 SYSTEM MODEL In this

More information

5650 chapter4. November 6, 2015

5650 chapter4. November 6, 2015 5650 chapter4 November 6, 2015 Contents Sampling Theory 2 Starting Point............................................. 2 Lowpass Sampling Theorem..................................... 2 Principle Alias Frequency..................................

More information

PXIe Contents SPECIFICATIONS. 14 GHz and 26.5 GHz Vector Signal Analyzer

PXIe Contents SPECIFICATIONS. 14 GHz and 26.5 GHz Vector Signal Analyzer SPECIFICATIONS PXIe-5668 14 GHz and 26.5 GHz Vector Signal Analyzer These specifications apply to the PXIe-5668 (14 GHz) Vector Signal Analyzer and the PXIe-5668 (26.5 GHz) Vector Signal Analyzer with

More information

MAKING TRANSIENT ANTENNA MEASUREMENTS

MAKING TRANSIENT ANTENNA MEASUREMENTS MAKING TRANSIENT ANTENNA MEASUREMENTS Roger Dygert, Steven R. Nichols MI Technologies, 1125 Satellite Boulevard, Suite 100 Suwanee, GA 30024-4629 ABSTRACT In addition to steady state performance, antennas

More information

PTX-0350 RF UPCONVERTER, MHz

PTX-0350 RF UPCONVERTER, MHz PTX-0350 RF UPCONVERTER, 300 5000 MHz OPERATING MODES I/Q upconverter RF = LO + IF upconverter RF = LO - IF upconverter Synthesizer 10 MHz REFERENCE INPUT/OUTPUT EXTERNAL LOCAL OSCILLATOR INPUT I/Q BASEBAND

More information

Design of FIR Filter for Efficient Utilization of Speech Signal Akanksha. Raj 1 Arshiyanaz. Khateeb 2 Fakrunnisa.Balaganur 3

Design of FIR Filter for Efficient Utilization of Speech Signal Akanksha. Raj 1 Arshiyanaz. Khateeb 2 Fakrunnisa.Balaganur 3 IJSRD - International Journal for Scientific Research & Development Vol. 3, Issue 03, 2015 ISSN (online): 2321-0613 Design of FIR Filter for Efficient Utilization of Speech Signal Akanksha. Raj 1 Arshiyanaz.

More information

Measurement Setup for Phase Noise Test at Frequencies above 50 GHz Application Note

Measurement Setup for Phase Noise Test at Frequencies above 50 GHz Application Note Measurement Setup for Phase Noise Test at Frequencies above 50 GHz Application Note Products: R&S FSWP With recent enhancements in semiconductor technology the microwave frequency range beyond 50 GHz becomes

More information

Low Power LFM Pulse Compression RADAR with Sidelobe suppression

Low Power LFM Pulse Compression RADAR with Sidelobe suppression Low Power LFM Pulse Compression RADAR with Sidelobe suppression M. Archana 1, M. Gnana priya 2 PG Student [DECS], Dept. of ECE, Gokula Krishna College of Engineering, Sullurpeta, Andhra Pradesh, India

More information

RECOMMENDATION ITU-R SM.1268*

RECOMMENDATION ITU-R SM.1268* Rec. ITU-R SM.1268 1 RECOMMENDATION ITU-R SM.1268* METHOD OF MEASURING THE MAXIMUM FREQUENCY DEVIATION OF FM BROADCAST EMISSIONS AT MONITORING STATIONS (Question ITU-R 67/1) Rec. ITU-R SM.1268 (1997) The

More information

EE 422G - Signals and Systems Laboratory

EE 422G - Signals and Systems Laboratory EE 422G - Signals and Systems Laboratory Lab 3 FIR Filters Written by Kevin D. Donohue Department of Electrical and Computer Engineering University of Kentucky Lexington, KY 40506 September 19, 2015 Objectives:

More information

Function - Analog Waveforms

Function - Analog Waveforms Chapter 5 The Ambiguity Function - Analog Waveforms 5.1. Introduction The radar ambiguity function represents the output of the matched filter, and it describes the interference caused by the range and/or

More information

Armstrong Atlantic State University Engineering Studies MATLAB Marina Sound Processing Primer

Armstrong Atlantic State University Engineering Studies MATLAB Marina Sound Processing Primer Armstrong Atlantic State University Engineering Studies MATLAB Marina Sound Processing Primer Prerequisites The Sound Processing Primer assumes knowledge of the MATLAB IDE, MATLAB help, arithmetic operations,

More information

Power Spectral Estimation With FFT (Numerical Recipes Section 13.4)

Power Spectral Estimation With FFT (Numerical Recipes Section 13.4) Power Spectral Estimation With FFT (Numerical Recipes Section 13.4) C. Kankelborg Rev. February 9, 2018 1 The Periodogram and Windowing Several methods have been developed for the estimation of power spectra

More information

Amplitude Modulation. Amplitude Modulation. Amplitude Modulation. Amplitude Modulation. A. Introduction. A. Introduction

Amplitude Modulation. Amplitude Modulation. Amplitude Modulation. Amplitude Modulation. A. Introduction. A. Introduction 1. In AM modulation we impart the information of a message signal m(t) on to a sinusoidal carrier c(t). This results in the translation of the message signal to a new frequency range. The motivation for

More information

University of Huddersfield Repository

University of Huddersfield Repository University of Huddersfield Repository Ball, Andrew, Wang, Tian T., Tian, X. and Gu, Fengshou A robust detector for rolling element bearing condition monitoring based on the modulation signal bispectrum,

More information

George Mason University Signals and Systems I Spring 2016

George Mason University Signals and Systems I Spring 2016 George Mason University Signals and Systems I Spring 2016 Laboratory Project #4 Assigned: Week of March 14, 2016 Due Date: Laboratory Section, Week of April 4, 2016 Report Format and Guidelines for Laboratory

More information

Electrical & Computer Engineering Technology

Electrical & Computer Engineering Technology Electrical & Computer Engineering Technology EET 419C Digital Signal Processing Laboratory Experiments by Masood Ejaz Experiment # 1 Quantization of Analog Signals and Calculation of Quantized noise Objective:

More information

MSK has three important properties. However, the PSD of the MSK only drops by 10log 10 9 = 9.54 db below its midband value at ft b = 0.

MSK has three important properties. However, the PSD of the MSK only drops by 10log 10 9 = 9.54 db below its midband value at ft b = 0. Gaussian MSK MSK has three important properties Constant envelope (why?) Relatively narrow bandwidth Coherent detection performance equivalent to that of QPSK However, the PSD of the MSK only drops by

More information

EC310 Security Exercise 20

EC310 Security Exercise 20 EC310 Security Exercise 20 Introduction to Sinusoidal Signals This lab demonstrates a sinusoidal signal as described in class. In this lab you will identify the different waveform parameters for a pure

More information

Principles of Communications ECS 332

Principles of Communications ECS 332 Principles of Communications ECS 332 Asst. Prof. Dr. Prapun Suksompong prapun@siit.tu.ac.th 5. Angle Modulation Office Hours: BKD, 6th floor of Sirindhralai building Wednesday 4:3-5:3 Friday 4:3-5:3 Example

More information

Narrow- and wideband channels

Narrow- and wideband channels RADIO SYSTEMS ETIN15 Lecture no: 3 Narrow- and wideband channels Ove Edfors, Department of Electrical and Information technology Ove.Edfors@eit.lth.se 27 March 2017 1 Contents Short review NARROW-BAND

More information

Estimation of Predetection SNR of LMR Analog FM Signals Using PL Tone Analysis

Estimation of Predetection SNR of LMR Analog FM Signals Using PL Tone Analysis Estimation of Predetection SNR of LMR Analog FM Signals Using PL Tone Analysis Akshay Kumar akshay2@vt.edu Steven Ellingson ellingson@vt.edu Virginia Tech, Wireless@VT May 2, 2012 Table of Contents 1 Introduction

More information

EE4512 Analog and Digital Communications Chapter 6. Chapter 6 Analog Modulation and Demodulation

EE4512 Analog and Digital Communications Chapter 6. Chapter 6 Analog Modulation and Demodulation Chapter 6 Analog Modulation and Demodulation Chapter 6 Analog Modulation and Demodulation Amplitude Modulation Pages 306-309 309 The analytical signal for double sideband, large carrier amplitude modulation

More information

BME 3512 Bioelectronics Laboratory Two - Passive Filters

BME 3512 Bioelectronics Laboratory Two - Passive Filters BME 35 Bioelectronics Laboratory Two - Passive Filters Learning Objectives: Understand the basic principles of passive filters. Laboratory Equipment: Agilent Oscilloscope Model 546A Agilent Function Generator

More information

1. In the command window, type "help conv" and press [enter]. Read the information displayed.

1. In the command window, type help conv and press [enter]. Read the information displayed. ECE 317 Experiment 0 The purpose of this experiment is to understand how to represent signals in MATLAB, perform the convolution of signals, and study some simple LTI systems. Please answer all questions

More information

Jitter Measurements using Phase Noise Techniques

Jitter Measurements using Phase Noise Techniques Jitter Measurements using Phase Noise Techniques Agenda Jitter Review Time-Domain and Frequency-Domain Jitter Measurements Phase Noise Concept and Measurement Techniques Deriving Random and Deterministic

More information

ECE 4600 Communication Systems

ECE 4600 Communication Systems ECE 4600 Communication Systems Dr. Bradley J. Bazuin Associate Professor Department of Electrical and Computer Engineering College of Engineering and Applied Sciences Course Topics Course Introduction

More information

Reduction in sidelobe and SNR improves by using Digital Pulse Compression Technique

Reduction in sidelobe and SNR improves by using Digital Pulse Compression Technique Reduction in sidelobe and SNR improves by using Digital Pulse Compression Technique Devesh Tiwari 1, Dr. Sarita Singh Bhadauria 2 Department of Electronics Engineering, Madhav Institute of Technology and

More information