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

Size: px
Start display at page:

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

Transcription

1 Homework 6 April, 6 Problem Steady state of LTI systems The transfer function of an LTI system is H(s) = Y (s) X(s) = s s + 3s + If the input to this system is x(t) = + cos(t + π/4), < t <, what is the output y(t) in the steady state. Solution According to the eigenfunction property of LTI,the steady state response corresponding to the given x(t) = + cos(t + π/4) = cos(t) + cos(t + π/4) is Since y(t) = H(j) cos(t + H(j)) + H(j) cos(t + π/4 + H(j)) H(j) = H(s) s=j = ej H(j) = H(s) s=j = j + 3j = + j 5 = = Hence, y(t) = cos(t ) Problem Fourier series of sampling delta The periodic signal δ Ts (t) = m= δ(t mt s ) will be very useful in the sampling of continuous-time signal.

2 (a) Find the Fourier series of the signal-that is δ Ts (t) = k e jkωst k= find the Fourier coefficients k. (b) Plot the magnitude line spectrum of this signal. (c) Plot δ Ts (t) and its corresponding line spectrum k as functions of time and frequency. Are they both periodic? How are their periods related? Explain. Solution (a)a period of δ Ts (t) is δ(t ) for T s / t + T s /.The Fourier series coefficients of δ Ts (t) of period T s are given by Thus, k = T s L[δ(t )] s=jωsk = T s e jkωs δ Ts = k= T s e jkωs(t ) (b) The magnitude line spectrum of δ Ts (t) is a periodic signal of fundamental frequency Ω s = π/t s and magnitude /T s. (c) The magnitude of k and signal δ Ts (t) is periodic with T s and Ω s = π/t s. The angle of k is k = kω s,which is an odd function. Problem 3 Manipulation of periodic signals Let the following be the Fourier series of a periodic signal x(t) of period T (fundamental frequency Ω = π/t ): x(t) = X k e jω kt k= Consider the following functions of x(t), and determine if they are periodic and what are their periods if so: () y(t) = x(t) + 3 () z(t) = x(t ) + x(t) (3) w(t) = x(t ) Express the Fourier series coefficients Y k, Z k and W k in terms of X k. Solution 3 (a) If the periodic signal is x(t) = k X ke jω kt,then y(t) = x(t) + 3 = (X + 3) + k X k e jω kt

3 is also periodic of period T with Fourier coefficients { X + 3 k = Y k = X k k (b) The signal is z(t) = x(t ) + x(t) = k X k e jω k(t ) + k X k e jω kt = k [X k ( + e jω k )]e jω kt is periodic of period T and with Fourier series coefficients (c) The signal Z k = X k ( + e jω k ) w(t) = x(t ) = k = m even X k e jω k(t ) X m/ e jω mt e jω m/ is periodic of period T /,with Fourier series coefficients { Xk/ e W k = jω k/ k even otherwise problem 4:Windowing and music soundsmatlab In the computer generation of musical sounds,pure tones need to be windowed to make them more interesting.windowing mimics the way a musician would approach the generation of a certain sound.increasing the richness of the harmonic frequencies is the result of the windowing,as we will see in this problem.consider the generation of a musical note with frequencies around f A = 88Hz.Assume our musician while playing this note uses three strokes corresponding to a window w (t) = r(t) r(t T ) r(t T ) + r(t T ),so that the resulting sound would be the multiplication,or windowing,of a pure sinusoid cos(πf A t) by a periodic signal w(t),with w (t) a period that repeats every T = 5T where T is the period of the sinusoid.let T = T /4 and T = T /4. (a) Analytically determine the Fourier series of the window w(t) and plot its line spectrum using MATLAB.Indicate how you would choose the number of harmonics needed to obtain a good approximation to w(t) (b) Use the modulation or the convolution properties of the Fourier series to obtain the coefcients of the product s(t) = cos(πf A t)w(t).use Matlab to plot the line spectrum of this periodic signal and again determine how many harmonic frequencies you would need to obtain a good approximation to s(t). (c) The line spectrum of the pure tone p(t) = cos(πf A t) only displays one harmonic,the one

4 corresponding to the f A = 88Hz frequency.how many more harmonics does s(t) have?to listen to the richness in harmonics use the MATLAB function sound to play the sinusoid p(t) and s(t)(use F s = 88Hz to play both). (d) Consider a combination of notes in a certain scale; for instance, let p(t) = sin(π 44t) + sin(π 55t) + sin(π 66t) Use the same windowing w(t),and let s(t) = p(t)w(t).use MATLAB to plot p(t) and s(t) and to compute and plot their corresponding line spectra.use sound to play p(nt s ) and s(nt s ) using F s =. Solution 4:if T = T /4 (a) Since window w(t) is a periodic function with period T = 5T,where T = /f A = /88 sec., and T = T /4,T = T /, w == r(t) r(t T ) r(t T ) + r(t T ),then the Fourier series of the window w(t) is W k = T W (s) s=jkω = s ( e st /4 e st / + e st ) s=jkω = ( cos(kπ/) cos(kπ) + j sin(kπ/)) Ω k Ω = π = 354πrad/sec T (b) The signal s(t) = cos(πf A t)w(t),by the convolution properties of the Fourier series,the s(t) is obtained by shifting the harmonics of w(t) to a central frequency πf A c l e a r a l l ; c l o s e a l l ; c l c ; c l e a r a l l ; c l c ; 3 Fs =88; T=/Fs ; 5 T=5 T; T=T/4;T=T/; Ts=/76; % o v e r a l l sample p eriod 7 t =:Ts : T Ts ; Nn=l e n g t h ( t ) ; x=[ t ( : c e i l (Nn/4) ) t ( c e i l (Nn/4) +) ones (, c e i l (Nn/4) ) ] ; 9 x=x ( c e i l (Nn/4) +) ones (, c e i l (Nn/4) ) t ( : c e i l (Nn/4) ) ; wind=[x x ] ; f i g u r e ( ) ; 3 p l o t ( t, wind ) ; g r i d on ; t i t l e ( wind ( t ) ) ; x l a b e l ( t ) ; y l a b e l ( magnitude ) ; 5 %a syms t 7 N=; x=t h e a v i s i d e ( t ) (t T/4) h e a v i s i d e ( t T/4)... 9 (t T/) h e a v i s i d e ( t T/)+... ( t T) h e a v i s i d e ( t T) ; [ X, w]= f o u r i e r s e r i e s ( x, T,N) ; f i g u r e ( ) 3 subplot (,, ) ;

5 w= f l i p l r (w) ; 5 w=[w w ] ; stem (w, [ f l i p l r ( abs (X) ) abs (X) ] ) ;%t i t l e ( Magnitude l i n e spectrum ) ; 7 t i t l e ( The l i n e spectrum o f w( t ) a ) ; subplot (,, ) ; 9 stem (w,[ f l i p l r ( angle (X) ) angle (X) ] ) ;%t i t l e ( Phase l i n e spectrum ) ; 3 %b s=cos ( pi Fs t ) x ; 33 [ X, w]= f o u r i e r s e r i e s ( s, T,N) ; f i g u r e ( 3 ) 35 subplot (,, ) ; w= f l i p l r (w) ; 37 w=[w w ] ; stem (w, [ f l i p l r ( abs (X) ) abs (X) ] ) ;%t i t l e ( Magnitude l i n e spectrum ) ; 39 t i t l e ( The l i n e spectrum o f s ( t ) b ) ; subplot (,, ) ; 4 stem (w,[ f l i p l r ( angle (X) ) angle (X) ] ) ;%t i t l e ( Phase l i n e spectrum ) ; 43 %c p=cos ( pi Fs t ) ; 45 [ X, w]= f o u r i e r s e r i e s (p, T,N) ; f i g u r e ( 4 ) 47 subplot (,, ) ; w= f l i p l r (w) ; 49 w=[w w ] ; stem (w, [ f l i p l r ( abs (X) ) abs (X) ] ) ;%t i t l e ( Magnitude l i n e spectrum ) ; 5 t i t l e ( The l i n e spectrum o f p ( t ) c ) ; subplot (,, ) ; 53 stem (w,[ f l i p l r ( angle (X) ) angle (X) ] ) ;%t i t l e ( Phase l i n e spectrum ) ; 55 t =:Ts : T Ts ; p s=cos ( pi Fs. t ) ; 57 sound ( p s ) ; pause ( ) ; s s=cos ( pi Fs. t. wind ) ; 59 sound ( s s ) ; 6 %d Fs =; 63 p=s i n ( pi 44 t )+s i n ( pi 55 t )+s i n ( pi 66 t ) ; s=p x ; 65 T p=/; f i g u r e ( 5 ) ; 67 subplot (,, ) ; e z p l o t (p, [ T p ] ) ; t i t l e ( p ( t ) ) ; 69 subplot (,, ) ; e z p l o t ( s, [ T ] ) ; t i t l e ( s ( t ) ) ; 7 t i t l e ( the f i g u r e o f p ( t ) and s ( t ) ) ; [ X, w]= f o u r i e r s e r i e s (p, T p,n) ; 73 f i g u r e ( 6 ) ; 75 subplot (,, ) ; w= f l i p l r (w) ; 77 w=[w w ] ; stem (w, [ f l i p l r ( abs (X) ) abs (X) ] ) ;%t i t l e ( Magnitude l i n e spectrum ) ; 79 t i t l e ( The l i n e spectrum o f p ( t ) d ) ;

6 subplot (,, ) ; 8 stem (w,[ f l i p l r ( angle (X) ) angle (X) ] ) ;%t i t l e ( Phase l i n e spectrum ) ; [ X, w]= f o u r i e r s e r i e s ( s, T,N) ; 87 f i g u r e ( 7 ) ; subplot (,, ) ; 89 w= f l i p l r (w) ; w=[w w ] ; 9 stem (w, [ f l i p l r ( abs (X) ) abs (X) ] ) ;%t i t l e ( Magnitude l i n e spectrum ) ; t i t l e ( The l i n e spectrum o f s ( t ) d ) ; 93 subplot (,, ) ; stem (w,[ f l i p l r ( angle (X) ) angle (X) ] ) ;%t i t l e ( Phase l i n e spectrum ) ; Prob 44.m

7

8

9 Solution 4:if T =3 T /4 (a) The fundamental period of the sinusoid is T = /88 so that T = 5T = 5/88 sec., T = T /4 and T = 3T /4. The Fourier series coefficients of ω(t) are W k = T W (s) s=jkω = s ( e st/4 e s3t/4 + e st ) s=jkω = e st/ s (e st/ e st/4 e st/4 + e st/ ) s=jkω = e jkπ Ω (cos(πk) cos(πk/)) Ω k = π T = 35π rad/sec (b) The signal s(t) = w(t) cos(πf A t) shifts the harmonics of w(t) to a central frequency πf A. The number of harmonic frequencies is increased by windowing the sinusoid or sum of sinusoids. %Problem 4.4 clear all;clc; % parameters Fs = 88; T = /Fs; %frequency %sample period T = 5*T; T = T/4; T = T*3/4; % a) % define one period of w signal -> w Ts=/76; t=:ts:t-ts; Nn=length(t); % overall sample period x=[t(:ceil(nn/4)) t(ceil(nn/4)+)*ones(,ceil(nn/4))]; x=fliplr(x); w=[x x]; N=length(w); % plot line spectrum figure() FSeries(w,Ts,T,N); %number of samples in w % harmonics H to approximate w? w=*pi/t; DC=.65; H=3; for k=:h, a(k)=*(cos(k*w*t/4)-cos(k*w*t/))/t/kˆ/wˆ; a=[dc *a]; figure() for N=:H+, x=a()*ones(,length(t)); for k=:n, x=x+a(k)*cos((k-)*w.*(t+t/)); plot(t,x); axis([ max(t).*min(x).*max(x)]);

10 hold on; plot(t,w, r ) ylabel( Amplitude );xlabel( t (sec) ); leg( aprox w(t), w(t) );grid; hold off pause(.); clear x; clear H a x % b) s = cos(*pi*fs*t).*w; %modulated signal s figure(3); FSeries(s,Ts,T,N); % line spectrum of s % how many harmonics H are necessary to approximate s? w=*pi/t; DC=.65;H=3; for k=:h, a(k)=*(cos(k*w*t/4)-cos(k*w*t/))/t/kˆ/wˆ; a=[dc *a]; figure(4) for N=:H+, x=a()*ones(,length(t)); for k=:n, x=x+a(k)*cos((k-)*w.*(t+t/)); x=x.*cos(5*w.*t); plot(t,x); axis([ max(t).*min(s).*max(s)]); hold on; plot(t,s, r ) ylabel( Amplitude ); xlabel( t (sec) ); leg( aprox s(t), s(t) ); grid; hold off pause(.); clear x; % c) p = cos(*pi*fs*t); %signal p figure(5); FSeries(p,Ts,T,N); %line spectrum of p %sound(p); pause(); sound(w*s);pause(); % d) p = sin(*pi*44*t)+sin(*pi*55*t)+sin(*pi*66*t); %signal p s = p.*w; %modulated signal s

11 figure(6); FSeries(s,Ts,T,N); %line spectrum of s % sound(*p); pause(); sound(*w*s); x 3 Periodic signal x 4 x 3 Periodic signal.5 4 aprox w(t) w(t) x(t).5 x(t) t (sec) x 3 Magnitude Line Spectrum x 3 Phase Line Spectrum Amplitude t (sec) x 4 Magnitude Line Spectrum 5 x 4 Phase Line Spectrum X k <X k X k <X k w (rad/sec) x 4 w (rad/sec) x 4 t (sec) x 3 w (rad/sec) x 4 w (rad/sec) x 4 Figure : Right to left: window and line spectra, approximation of window, windowed sinusoid and its line spectra..5 x 3 aprox s(t) Periodic signal x 3 Periodic signal s(t) x(t) x(t).5 4 Amplitude t (sec).5.4 Magnitude Line Spectrum 5 x 6 Phase Line Spectrum t (sec) x 4 Magnitude Line Spectrum.5 x 3 Phase Line Spectrum X k.3. <X k X k 3 <X k t (sec) x 3 w (rad/sec) x 4 w (rad/sec) x 4 w (rad/sec) x 4 w (rad/sec) x 4 Figure : Right to left: approximation of windowed signal, line spectra of sinusoid, windowed sum of sinusoids and line spectra.

12 problem 5:Compution of π MATLAB As you know,π is an irrational number that can only be approximated by a number with a finite number of decimals.how to compute this value recursively is a problem of theoretical interest.in this problem we show that the Fourier series can provide that formulation. (a) Consider a train of rectangular pulses x(t),with a period x (t) = [u(t +.5) u(t.5)].5 t.5 and period T =.Plot the periodic signal and nd its trigonometric Fourier series. (b) Use the above Fourier series to nd an innite sum for π. (c) If π N is an approximation of the innite sum with N coefficients,and π is the value given by MATLAB,find the value of N so that π N is 95% of the value of π given by MATLAB.

13 Solution 5 π) so that (a) The signal x(t) is zero-mean. The Fourier series coefficients are obtained from (Ω = π/t = ˆX (s) = s (e.5s e.5s ) s=jkπ = sin(πk/) πk/ x(t) = = k=, k= sin(πk/) e jkπt πk/ sin(πk/) πk/ cos(πkt) Since x() =, letting t = in both sides and then multiplying by π we get that If we let we use MATLAB to find the value of N. % Problem 4.5 clear all; clc N=; x = ; for k=:n %DC value x = x + 4*sin(k*pi/)/k; xx(k) =x; format long π = 4 π N = 4 k= N k= display( Error of approximation for ) N e = pi-x ppi=pi*ones(,length(xx)); n=:n; figure() sin(πk/) k sin(πk/) k =.95π subplot(); plot(n,xx); title( Approximation of PI ); axis([ N 4.5]) hold on; plot(n,ppi, r ); grid; hold off; leg( approximate, pi ) subplot(); plot(n,xx-pi); title( Error of approximation ); grid % N for 95 percent of pi sum = ; for i = :N, %initial approximation sum = sum + 4*cos(i*pi/-pi/)/i; if (sum >=(.95*pi))&&(sum<=pi) break; display([numstr(i) coeficients needed of Fourier series for 95% approx. of PI ])

14 Error of approximation for N = e = coeficients needed of Fourier series for 95\% approx. of PI 4 3 Approximation of PI n Error of approximation approximate pi n Figure 4: Approximation of π by series, error of approximation

15 problem 5:Compution of π MATLAB As you know,π is an irrational number that can only be approximated by a number with a finite number of decimals.how to compute this value recursively is a problem of theoretical interest.in this problem we show that the Fourier series can provide that formulation. (a) Consider a train of rectangular pulses x(t),with a period x (t) = [u(t +.5) u(t.5)].5 t.5 and period T =.Plot the periodic signal and nd its trigonometric Fourier series. (b) Use the above Fourier series to nd an innite sum for π. (c) If π N is an approximation of the innite sum with N coefficients,and π is the value given by MATLAB,find the value of N so that π N is 95% of the value of π given by MATLAB.

16 Solution 5 π) so that (a) The signal x(t) is zero-mean. The Fourier series coefficients are obtained from (Ω = π/t = ˆX (s) = s (e.5s e.5s ) s=jkπ = sin(πk/) πk/ x(t) = = k=, k= sin(πk/) e jkπt πk/ sin(πk/) πk/ cos(πkt) Since x() =, letting t = in both sides and then multiplying by π we get that If we let we use MATLAB to find the value of N. % Problem 4.5 clear all; clc N=; x = ; for k=:n %DC value x = x + 4*sin(k*pi/)/k; xx(k) =x; format long π = 4 π N = 4 k= N k= display( Error of approximation for ) N e = pi-x ppi=pi*ones(,length(xx)); n=:n; figure() sin(πk/) k sin(πk/) k =.95π subplot(); plot(n,xx); title( Approximation of PI ); axis([ N 4.5]) hold on; plot(n,ppi, r ); grid; hold off; leg( approximate, pi ) subplot(); plot(n,xx-pi); title( Error of approximation ); grid % N for 95 percent of pi sum = ; for i = :N, %initial approximation sum = sum + 4*cos(i*pi/-pi/)/i; if (sum >=(.95*pi))&&(sum<=pi) break; display([numstr(i) coeficients needed of Fourier series for 95% approx. of PI ])

17 Error of approximation for N = e = coeficients needed of Fourier series for 95\% approx. of PI 4 3 Approximation of PI n Error of approximation approximate pi n Figure 4: Approximation of π by series, error of approximation

ECE 301 Fall 2011 Division 1 Homework 10 Solutions. { 1, for 0.5 t 0.5 x(t) = 0, for 0.5 < t 1

ECE 301 Fall 2011 Division 1 Homework 10 Solutions. { 1, for 0.5 t 0.5 x(t) = 0, for 0.5 < t 1 ECE 3 Fall Division Homework Solutions Problem. Reconstruction of a continuous-time signal from its samples. Let x be a periodic continuous-time signal with period, such that {, for.5 t.5 x(t) =, for.5

More information

Frequency Analysis: The Fourier

Frequency Analysis: The Fourier CHAPTER 4 Frequency Analysis: The Fourier Series A Mathematician is a device for turning coffee into theorems. Paul Erdos (93 996) mathematician 4. INTRODUCTION In this chapter and the next we consider

More information

Fourier series for continuous and discrete time signals

Fourier series for continuous and discrete time signals 8-9 Signals and Systems Fall 5 Fourier series for continuous and discrete time signals The road to Fourier : Two weeks ago you saw that if we give a complex exponential as an input to a system, the output

More information

Signals & Systems. Lecture 5 Continuous-Time Fourier Transform. Alp Ertürk

Signals & Systems. Lecture 5 Continuous-Time Fourier Transform. Alp Ertürk Signals & Systems Lecture 5 Continuous-Time Fourier Transform Alp Ertürk alp.erturk@kocaeli.edu.tr Fourier Series Representation of Continuous-Time Periodic Signals Synthesis equation: x t = a k e jkω

More information

Line Spectra and their Applications

Line Spectra and their Applications In [ ]: cd matlab pwd Line Spectra and their Applications Scope and Background Reading This session concludes our introduction to Fourier Series. Last time (http://nbviewer.jupyter.org/github/cpjobling/eg-47-

More information

Signals & Systems. Lecture 4 Fourier Series Properties & Discrete-Time Fourier Series. Alp Ertürk

Signals & Systems. Lecture 4 Fourier Series Properties & Discrete-Time Fourier Series. Alp Ertürk Signals & Systems Lecture 4 Fourier Series Properties & Discrete-Time Fourier Series Alp Ertürk alp.erturk@kocaeli.edu.tr Fourier Series Representation of Continuous-Time Periodic Signals Synthesis equation:

More information

Chapter 5 Frequency Domain Analysis of Systems

Chapter 5 Frequency Domain Analysis of Systems Chapter 5 Frequency Domain Analysis of Systems CT, LTI Systems Consider the following CT LTI system: xt () ht () yt () Assumption: the impulse response h(t) is absolutely integrable, i.e., ht ( ) dt< (this

More information

Chapter 6: Applications of Fourier Representation Houshou Chen

Chapter 6: Applications of Fourier Representation Houshou Chen Chapter 6: Applications of Fourier Representation Houshou Chen Dept. of Electrical Engineering, National Chung Hsing University E-mail: houshou@ee.nchu.edu.tw H.S. Chen Chapter6: Applications of Fourier

More information

(i) Represent continuous-time periodic signals using Fourier series

(i) Represent continuous-time periodic signals using Fourier series Fourier Series Chapter Intended Learning Outcomes: (i) Represent continuous-time periodic signals using Fourier series (ii) (iii) Understand the properties of Fourier series Understand the relationship

More information

Chapter 4 The Fourier Series and Fourier Transform

Chapter 4 The Fourier Series and Fourier Transform Chapter 4 The Fourier Series and Fourier Transform Fourier Series Representation of Periodic Signals Let x(t) be a CT periodic signal with period T, i.e., xt ( + T) = xt ( ), t R Example: the rectangular

More information

Chapter 5 Frequency Domain Analysis of Systems

Chapter 5 Frequency Domain Analysis of Systems Chapter 5 Frequency Domain Analysis of Systems CT, LTI Systems Consider the following CT LTI system: xt () ht () yt () Assumption: the impulse response h(t) is absolutely integrable, i.e., ht ( ) dt< (this

More information

Chapter 4 The Fourier Series and Fourier Transform

Chapter 4 The Fourier Series and Fourier Transform Chapter 4 The Fourier Series and Fourier Transform Representation of Signals in Terms of Frequency Components Consider the CT signal defined by N xt () = Acos( ω t+ θ ), t k = 1 k k k The frequencies `present

More information

Homework 3 Solutions

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

More information

Representing a Signal

Representing a Signal The Fourier Series Representing a Signal The convolution method for finding the response of a system to an excitation takes advantage of the linearity and timeinvariance of the system and represents the

More information

Fourier series: Additional notes

Fourier series: Additional notes Fourier series: Additional notes Linking Fourier series representations for signals Rectangular waveform Require FS expansion of signal y(t) below: 1 y(t) 1 4 4 8 12 t (seconds) Period T = 8, so ω = 2π/T

More information

E2.5 Signals & Linear Systems. Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & 2)

E2.5 Signals & Linear Systems. Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & 2) E.5 Signals & Linear Systems Tutorial Sheet 1 Introduction to Signals & Systems (Lectures 1 & ) 1. Sketch each of the following continuous-time signals, specify if the signal is periodic/non-periodic,

More information

ECE 301 Fall 2010 Division 2 Homework 10 Solutions. { 1, if 2n t < 2n + 1, for any integer n, x(t) = 0, if 2n 1 t < 2n, for any integer n.

ECE 301 Fall 2010 Division 2 Homework 10 Solutions. { 1, if 2n t < 2n + 1, for any integer n, x(t) = 0, if 2n 1 t < 2n, for any integer n. ECE 3 Fall Division Homework Solutions Problem. Reconstruction of a continuous-time signal from its samples. Consider the following periodic signal, depicted below: {, if n t < n +, for any integer n,

More information

EE 3054: Signals, Systems, and Transforms Summer It is observed of some continuous-time LTI system that the input signal.

EE 3054: Signals, Systems, and Transforms Summer It is observed of some continuous-time LTI system that the input signal. EE 34: Signals, Systems, and Transforms Summer 7 Test No notes, closed book. Show your work. Simplify your answers. 3. It is observed of some continuous-time LTI system that the input signal = 3 u(t) produces

More information

QUIZ #2 SOLUTION Version A

QUIZ #2 SOLUTION Version A GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL & COMPUTER ENGINEERING QUIZ #2 SOLUTION Version A DATE: 7-MAR-16 SOLUTION Version A COURSE: ECE 226A,B NAME: STUDENT #: LAST, FIRST 2 points 2 points

More information

Problem Value

Problem Value GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL & COMPUTER ENGINEERING FINAL EXAM DATE: 30-Apr-04 COURSE: ECE-2025 NAME: GT #: LAST, FIRST Recitation Section: Circle the date & time when your Recitation

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

Fourier Representations of Signals & LTI Systems

Fourier Representations of Signals & LTI Systems 3. Introduction. A signal can be represented as a weighted superposition of complex sinusoids. x(t) or x[n] 2. LTI system: LTI System Output = A weighted superposition of the system response to each complex

More information

Homework 4. May An LTI system has an input, x(t) and output y(t) related through the equation y(t) = t e (t t ) x(t 2)dt

Homework 4. May An LTI system has an input, x(t) and output y(t) related through the equation y(t) = t e (t t ) x(t 2)dt Homework 4 May 2017 1. An LTI system has an input, x(t) and output y(t) related through the equation y(t) = t e (t t ) x(t 2)dt Determine the impulse response of the system. Rewriting as y(t) = t e (t

More information

2 Background: Fourier Series Analysis and Synthesis

2 Background: Fourier Series Analysis and Synthesis Signal Processing First Lab 15: Fourier Series Pre-Lab and Warm-Up: You should read at least the Pre-Lab and Warm-up sections of this lab assignment and go over all exercises in the Pre-Lab section before

More information

Math 345: Applied Mathematics

Math 345: Applied Mathematics Math 345: Applied Mathematics Introduction to Fourier Series, I Tones, Harmonics, and Fourier s Theorem Marcus Pendergrass Hampden-Sydney College Fall 2012 1 Sounds as waveforms I ve got a bad feeling

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

CE 513: STATISTICAL METHODS

CE 513: STATISTICAL METHODS 28-8-217/CE 68 CE 513: STATISTICAL METHODS IN CIVIL ENGINEERING Lecture: Introduction to Fourier transforms Dr. Budhaditya Hazra Room: N-37 Department of Civil Engineering 1 Fourier Analysis Fourier Series

More information

6.003 Homework #10 Solutions

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

More information

ECE 3084 QUIZ 2 SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING GEORGIA INSTITUTE OF TECHNOLOGY APRIL 2, Name:

ECE 3084 QUIZ 2 SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING GEORGIA INSTITUTE OF TECHNOLOGY APRIL 2, Name: ECE 3084 QUIZ 2 SCHOOL OF ELECTRICAL AND COMPUTER ENGINEERING GEORGIA INSTITUTE OF TECHNOLOGY APRIL 2, 205 Name:. The quiz is closed book, except for one 2-sided sheet of handwritten notes. 2. Turn off

More information

Problem Value

Problem Value GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL & COMPUTER ENGINEERING FINAL EXAM DATE: 2-May-05 COURSE: ECE-2025 NAME: GT #: LAST, FIRST (ex: gtz123a) Recitation Section: Circle the date & time when

More information

I. Signals & Sinusoids

I. Signals & Sinusoids I. Signals & Sinusoids [p. 3] Signal definition Sinusoidal signal Plotting a sinusoid [p. 12] Signal operations Time shifting Time scaling Time reversal Combining time shifting & scaling [p. 17] Trigonometric

More information

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

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

More information

Fourier transform representation of CT aperiodic signals Section 4.1

Fourier transform representation of CT aperiodic signals Section 4.1 Fourier transform representation of CT aperiodic signals Section 4. A large class of aperiodic CT signals can be represented by the CT Fourier transform (CTFT). The (CT) Fourier transform (or spectrum)

More information

Final Exam of ECE301, Section 3 (CRN ) 8 10am, Wednesday, December 13, 2017, Hiler Thtr.

Final Exam of ECE301, Section 3 (CRN ) 8 10am, Wednesday, December 13, 2017, Hiler Thtr. Final Exam of ECE301, Section 3 (CRN 17101-003) 8 10am, Wednesday, December 13, 2017, Hiler Thtr. 1. Please make sure that it is your name printed on the exam booklet. Enter your student ID number, and

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

2A1H Time-Frequency Analysis II

2A1H Time-Frequency Analysis II 2AH Time-Frequency Analysis II Bugs/queries to david.murray@eng.ox.ac.uk HT 209 For any corrections see the course page DW Murray at www.robots.ox.ac.uk/ dwm/courses/2tf. (a) A signal g(t) with period

More information

3.2 Complex Sinusoids and Frequency Response of LTI Systems

3.2 Complex Sinusoids and Frequency Response of LTI Systems 3. Introduction. A signal can be represented as a weighted superposition of complex sinusoids. x(t) or x[n]. LTI system: LTI System Output = A weighted superposition of the system response to each complex

More information

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

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

More information

Discrete-Time Fourier Transform

Discrete-Time Fourier Transform Discrete-Time Fourier Transform Chapter Intended Learning Outcomes: (i) (ii) (iii) Represent discrete-time signals using discrete-time Fourier transform Understand the properties of discrete-time Fourier

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

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

Problem Value

Problem Value GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL & COMPUTER ENGINEERING FINAL EXAM DATE: 30-Apr-04 COURSE: ECE-2025 NAME: GT #: LAST, FIRST Recitation Section: Circle the date & time when your Recitation

More information

Solutions to Problems in Chapter 4

Solutions to Problems in Chapter 4 Solutions to Problems in Chapter 4 Problems with Solutions Problem 4. Fourier Series of the Output Voltage of an Ideal Full-Wave Diode Bridge Rectifier he nonlinear circuit in Figure 4. is a full-wave

More information

Aspects of Continuous- and Discrete-Time Signals and Systems

Aspects of Continuous- and Discrete-Time Signals and Systems Aspects of Continuous- and Discrete-Time Signals and Systems C.S. Ramalingam Department of Electrical Engineering IIT Madras C.S. Ramalingam (EE Dept., IIT Madras) Networks and Systems 1 / 45 Scaling the

More information

Final Exam January 31, Solutions

Final Exam January 31, Solutions Final Exam January 31, 014 Signals & Systems (151-0575-01) Prof. R. D Andrea & P. Reist Solutions Exam Duration: Number of Problems: Total Points: Permitted aids: Important: 150 minutes 7 problems 50 points

More information

J. McNames Portland State University ECE 223 Sampling Ver

J. McNames Portland State University ECE 223 Sampling Ver Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

Assignment 2 Solutions Fourier Series

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

More information

GATE EE Topic wise Questions SIGNALS & SYSTEMS

GATE EE Topic wise Questions SIGNALS & SYSTEMS www.gatehelp.com GATE EE Topic wise Questions YEAR 010 ONE MARK Question. 1 For the system /( s + 1), the approximate time taken for a step response to reach 98% of the final value is (A) 1 s (B) s (C)

More information

Review of Analog Signal Analysis

Review of Analog Signal Analysis Review of Analog Signal Analysis Chapter Intended Learning Outcomes: (i) Review of Fourier series which is used to analyze continuous-time periodic signals (ii) Review of Fourier transform which is used

More information

LTI Systems (Continuous & Discrete) - Basics

LTI Systems (Continuous & Discrete) - Basics LTI Systems (Continuous & Discrete) - Basics 1. A system with an input x(t) and output y(t) is described by the relation: y(t) = t. x(t). This system is (a) linear and time-invariant (b) linear and time-varying

More information

Modeling Buck Converter by Using Fourier Analysis

Modeling Buck Converter by Using Fourier Analysis PIERS ONLINE, VOL. 6, NO. 8, 2010 705 Modeling Buck Converter by Using Fourier Analysis Mao Zhang 1, Weiping Zhang 2, and Zheng Zhang 2 1 School of Computing, Engineering and Physical Sciences, University

More information

Fourier Transform. Find the Fourier series for a periodic waveform Determine the output of a filter when the input is a periodic function

Fourier Transform. Find the Fourier series for a periodic waveform Determine the output of a filter when the input is a periodic function Objectives: Be able to Fourier Transform Find the Fourier series for a periodic waveform Determine the output of a filter when the input is a periodic function Filters with a Single Sinusoidal Input: Suppose

More information

Overview of Sampling Topics

Overview of Sampling Topics Overview of Sampling Topics (Shannon) sampling theorem Impulse-train sampling Interpolation (continuous-time signal reconstruction) Aliasing Relationship of CTFT to DTFT DT processing of CT signals DT

More information

V. IIR Digital Filters

V. IIR Digital Filters Digital Signal Processing 5 March 5, V. IIR Digital Filters (Deleted in 7 Syllabus). (dded in 7 Syllabus). 7 Syllabus: nalog filter approximations Butterworth and Chebyshev, Design of IIR digital filters

More information

LECTURE 12 Sections Introduction to the Fourier series of periodic signals

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

More information

FROM ANALOGUE TO DIGITAL

FROM ANALOGUE TO DIGITAL SIGNALS AND SYSTEMS: PAPER 3C1 HANDOUT 7. Dr David Corrigan 1. Electronic and Electrical Engineering Dept. corrigad@tcd.ie www.mee.tcd.ie/ corrigad FROM ANALOGUE TO DIGITAL To digitize signals it is necessary

More information

EE 224 Signals and Systems I Review 1/10

EE 224 Signals and Systems I Review 1/10 EE 224 Signals and Systems I Review 1/10 Class Contents Signals and Systems Continuous-Time and Discrete-Time Time-Domain and Frequency Domain (all these dimensions are tightly coupled) SIGNALS SYSTEMS

More information

Topic 3: Fourier Series (FS)

Topic 3: Fourier Series (FS) ELEC264: Signals And Systems Topic 3: Fourier Series (FS) o o o o Introduction to frequency analysis of signals CT FS Fourier series of CT periodic signals Signal Symmetry and CT Fourier Series Properties

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

ECE 301: Signals and Systems Homework Assignment #3

ECE 301: Signals and Systems Homework Assignment #3 ECE 31: Signals and Systems Homework Assignment #3 Due on October 14, 215 Professor: Aly El Gamal A: Xianglun Mao 1 Aly El Gamal ECE 31: Signals and Systems Homework Assignment #3 Problem 1 Problem 1 Consider

More information

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2

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

More information

Chapter 1 Fundamental Concepts

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

More information

Problem Value Score No/Wrong Rec

Problem Value Score No/Wrong Rec GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL & COMPUTER ENGINEERING QUIZ #2 DATE: 14-Oct-11 COURSE: ECE-225 NAME: GT username: LAST, FIRST (ex: gpburdell3) 3 points 3 points 3 points Recitation

More information

Question Paper Code : AEC11T02

Question Paper Code : AEC11T02 Hall Ticket No Question Paper Code : AEC11T02 VARDHAMAN COLLEGE OF ENGINEERING (AUTONOMOUS) Affiliated to JNTUH, Hyderabad Four Year B. Tech III Semester Tutorial Question Bank 2013-14 (Regulations: VCE-R11)

More information

Review of Frequency Domain Fourier Series: Continuous periodic frequency components

Review of Frequency Domain Fourier Series: Continuous periodic frequency components Today we will review: Review of Frequency Domain Fourier series why we use it trig form & exponential form how to get coefficients for each form Eigenfunctions what they are how they relate to LTI systems

More information

16.362: Signals and Systems: 1.0

16.362: Signals and Systems: 1.0 16.362: Signals and Systems: 1.0 Prof. K. Chandra ECE, UMASS Lowell September 1, 2016 1 Background The pre-requisites for this course are Calculus II and Differential Equations. A basic understanding of

More information

CMPT 318: Lecture 5 Complex Exponentials, Spectrum Representation

CMPT 318: Lecture 5 Complex Exponentials, Spectrum Representation CMPT 318: Lecture 5 Complex Exponentials, Spectrum Representation Tamara Smyth, tamaras@cs.sfu.ca School of Computing Science, Simon Fraser University January 23, 2006 1 Exponentials The exponential is

More information

Music 270a: Complex Exponentials and Spectrum Representation

Music 270a: Complex Exponentials and Spectrum Representation Music 270a: Complex Exponentials and Spectrum Representation Tamara Smyth, trsmyth@ucsd.edu Department of Music, University of California, San Diego (UCSD) October 24, 2016 1 Exponentials The exponential

More information

Multimedia Signals and Systems - Audio and Video. Signal, Image, Video Processing Review-Introduction, MP3 and MPEG2

Multimedia Signals and Systems - Audio and Video. Signal, Image, Video Processing Review-Introduction, MP3 and MPEG2 Multimedia Signals and Systems - Audio and Video Signal, Image, Video Processing Review-Introduction, MP3 and MPEG2 Kunio Takaya Electrical and Computer Engineering University of Saskatchewan December

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

Homework 6 EE235, Spring 2011

Homework 6 EE235, Spring 2011 Homework 6 EE235, Spring 211 1. Fourier Series. Determine w and the non-zero Fourier series coefficients for the following functions: (a 2 cos(3πt + sin(1πt + π 3 w π e j3πt + e j3πt + 1 j2 [ej(1πt+ π

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

2A1H Time-Frequency Analysis II Bugs/queries to HT 2011 For hints and answers visit dwm/courses/2tf

2A1H Time-Frequency Analysis II Bugs/queries to HT 2011 For hints and answers visit   dwm/courses/2tf Time-Frequency Analysis II (HT 20) 2AH 2AH Time-Frequency Analysis II Bugs/queries to david.murray@eng.ox.ac.uk HT 20 For hints and answers visit www.robots.ox.ac.uk/ dwm/courses/2tf David Murray. A periodic

More information

X. Chen More on Sampling

X. Chen More on Sampling X. Chen More on Sampling 9 More on Sampling 9.1 Notations denotes the sampling time in second. Ω s = 2π/ and Ω s /2 are, respectively, the sampling frequency and Nyquist frequency in rad/sec. Ω and ω denote,

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

sinc function T=1 sec T=2 sec angle(f(w)) angle(f(w))

sinc function T=1 sec T=2 sec angle(f(w)) angle(f(w)) T=1 sec sinc function 3 angle(f(w)) T=2 sec angle(f(w)) 1 A quick script to plot mag & phase in MATLAB w=0:0.2:50; Real exponential func b=5; Fourier transform (filter) F=1.0./(b+j*w); subplot(211), plot(w,

More information

DFT and Matlab with some examples.

DFT and Matlab with some examples. DFT and Matlab with some examples 1 www.icrf.nl Fourier transform Fourier transform is defined as: X + jωt = x( t e dt ( ω ) ) with ω= 2 π f Rad/s And x(t) a signal in the time domain. www.icrf.nl 2 Fourier

More information

Problem Sheet 1 Examples of Random Processes

Problem Sheet 1 Examples of Random Processes RANDOM'PROCESSES'AND'TIME'SERIES'ANALYSIS.'PART'II:'RANDOM'PROCESSES' '''''''''''''''''''''''''''''''''''''''''''''''''''''''''''''''''Problem'Sheets' Problem Sheet 1 Examples of Random Processes 1. Give

More information

ECE 301. Division 2, Fall 2006 Instructor: Mimi Boutin Midterm Examination 3

ECE 301. Division 2, Fall 2006 Instructor: Mimi Boutin Midterm Examination 3 ECE 30 Division 2, Fall 2006 Instructor: Mimi Boutin Midterm Examination 3 Instructions:. Wait for the BEGIN signal before opening this booklet. In the meantime, read the instructions below and fill out

More information

E : Lecture 1 Introduction

E : Lecture 1 Introduction E85.2607: Lecture 1 Introduction 1 Administrivia 2 DSP review 3 Fun with Matlab E85.2607: Lecture 1 Introduction 2010-01-21 1 / 24 Course overview Advanced Digital Signal Theory Design, analysis, and implementation

More information

Discrete Fourier Transform

Discrete Fourier Transform Discrete Fourier Transform Valentina Hubeika, Jan Černocký DCGM FIT BUT Brno, {ihubeika,cernocky}@fit.vutbr.cz Diskrete Fourier transform (DFT) We have just one problem with DFS that needs to be solved.

More information

EE Homework 13 - Solutions

EE Homework 13 - Solutions EE3054 - Homework 3 - Solutions. (a) The Laplace transform of e t u(t) is s+. The pole of the Laplace transform is at which lies in the left half plane. Hence, the Fourier transform is simply the Laplace

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

INTRODUCTION TO DIGITAL CONTROL

INTRODUCTION TO DIGITAL CONTROL ECE4540/5540: Digital Control Systems INTRODUCTION TO DIGITAL CONTROL.: Introduction In ECE450/ECE550 Feedback Control Systems, welearnedhow to make an analog controller D(s) to control a linear-time-invariant

More information

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros)

Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) Overview of Bode Plots Transfer function review Piece-wise linear approximations First-order terms Second-order terms (complex poles & zeros) J. McNames Portland State University ECE 222 Bode Plots Ver.

More information

Down-Sampling (4B) Young Won Lim 11/15/12

Down-Sampling (4B) Young Won Lim 11/15/12 Down-Sampling (B) /5/ Copyright (c) 9,, Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version. or any later

More information

LABORATORY 1 DISCRETE-TIME SIGNALS

LABORATORY 1 DISCRETE-TIME SIGNALS LABORATORY DISCRETE-TIME SIGNALS.. Introduction A discrete-time signal is represented as a sequence of numbers, called samples. A sample value of a typical discrete-time signal or sequence is denoted as:

More information

Chapter 1 Fundamental Concepts

Chapter 1 Fundamental Concepts Chapter 1 Fundamental Concepts 1 Signals A signal is a pattern of variation of a physical quantity, often as a function of time (but also space, distance, position, etc). These quantities are usually the

More information

Interchange of Filtering and Downsampling/Upsampling

Interchange of Filtering and Downsampling/Upsampling Interchange of Filtering and Downsampling/Upsampling Downsampling and upsampling are linear systems, but not LTI systems. They cannot be implemented by difference equations, and so we cannot apply z-transform

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

Section Kamen and Heck And Harman. Fourier Transform

Section Kamen and Heck And Harman. Fourier Transform s Section 3.4-3.7 Kamen and Heck And Harman 1 3.4 Definition (Equation 3.30) Exists if integral converges (Equation 3.31) Example 3.7 Constant Signal Does not have a Fourier transform in the ordinary sense.

More information

Discrete Time Fourier Transform (DTFT)

Discrete Time Fourier Transform (DTFT) Discrete Time Fourier Transform (DTFT) 1 Discrete Time Fourier Transform (DTFT) The DTFT is the Fourier transform of choice for analyzing infinite-length signals and systems Useful for conceptual, pencil-and-paper

More information

Signals and Systems I Have Known and Loved. (Lecture notes for CSE 3451) Andrew W. Eckford

Signals and Systems I Have Known and Loved. (Lecture notes for CSE 3451) Andrew W. Eckford Signals and Systems I Have Known and Loved (Lecture notes for CSE 3451) Andrew W. Eckford Department of Electrical Engineering and Computer Science York University, Toronto, Ontario, Canada Version: December

More information

Fourier Series Representation of

Fourier Series Representation of Fourier Series Representation of Periodic Signals Rui Wang, Assistant professor Dept. of Information and Communication Tongji University it Email: ruiwang@tongji.edu.cn Outline The response of LIT system

More information

2.161 Signal Processing: Continuous and Discrete

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

More information

4 The Continuous Time Fourier Transform

4 The Continuous Time Fourier Transform 96 4 The Continuous Time ourier Transform ourier (or frequency domain) analysis turns out to be a tool of even greater usefulness Extension of ourier series representation to aperiodic signals oundation

More information

APPLICATIONS FOR ROBOTICS

APPLICATIONS FOR ROBOTICS Version: 1 CONTROL APPLICATIONS FOR ROBOTICS TEX d: Feb. 17, 214 PREVIEW We show that the transfer function and conditions of stability for linear systems can be studied using Laplace transforms. Table

More information

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

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

More information

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

Signals and Systems Lecture Notes

Signals and Systems Lecture Notes Dr. Mahmoud M. Al-Husari Signals and Systems Lecture Notes This set of lecture notes are never to be considered as a substitute to the textbook recommended by the lecturer. ii Contents Preface v 1 Introduction

More information