OSE801 Engineering System Identification. Lecture 05: Fourier Analysis

Size: px
Start display at page:

Download "OSE801 Engineering System Identification. Lecture 05: Fourier Analysis"

Transcription

1 OSE81 Engineering System Identification Lecture 5: Fourier Analysis What we will study in this lecture: A short introduction of Fourier analysis Sampling the data Applications Example

2 1 Fourier Analysis and Signal Aliasing Suppose we have a set of measurements on vibrating structures, q(t), f(t),..., where q s can be velocity, displacement or acceleration vectors, and f s are excitations. As most vibrating structural systems exhibit periodic responses, it is natural to approximate the time series of measured data in terms of their frequency contents. The starting point for this data processing is the wellknown Fourier analysis (after J.B.J. Fourier ( )). In Fourier analysis we approximate a function x(t) by x(t) a 2 + (a k cos kt + b k sin kt) (1) k=1 where a k, b k and a are coefficients to be determined. An attractive feature of the Fourier expansion is in the simplicity of determining the expansion coefficients given by 2π a k = 1 x(t) cos ktdt, b k = 1 x(t) sin ktdt (2) π π for which the following results are repetitively employed: 2π 2π 2π 2π k m cos kt cos mt dt = π k = m 2π k = m = sin kt cos mt dt = for all k & m k m sin kt sin mt dt = π k = m (3) There are two essential properties of the Fourier function: 1) The error of a truncated approximation can be assessed in terms of the function rather than some high-order derivatives required in typical polynomial expansions. 2) The rate of convergence can be estimated easily from the discontinuities of the function and its derivatives. Of course, the routine Fourier analysis tool we would like to understand is Fast Fourier Transform (FFT) rather than the above continuous Fourier analysis. First, as sampling profoundly affects a proper usage of FFT, let us begin 2

3 this section by examining the aliasing phenomenon and its impact on Fourier analysis in general. To this end, we introduce a thought experiment: We are watching a Western movie. A stage coach starts up and the wheels start going faster and faster. If we keep our eyes on the wheels, we see the wheels gradually slow down (even though the speed of the coach is not!), then stop, then occasionally go backwards, slow down, stop, go forward, etc. This effect is due solely to the sampling that our eyes perform on the real scene of the rotating wheels. Hence, once we know the sampling rate, we can tell exactly what sampled frequencies correspond to the rotating wheel speeds (frequencies). In other words, signals with different frequencies may appear to be the same signal, depending upon the sampling rate. To illustrate this, let us consider the following two pathological signals, an example given in Hamming: y 1 (t) = cos[π(n + ε)t + φ] y 2 (t) = cos[π(n ε)t φ] (4) Notice that the two signals have the same values at the three sampling points (t =, 1, 2) as shown in Fig This can be verified from the following identity: cos[π(n + ε)5 + φ] cos[π(n ε)t φ] 2 sin(nπt) sin(nεt + φ) =. (5) if both n and t are integers. Therefore, once we made the measurements, there is no way for us to distinguish the two signals; they appear as if they were the same frequency. This is an important concept to remember in all the data processing involving Fourier analysis. 2 Fourier Integral and Discrete Fourier Transform In practice, the evaluation of the Fourier coefficients a k and b k has to be carried out by an efficient discrete algorithm. This involves the Fourier integral of y(t) defined by X(f) = and its inverse x(t), once X(f) is given, is obtained by: x(t) = + x(t)e j2πft dt (6) X(f) e j2πft df (7) 3

4 Fig. 1. Hamming s Aliasing Example where f is the frequency variable in Hz. Before we can derive Fast Fourier Transforms from the above Fourier integrals, we would need two intermediate steps: a sampled representation of Fourier series and discrete Fourier transform. First, we represent the function x(t) in a discrete periodic form: x(t) = a + 2 (a k cos 2πkt k=1 T + b k sin 2πkt T ) a k = 1 T x(t) cos 2πkt dt, k T T b k = 1 T x(t) sin 2πkt dt, 1 k T T (8) Now let us introduce a complex coefficient that absorbs both a k and b k X(k) = (a k j b k ) = 1 T T x(t)e j(2πkt/t ) dt, j = 1, k (9) 4

5 A crucial step here is to discretize the above complex coefficient X(k) by X(k) = 1 T N 1 s= = t (N t) x(s) e j(2πks t/t ) t N 1 s= x(s) e j(2πks/n) since T = N t (1) The quantity in the denominator (N t) should be interpreted for periodic functions as the time duration or the period of the fundamental frequency content of the signal. Clearly, X(k) in the above equation is the discrete counterpart to the continuous Fourier integral (6). Following a similar step, the discrete inverse Fourier transform that corresponds to the continuous case can be derived as x(s) = N 1 k= X(k) e j(2πks/n) (11) Remark: It should be noted that in MATLAB the discrete Fourier transform pairs are defined by X(k) = N 1 s= x(s) e j(2πks/n) x(s) = 1 N N 1 k= X(k) e j(2πks/n) (12) Hence, for plotting or sometimes scaling purposes, MATLAB Fourier transform X(k) needs to be scaled by t/(n t). However, these MATHLAB pairs need no scaling when using them eventually to obtain an approximate x(t) from {x(s), s =,..., N 1}, viz., x(s) ifft (fft ( x(s) ) ) (13) 3 Sampling Theorem and Aliasing Revisited At the start of this section a physical view of aliasing was presented. Let us now revisit aliasing in conjunction with sampling rules. Suppose x(t) is sampled at discrete time intervals t = t, 2 t, 3 t,..., N t. The sampled discrete 5

6 Fig. 2. Box Wave Transform Pairs values of x(t) denoted as ˆx(t) at those sampling instants can be represented by ˆx(t) = k= where δ(t k t) is the Dirac delta functions. x(k t) δ(t k t) (14) Now suppose that x(t) is zero for frequencies that are greater than ω max = 2πf c. One such function is a box function in frequency domain by {X(f) = 1; f < f c } x(t) = 2f c sin (2πf ct) 2πf c t whose theoretical transform pairs are shown in Fig. 2. (15) To examine the effect of sampling, three sampling stepsizes ( t =.1,.5,, 85) are chosen and their respective Fourier transforms are shown in Fig It should be noted that only half of the symmetric part of the frequency vs. amplitude ( f 1) is plotted. Comparing the discrete transform results with the theoretical transform given in Fig. 5.2, we see that the case with the sampling rate t =.1 gives both the amplitude and frequency transform correctly, except small oscillations around the cut-off frequency f = 1 due to 6

7 Dt=.85 Dt= Frequency(Hz) Dt = Fig. 3. Discrete Fourier Transform of sin(2πt) 2πt the well-known Gibbs phenomenon. Second, the case of t =.5 not only gives the correct magnitude and frequency, but more importantly there is no oscillation around the cut-off frequency. The third case with the sampling rate t =.1 shows the discrete case fails to approximate the theoretical result. The reconstructed three time signals by performing the inverse discrete Fourier transforms of the three discrete Fourier transform cases are shown in Fig

8 D t=.1.2 Dt= Dt= Fig. 4. Reconstructed sin(2πt) 2πt Function Notice that the case of t =.1 reconstructs the original signal reasonably accurately. The case with t =.5 captures the correct magnitude at time t =, and it is zero everywhere else. The case with sampling rate t =.85 are again completely in error. This dependency of the foregoing discrete transform accuracies on the sampling rate can be understood as follows. Since the period of the example problem is T c = 1/f c = 1, the sampling rate 8

9 1.8 o o o o o :Sampling Points o o o Fig. 5. Nyquist Sampling of cos(2πt) Function that picks the absolute maximum function values is t N = T c /2 = 1/2f c. The sinusoidal function is then approximated by a saw-tooth function. Notice that the saw-tooth approximation preserves both the peak values and the frequency. This is illustrated in Fig Therefore, if the sampling rate is large than this value, aliasing will occur, meaning the frequency will be lower 9

10 or the period will be artificially longer. The sampling rate given by t N = 1/(2 period of the signal) (16) is called the Nyquist sampling rate. Hence, if the sampling rate is smaller than the Nyquist rate, no aliasing will occur. Finally, it turns out that the frequency band-limited box wave form pairs provides an important role in constructing the continuous signal from a set of sampled discrete signals, which is called the sampling theorem: x(t) = t s= x(s) sin 2πf c(t s t) π(t s t) (17) The above sampling theorem is applicable to the time domain signal reconstruction. There exists the frequency-domain counterpart, which states that if a function x(t) is time-limited as given by x(t) =, t > T c (18) then the continuous Fourier transform can be constructed from a set of sampled Fourier signals by X(f) = 1 2T c k= X(k) sin 2πT c(f k/2t c ) π(f k/2t c ) (19) In practice, rarely one has the luxury of working with frequency band-limited signals. For example, signals measured on the vibrating structures contain a wide range of frequency spectrum so that it is inevitable to truncate the frequency band-width. Such truncations of either time-domain signals or frequencydomain signals do introduce errors called leakage. This will be discussed below. 4 Leakage due to Signal Truncations Let us consider the following example problem: η 1 (t) = sin(2πf t), f = (2) For subsequent discussions, we introduce without proof the well-known theoretical Fourier transform pairs: 1

11 cos(2πf t) 1 2 δ(f f ) δ(f + f ) sin(2πf t) j 1 2 δ(f + f ) j 1 2 δ(f f ) (21) In truncating time-series signals, it is recommended that the sampling time interval be equal to a multiple of the signal period, while satisfying the Nyquist sampling rate criterion to avoid aliasing. If the sampling time interval is not equal to the integer multiplicity of the signal period, then leakage phenomenon occurs. Since for this example problem we have its period T = 1/f = , in order for the sampling rate to be a fraction of the period, we must have t = /N where N is the number of samples per period. Figure 5.6 illustrates the leakage phenomenon for the example problem. Even though the sampling rate is smaller for the leaking FRF plot designated by +, because the sampling interval is 12.8 * period, that is, the sampling duration is not a multiple of its period, its Fourier transform results in significant leakage. However, this is realistic in that one must usually deal with data sets whose period information is not known a priori. The leakage problem has motivated a host of researchers to devise a plethora of filtering schemes that would compensate the fractional-periodic nature of signals. For periodic signals (fortunately vibration records are periodic!), perhaps the most widely used anti-leakage filter is due to Hanning given by x(t) = 1 2πn (1 cos ) n =, 1, 2,..., N 1. (22) 2 N 1 where N is the total number of samples. Observe that the above Hanning function forces the sampled data to be zero at the start and at the end of the sample interval. Figure 7 shows the effect of Hanning filtering on minimizing leakage when the sample interval does not correspond to a multiple of signal period. The significant improvement over the case without filtering is obvious. However, it should be noted that the peak amplitude is considerably reduced (from.5 to about.25) after applying the Hanning filter. As the magnitude of FRF curves is related to the structural damping levels, one must be careful in interpreting the Hanning-filtered results. Finally, the errors in the magnitudes of the case with the sampling rate N t = 12.8 T can be corrected if one judiciously utilizes the sampling formula. For 11

12 .6.5 Magnitude Frequency(Hz) Fig. 6. Leakage in fft(cos 2πf t) due to Sample Truncation. (o plot: T / t = 32 and 16T duration ), (+ plot: T / t = 4 and 12.8T duration ) example, as the closest multiple of the period is 12, the correct magnitudepreserving formula should read: X(k) = t (12 T ) fft (sin 2πf t) (23) 12

13 Magnitude Frequency(Hz) Fig. 7. Effect of Hanning Filter on Leaky fft(cos 2πf t) FRF Result. (o plot: T / t = 4 and 12.8T duration ), (x plot: after Hanning filtering) which should give its peak magnitude.5, a correct one as can be seen from (21). Finally, the following elementary MatLab code and its variations were used to plot several figures used in the preceding sections. 13

14 % example fft of sine (2*pi*f *t); f = ; f = ; T = 1./f; dt = T/4; N=512; time =(:(N-1))*dt; arg = 2*pi*f*time; y = sin(arg); yfft = fft(y); freq=(:(n/2-1))/(n*dt); plot(freq, abs(yfft(1:n/2))/n, + ); axis([ 1.3.6]); %end 14

EEL3135: Homework #3 Solutions

EEL3135: Homework #3 Solutions EEL335: Homework #3 Solutions Problem : (a) Compute the CTFT for the following signal: xt () cos( πt) cos( 3t) + cos( 4πt). First, we use the trigonometric identity (easy to show by using the inverse Euler

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 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

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

2 Frequency-Domain Analysis

2 Frequency-Domain Analysis 2 requency-domain Analysis Electrical engineers live in the two worlds, so to speak, of time and frequency. requency-domain analysis is an extremely valuable tool to the communications engineer, more so

More information

1 Understanding Sampling

1 Understanding Sampling 1 Understanding Sampling Summary. In Part I, we consider the analysis of discrete-time signals. In Chapter 1, we consider how discretizing a signal affects the signal s Fourier transform. We derive the

More information

Experimental Fourier Transforms

Experimental Fourier Transforms Chapter 5 Experimental Fourier Transforms 5.1 Sampling and Aliasing Given x(t), we observe only sampled data x s (t) = x(t)s(t; T s ) (Fig. 5.1), where s is called sampling or comb function and can be

More information

Vibration Testing. Typically either instrumented hammers or shakers are used.

Vibration Testing. Typically either instrumented hammers or shakers are used. Vibration Testing Vibration Testing Equipment For vibration testing, you need an excitation source a device to measure the response a digital signal processor to analyze the system response Excitation

More information

A523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2011

A523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2011 A523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2011 Lecture 6 PDFs for Lecture 1-5 are on the web page Problem set 2 is on the web page Article on web page A Guided

More information

OSE801 Engineering System Identification. Lecture 09: Computing Impulse and Frequency Response Functions

OSE801 Engineering System Identification. Lecture 09: Computing Impulse and Frequency Response Functions OSE801 Engineering System Identification Lecture 09: Computing Impulse and Frequency Response Functions 1 Extracting Impulse and Frequency Response Functions In the preceding sections, signal processing

More information

Lecture 7 ELE 301: Signals and Systems

Lecture 7 ELE 301: Signals and Systems Lecture 7 ELE 30: Signals and Systems Prof. Paul Cuff Princeton University Fall 20-2 Cuff (Lecture 7) ELE 30: Signals and Systems Fall 20-2 / 22 Introduction to Fourier Transforms Fourier transform as

More information

The (Fast) Fourier Transform

The (Fast) Fourier Transform The (Fast) Fourier Transform The Fourier transform (FT) is the analog, for non-periodic functions, of the Fourier series for periodic functions can be considered as a Fourier series in the limit that the

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

!Sketch f(t) over one period. Show that the Fourier Series for f(t) is as given below. What is θ 1?

!Sketch f(t) over one period. Show that the Fourier Series for f(t) is as given below. What is θ 1? Second Year Engineering Mathematics Laboratory Michaelmas Term 998 -M L G Oldfield 30 September, 999 Exercise : Fourier Series & Transforms Revision 4 Answer all parts of Section A and B which are marked

More information

Chap 4. Sampling of Continuous-Time Signals

Chap 4. Sampling of Continuous-Time Signals Digital Signal Processing Chap 4. Sampling of Continuous-Time Signals Chang-Su Kim Digital Processing of Continuous-Time Signals Digital processing of a CT signal involves three basic steps 1. Conversion

More information

Sound & Vibration Magazine March, Fundamentals of the Discrete Fourier Transform

Sound & Vibration Magazine March, Fundamentals of the Discrete Fourier Transform Fundamentals of the Discrete Fourier Transform Mark H. Richardson Hewlett Packard Corporation Santa Clara, California The Fourier transform is a mathematical procedure that was discovered by a French mathematician

More information

Digital Signal Processing

Digital Signal Processing Digital Signal Processing Introduction Moslem Amiri, Václav Přenosil Embedded Systems Laboratory Faculty of Informatics, Masaryk University Brno, Czech Republic amiri@mail.muni.cz prenosil@fi.muni.cz February

More information

Fundamentals of the Discrete Fourier Transform

Fundamentals of the Discrete Fourier Transform Seminar presentation at the Politecnico di Milano, Como, November 12, 2012 Fundamentals of the Discrete Fourier Transform Michael G. Sideris sideris@ucalgary.ca Department of Geomatics Engineering University

More information

The Discrete Fourier Transform

The Discrete Fourier Transform The Discrete Fourier Transform / 23 The Fourier Transform Any discrete time series exponentials: can be built up of a sum of complex = X m e i2πmn/, n = 0,, m=0 = [ + + + + ]. X 0 X e i2πn (/) X 2 e i2πn

More information

Introduction to Fourier Transforms. Lecture 7 ELE 301: Signals and Systems. Fourier Series. Rect Example

Introduction to Fourier Transforms. Lecture 7 ELE 301: Signals and Systems. Fourier Series. Rect Example Introduction to Fourier ransforms Lecture 7 ELE 3: Signals and Systems Fourier transform as a limit of the Fourier series Inverse Fourier transform: he Fourier integral theorem Prof. Paul Cuff Princeton

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

Massachusetts Institute of Technology

Massachusetts Institute of Technology Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.011: Introduction to Communication, Control and Signal Processing QUIZ 1, March 16, 2010 ANSWER BOOKLET

More information

ECEN 667 Power System Stability Lecture 25: FFT, Energy Methods

ECEN 667 Power System Stability Lecture 25: FFT, Energy Methods ECEN 667 Power System Stability Lecture 5: FFT, Energy Methods Prof. Tom Overbye Dept. of Electrical and Computer Engineering Texas A&M University, overbye@tamu.edu 1 Announcements Read Chapter 9 Final

More information

L29: Fourier analysis

L29: Fourier analysis L29: Fourier analysis Introduction The discrete Fourier Transform (DFT) The DFT matrix The Fast Fourier Transform (FFT) The Short-time Fourier Transform (STFT) Fourier Descriptors CSCE 666 Pattern Analysis

More information

SEISMIC WAVE PROPAGATION. Lecture 2: Fourier Analysis

SEISMIC WAVE PROPAGATION. Lecture 2: Fourier Analysis SEISMIC WAVE PROPAGATION Lecture 2: Fourier Analysis Fourier Series & Fourier Transforms Fourier Series Review of trigonometric identities Analysing the square wave Fourier Transform Transforms of some

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 206 Problem Set #6 Assigned: March, 206 Due Date: March 5, 206 Reading: This problem set is on Fourier series representations of periodic signals. The

More information

Time and Spatial Series and Transforms

Time and Spatial Series and Transforms Time and Spatial Series and Transforms Z- and Fourier transforms Gibbs' phenomenon Transforms and linear algebra Wavelet transforms Reading: Sheriff and Geldart, Chapter 15 Z-Transform Consider a digitized

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

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

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

Lecture 8 ELE 301: Signals and Systems

Lecture 8 ELE 301: Signals and Systems Lecture 8 ELE 30: Signals and Systems Prof. Paul Cuff Princeton University Fall 20-2 Cuff (Lecture 7) ELE 30: Signals and Systems Fall 20-2 / 37 Properties of the Fourier Transform Properties of the Fourier

More information

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010

ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 ME 563 HOMEWORK # 7 SOLUTIONS Fall 2010 PROBLEM 1: Given the mass matrix and two undamped natural frequencies for a general two degree-of-freedom system with a symmetric stiffness matrix, find the stiffness

More information

Vibration Testing. an excitation source a device to measure the response a digital signal processor to analyze the system response

Vibration Testing. an excitation source a device to measure the response a digital signal processor to analyze the system response Vibration Testing For vibration testing, you need an excitation source a device to measure the response a digital signal processor to analyze the system response i) Excitation sources Typically either

More information

In this Lecture. Frequency domain analysis

In this Lecture. Frequency domain analysis In this Lecture Frequency domain analysis Introduction In most cases we want to know the frequency content of our signal Why? Most popular analysis in frequency domain is based on work of Joseph Fourier

More information

e jωt = cos(ωt) + jsin(ωt),

e jωt = cos(ωt) + jsin(ωt), This chapter introduces you to the most useful mechanical oscillator model, a mass-spring system with a single degree of freedom. Basic understanding of this system is the gateway to the understanding

More information

LINEAR SYSTEMS. J. Elder PSYC 6256 Principles of Neural Coding

LINEAR SYSTEMS. J. Elder PSYC 6256 Principles of Neural Coding LINEAR SYSTEMS Linear Systems 2 Neural coding and cognitive neuroscience in general concerns input-output relationships. Inputs Light intensity Pre-synaptic action potentials Number of items in display

More information

Sensors. Chapter Signal Conditioning

Sensors. Chapter Signal Conditioning Chapter 2 Sensors his chapter, yet to be written, gives an overview of sensor technology with emphasis on how to model sensors. 2. Signal Conditioning Sensors convert physical measurements into data. Invariably,

More information

1 Signals and systems

1 Signals and systems 978--52-5688-4 - Introduction to Orthogonal Transforms: With Applications in Data Processing and Analysis Signals and systems In the first two chapters we will consider some basic concepts and ideas as

More information

Lecture 3 - Design of Digital Filters

Lecture 3 - Design of Digital Filters Lecture 3 - Design of Digital Filters 3.1 Simple filters In the previous lecture we considered the polynomial fit as a case example of designing a smoothing filter. The approximation to an ideal LPF can

More information

Distortion Analysis T

Distortion Analysis T EE 435 Lecture 32 Spectral Performance Windowing Spectral Performance of Data Converters - Time Quantization - Amplitude Quantization Quantization Noise . Review from last lecture. Distortion Analysis

More information

ESS Dirac Comb and Flavors of Fourier Transforms

ESS Dirac Comb and Flavors of Fourier Transforms 6. Dirac Comb and Flavors of Fourier ransforms Consider a periodic function that comprises pulses of amplitude A and duration τ spaced a time apart. We can define it over one period as y(t) = A, τ / 2

More information

Ver 3808 E1.10 Fourier Series and Transforms (2014) E1.10 Fourier Series and Transforms. Problem Sheet 1 (Lecture 1)

Ver 3808 E1.10 Fourier Series and Transforms (2014) E1.10 Fourier Series and Transforms. Problem Sheet 1 (Lecture 1) Ver 88 E. Fourier Series and Transforms 4 Key: [A] easy... [E]hard Questions from RBH textbook: 4., 4.8. E. Fourier Series and Transforms Problem Sheet Lecture. [B] Using the geometric progression formula,

More information

Homework: 4.50 & 4.51 of the attachment Tutorial Problems: 7.41, 7.44, 7.47, Signals & Systems Sampling P1

Homework: 4.50 & 4.51 of the attachment Tutorial Problems: 7.41, 7.44, 7.47, Signals & Systems Sampling P1 Homework: 4.50 & 4.51 of the attachment Tutorial Problems: 7.41, 7.44, 7.47, 7.49 Signals & Systems Sampling P1 Undersampling & Aliasing Undersampling: insufficient sampling frequency ω s < 2ω M Perfect

More information

1 1.27z z 2. 1 z H 2

1 1.27z z 2. 1 z H 2 E481 Digital Signal Processing Exam Date: Thursday -1-1 16:15 18:45 Final Exam - Solutions Dan Ellis 1. (a) In this direct-form II second-order-section filter, the first stage has

More information

Frequency Response and Continuous-time Fourier Series

Frequency Response and Continuous-time Fourier Series Frequency Response and Continuous-time Fourier Series Recall course objectives Main Course Objective: Fundamentals of systems/signals interaction (we d like to understand how systems transform or affect

More information

CH.4 Continuous-Time Fourier Series

CH.4 Continuous-Time Fourier Series CH.4 Continuous-Time Fourier Series First step to Fourier analysis. My mathematical model is killing me! The difference between mathematicians and engineers is mathematicians develop mathematical tools

More information

Fourier Analysis and Power Spectral Density

Fourier Analysis and Power Spectral Density Chapter 4 Fourier Analysis and Power Spectral Density 4. Fourier Series and ransforms Recall Fourier series for periodic functions for x(t + ) = x(t), where x(t) = 2 a + a = 2 a n = 2 b n = 2 n= a n cos

More information

EE4061 Communication Systems

EE4061 Communication Systems EE4061 Communication Systems Week 11 Intersymbol Interference Nyquist Pulse Shaping 0 c 2015, Georgia Institute of Technology (lect10 1) Intersymbol Interference (ISI) Tx filter channel Rx filter a δ(t-nt)

More information

EE 435. Lecture 32. Spectral Performance Windowing

EE 435. Lecture 32. Spectral Performance Windowing EE 435 Lecture 32 Spectral Performance Windowing . Review from last lecture. Distortion Analysis T 0 T S THEOREM?: If N P is an integer and x(t) is band limited to f MAX, then 2 Am Χ mnp 1 0 m h N and

More information

Fourier Transform Fast Fourier Transform discovered by Carl Gauss ~1805 re- re invented by Cooley & Tukey in 1965

Fourier Transform Fast Fourier Transform discovered by Carl Gauss ~1805 re- re invented by Cooley & Tukey in 1965 ourier Transform ast ourier Transform discovered by Carl Gauss ~85 re-invented by Cooley & Tukey in 965 wikipedia Next concepts Shannon s Theorem ourier analysis Complex notation Rotating vectors Angular

More information

Review: Continuous Fourier Transform

Review: Continuous Fourier Transform Review: Continuous Fourier Transform Review: convolution x t h t = x τ h(t τ)dτ Convolution in time domain Derivation Convolution Property Interchange the order of integrals Let Convolution Property By

More information

ELEN E4810: Digital Signal Processing Topic 11: Continuous Signals. 1. Sampling and Reconstruction 2. Quantization

ELEN E4810: Digital Signal Processing Topic 11: Continuous Signals. 1. Sampling and Reconstruction 2. Quantization ELEN E4810: Digital Signal Processing Topic 11: Continuous Signals 1. Sampling and Reconstruction 2. Quantization 1 1. Sampling & Reconstruction DSP must interact with an analog world: A to D D to A x(t)

More information

Signal Processing Signal and System Classifications. Chapter 13

Signal Processing Signal and System Classifications. Chapter 13 Chapter 3 Signal Processing 3.. Signal and System Classifications In general, electrical signals can represent either current or voltage, and may be classified into two main categories: energy signals

More information

Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum

Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum Chapter 4 Discrete Fourier Transform (DFT) And Signal Spectrum CEN352, DR. Nassim Ammour, King Saud University 1 Fourier Transform History Born 21 March 1768 ( Auxerre ). Died 16 May 1830 ( Paris ) French

More information

GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL and COMPUTER ENGINEERING

GEORGIA INSTITUTE OF TECHNOLOGY SCHOOL of ELECTRICAL and COMPUTER ENGINEERING GEORGIA INSIUE OF ECHNOLOGY SCHOOL of ELECRICAL and COMPUER ENGINEERING ECE 6250 Spring 207 Problem Set # his assignment is due at the beginning of class on Wednesday, January 25 Assigned: 6-Jan-7 Due

More information

An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing

An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing 85 An Estimation of Error-Free Frequency Response Function from Impact Hammer Testing Se Jin AHN, Weui Bong JEONG and Wan Suk YOO The spectrum of impulse response signal from the impact hammer testing

More information

Laplace Transform Part 1: Introduction (I&N Chap 13)

Laplace Transform Part 1: Introduction (I&N Chap 13) Laplace Transform Part 1: Introduction (I&N Chap 13) Definition of the L.T. L.T. of Singularity Functions L.T. Pairs Properties of the L.T. Inverse L.T. Convolution IVT(initial value theorem) & FVT (final

More information

a k cos kω 0 t + b k sin kω 0 t (1) k=1

a k cos kω 0 t + b k sin kω 0 t (1) k=1 MOAC worksheet Fourier series, Fourier transform, & Sampling Working through the following exercises you will glean a quick overview/review of a few essential ideas that you will need in the moac course.

More information

Information and Communications Security: Encryption and Information Hiding

Information and Communications Security: Encryption and Information Hiding Short Course on Information and Communications Security: Encryption and Information Hiding Tuesday, 10 March Friday, 13 March, 2015 Lecture 5: Signal Analysis Contents The complex exponential The complex

More information

EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, Cover Sheet

EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, Cover Sheet EE301 Signals and Systems In-Class Exam Exam 3 Thursday, Apr. 19, 2012 Cover Sheet Test Duration: 75 minutes. Coverage: Chaps. 5,7 Open Book but Closed Notes. One 8.5 in. x 11 in. crib sheet Calculators

More information

1 Introduction & Objective

1 Introduction & Objective Signal Processing First Lab 13: Numerical Evaluation of 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

More information

Images have structure at various scales

Images have structure at various scales Images have structure at various scales Frequency Frequency of a signal is how fast it changes Reflects scale of structure A combination of frequencies 0.1 X + 0.3 X + 0.5 X = Fourier transform Can we

More information

Lecture 8: Signal Reconstruction, DT vs CT Processing. 8.1 Reconstruction of a Band-limited Signal from its Samples

Lecture 8: Signal Reconstruction, DT vs CT Processing. 8.1 Reconstruction of a Band-limited Signal from its Samples EE518 Digital Signal Processing University of Washington Autumn 2001 Dept. of Electrical Engineering Lecture 8: Signal Reconstruction, D vs C Processing Oct 24, 2001 Prof: J. Bilmes

More information

A3. Frequency Representation of Continuous Time and Discrete Time Signals

A3. Frequency Representation of Continuous Time and Discrete Time Signals A3. Frequency Representation of Continuous Time and Discrete Time Signals Objectives Define the magnitude and phase plots of continuous time sinusoidal signals Extend the magnitude and phase plots to discrete

More information

L6: Short-time Fourier analysis and synthesis

L6: Short-time Fourier analysis and synthesis L6: Short-time Fourier analysis and synthesis Overview Analysis: Fourier-transform view Analysis: filtering view Synthesis: filter bank summation (FBS) method Synthesis: overlap-add (OLA) method STFT magnitude

More information

Chapter 12 Variable Phase Interpolation

Chapter 12 Variable Phase Interpolation Chapter 12 Variable Phase Interpolation Contents Slide 1 Reason for Variable Phase Interpolation Slide 2 Another Need for Interpolation Slide 3 Ideal Impulse Sampling Slide 4 The Sampling Theorem Slide

More information

Filter Analysis and Design

Filter Analysis and Design Filter Analysis and Design Butterworth Filters Butterworth filters have a transfer function whose squared magnitude has the form H a ( jω ) 2 = 1 ( ) 2n. 1+ ω / ω c * M. J. Roberts - All Rights Reserved

More information

8/19/16. Fourier Analysis. Fourier analysis: the dial tone phone. Fourier analysis: the dial tone phone

8/19/16. Fourier Analysis. Fourier analysis: the dial tone phone. Fourier analysis: the dial tone phone Patrice Koehl Department of Biological Sciences National University of Singapore http://www.cs.ucdavis.edu/~koehl/teaching/bl5229 koehl@cs.ucdavis.edu Fourier analysis: the dial tone phone We use Fourier

More information

ENGIN 100: Music Signal Processing. LAB #5: Spectrograms

ENGIN 100: Music Signal Processing. LAB #5: Spectrograms ENGIN : Music Signal Processing LAB #5: Spectrograms Professor Andrew E. Yagle Dept. of EECS, The University of Michigan, Ann Arbor, MI 489-222 I. ABSTRACT This lab will teach you how to use another tool

More information

Final Exam 14 May LAST Name FIRST Name Lab Time

Final Exam 14 May LAST Name FIRST Name Lab Time EECS 20n: Structure and Interpretation of Signals and Systems Department of Electrical Engineering and Computer Sciences UNIVERSITY OF CALIFORNIA BERKELEY Final Exam 14 May 2005 LAST Name FIRST Name Lab

More information

FOURIER ANALYSIS using Python

FOURIER ANALYSIS using Python (version September 5) FOURIER ANALYSIS using Python his practical introduces the following: Fourier analysis of both periodic and non-periodic signals (Fourier series, Fourier transform, discrete Fourier

More information

Lecture 4 - Spectral Estimation

Lecture 4 - Spectral Estimation Lecture 4 - Spectral Estimation The Discrete Fourier Transform The Discrete Fourier Transform (DFT) is the equivalent of the continuous Fourier Transform for signals known only at N instants separated

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

ECE 301 Fall 2011 Division 1. Homework 1 Solutions.

ECE 301 Fall 2011 Division 1. Homework 1 Solutions. ECE 3 Fall 2 Division. Homework Solutions. Reading: Course information handout on the course website; textbook sections.,.,.2,.3,.4; online review notes on complex numbers. Problem. For each discrete-time

More information

IB Paper 6: Signal and Data Analysis

IB Paper 6: Signal and Data Analysis IB Paper 6: Signal and Data Analysis Handout 5: Sampling Theory S Godsill Signal Processing and Communications Group, Engineering Department, Cambridge, UK Lent 2015 1 / 85 Sampling and Aliasing All of

More information

Problem Set 8 Mar 5, 2004 Due Mar 10, 2004 ACM 95b/100b 3pm at Firestone 303 E. Sterl Phinney (2 pts) Include grading section number

Problem Set 8 Mar 5, 2004 Due Mar 10, 2004 ACM 95b/100b 3pm at Firestone 303 E. Sterl Phinney (2 pts) Include grading section number Problem Set 8 Mar 5, 24 Due Mar 1, 24 ACM 95b/1b 3pm at Firestone 33 E. Sterl Phinney (2 pts) Include grading section number Useful Readings: For Green s functions, see class notes and refs on PS7 (esp

More information

Introduction to Orthogonal Transforms. with Applications in Data Processing and Analysis

Introduction to Orthogonal Transforms. with Applications in Data Processing and Analysis i Introduction to Orthogonal Transforms with Applications in Data Processing and Analysis ii Introduction to Orthogonal Transforms with Applications in Data Processing and Analysis June 8, 2009 i ii Contents

More information

EA2.3 - Electronics 2 1

EA2.3 - Electronics 2 1 In the previous lecture, I talked about the idea of complex frequency s, where s = σ + jω. Using such concept of complex frequency allows us to analyse signals and systems with better generality. In this

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

A6523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2013

A6523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2013 A6523 Signal Modeling, Statistical Inference and Data Mining in Astrophysics Spring 2013 Lecture 26 Localization/Matched Filtering (continued) Prewhitening Lectures next week: Reading Bases, principal

More information

Lecture 7: Interpolation

Lecture 7: Interpolation Lecture 7: Interpolation ECE 401: Signal and Image Analysis University of Illinois 2/9/2017 1 Sampling Review 2 Interpolation and Upsampling 3 Spectrum of Interpolated Signals Outline 1 Sampling Review

More information

SIGNALS AND SYSTEMS: PAPER 3C1 HANDOUT 6a. Dr David Corrigan 1. Electronic and Electrical Engineering Dept.

SIGNALS AND SYSTEMS: PAPER 3C1 HANDOUT 6a. Dr David Corrigan 1. Electronic and Electrical Engineering Dept. SIGNALS AND SYSTEMS: PAPER 3C HANDOUT 6a. Dr David Corrigan. Electronic and Electrical Engineering Dept. corrigad@tcd.ie www.mee.tcd.ie/ corrigad FOURIER SERIES Have seen how the behaviour of systems can

More information

Tutorial Sheet #2 discrete vs. continuous functions, periodicity, sampling

Tutorial Sheet #2 discrete vs. continuous functions, periodicity, sampling 2.39 utorial Sheet #2 discrete vs. continuous functions, periodicity, sampling We will encounter two classes of signals in this class, continuous-signals and discrete-signals. he distinct mathematical

More information

Massachusetts Institute of Technology

Massachusetts Institute of Technology Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.11: Introduction to Communication, Control and Signal Processing QUIZ 1, March 16, 21 QUESTION BOOKLET

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

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

Signals and Systems Spring 2004 Lecture #9

Signals and Systems Spring 2004 Lecture #9 Signals and Systems Spring 2004 Lecture #9 (3/4/04). The convolution Property of the CTFT 2. Frequency Response and LTI Systems Revisited 3. Multiplication Property and Parseval s Relation 4. The DT Fourier

More information

MA3232 Summary 5. d y1 dy1. MATLAB has a number of built-in functions for solving stiff systems of ODEs. There are ode15s, ode23s, ode23t, ode23tb.

MA3232 Summary 5. d y1 dy1. MATLAB has a number of built-in functions for solving stiff systems of ODEs. There are ode15s, ode23s, ode23t, ode23tb. umerical solutions of higher order ODE We can convert a high order ODE into a system of first order ODEs and then apply RK method to solve it. Stiff ODEs Stiffness is a special problem that can arise in

More information

4.5. Applications of Trigonometry to Waves. Introduction. Prerequisites. Learning Outcomes

4.5. Applications of Trigonometry to Waves. Introduction. Prerequisites. Learning Outcomes Applications of Trigonometry to Waves 4.5 Introduction Waves and vibrations occur in many contexts. The water waves on the sea and the vibrations of a stringed musical instrument are just two everyday

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

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 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

Mass on a Horizontal Spring

Mass on a Horizontal Spring Course- B.Sc. Applied Physical Science (Computer Science) Year- IInd, Sem- IVth Subject Physics Paper- XIVth, Electromagnetic Theory Lecture No. 22, Simple Harmonic Motion Introduction Hello friends in

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

7.16 Discrete Fourier Transform

7.16 Discrete Fourier Transform 38 Signals, Systems, Transforms and Digital Signal Processing with MATLAB i.e. F ( e jω) = F [f[n]] is periodic with period 2π and its base period is given by Example 7.17 Let x[n] = 1. We have Π B (Ω)

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

x[n] = x a (nt ) x a (t)e jωt dt while the discrete time signal x[n] has the discrete-time Fourier transform x[n]e jωn

x[n] = x a (nt ) x a (t)e jωt dt while the discrete time signal x[n] has the discrete-time Fourier transform x[n]e jωn Sampling Let x a (t) be a continuous time signal. The signal is sampled by taking the signal value at intervals of time T to get The signal x(t) has a Fourier transform x[n] = x a (nt ) X a (Ω) = x a (t)e

More information

Summary of lecture 1. E x = E x =T. X T (e i!t ) which motivates us to define the energy spectrum Φ xx (!) = jx (i!)j 2 Z 1 Z =T. 2 d!

Summary of lecture 1. E x = E x =T. X T (e i!t ) which motivates us to define the energy spectrum Φ xx (!) = jx (i!)j 2 Z 1 Z =T. 2 d! Summary of lecture I Continuous time: FS X FS [n] for periodic signals, FT X (i!) for non-periodic signals. II Discrete time: DTFT X T (e i!t ) III Poisson s summation formula: describes the relationship

More information

DOING PHYSICS WITH MATLAB FOURIER ANALYSIS FOURIER TRANSFORMS

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

More information

Introduction to Biomedical Engineering

Introduction to Biomedical Engineering Introduction to Biomedical Engineering Biosignal processing Kung-Bin Sung 6/11/2007 1 Outline Chapter 10: Biosignal processing Characteristics of biosignals Frequency domain representation and analysis

More information