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

Size: px
Start display at page:

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

Transcription

1 The Z-Transform For a phasor: X(k) = e jωk We have previously derived: Y = H(z)X That is, the output of the filter (Y(k)) is derived by multiplying the input signal (X(k)) by the transfer function (H(z)). However, this equation holds only where X(k) is a phasor. It is not true in the general case. Why not?

2 The Z-Transform (cont.) If X is unit step, and H(z) = z Multiplying by (z) should delay X by one sample. but H(z)X = e -jω which is not just a shift of X by one sample

3 The Z-Transform (cont.) Y = H(z)X It is possible to devise a transformation of a time sequence for which this equation will always hold. That is the z-transform. if and and X*(z) is the z-transform of X(k) Y*(z) is the z-transform of Y(k) H(z) is the transfer function of a filter then Y*(z) = H(z) X*(z) (2) So, what s useful about the z-transform is that it lets us derive the output of filtering by multiplying the input by the transfer function.

4 What is the Z-Transform? The z-transform of a signal is derived by taking each sample value in sequence as the coefficient of successive negative powers of a complex variable (z), and adding the terms together: X*(z) = X(0) z -0 + X(1)z -1 + x(2) z

5 What is the Z-Transform? X*(z) = X(0) z -0 + X(1)z -1 + x(2) z Thus, the z-transform is a polynomial in negative power of z, just as is H. Note that the z-transform is itself a function of z. It is not a number. It is a function, which, if you give it a value for z (a point in the complex plane), it will return a value for X*(z).

6 What is the Z-Transform? Multiplying the z-transform of a signal by z -l will be equivalent to shifting the signal one sample later in time. This was a property of z -l that we illustrated for phasors, but once a signal is transformed into the z-domain, it will work for any signal. X*(z) = X(0) z -0 + X(1)z -1 + x(2) z H(z) = z -1 Y*(z) = X(0)z -1 +X(1)z -2 +x(3)z -3 Y*(z) is the z-transform of X delayed by one sample Y*(z) = X(k-1)*(z)

7 X(k) X delayed by one sample Y(k) X*(z) = X(0) z -0 + X(1)z -1 + x(2) z Y*(z) = Y(0) z -0 + Y(1) z -1 + Y(2) z = X(-1) z -0 + X(0) z -1 + X(2) z

8 Discrete Fourier Transform (DFT) The values of X*(z) around the unit circle have a special meaning. These are the values for which z=e jω. The value of the z-transform at any point along the circle (X*(e jω )) for a particular value of ω then tells us something about that frequency content in the signal: Magnitude(X*(e jω )) Amplitude of that frequency. Arg(X*(e jω )) Phase of that frequency. This evaluation of X*(e jω ) around the unit circle is referred to as the discrete fourier transform (DFT) of the signal.

9 Discrete Fourier Transform (DFT) Why does the evaluation of the z-transform around the unit circle have this "special" property? Consider how similar this is to calculating the frequency response of a filter. A moving average filter can be considered a time waveform: it is the impulse response of the filter. Its coefficients also can be considered coefficients of a polynomial in z. To get the frequency response: -we simply chose a set of test frequencies (a vector ω), -computed z from these (=e jω ), -evaluated the polynomial (for a given ω) by summing the terms of the polynomial. To get the frequency content: -consider successive points to be the coefficients of successive powers of z. -chose a set of test frequencies (a vector ω) -compute z from these (=e jω ), -evaluate the polynomial (for a given ω) by summing the terms of the polynomial. In either case: The magnitude of this complex number corresponded to the amplitude response, while the argument corresponded to the phase response.

10 DFT vs. Frequency Response There is an important way in which computing the DFT of a signal differs from computing the frequency response of a filter. Frequency Response: allows an arbitrary number of test frequencies DFT: limited to N frequencies (distributed equally around the entire unit circle, where N is the number of points in the signal being analyzed These N frequencies have the property that if we add sinusoids at those N frequencies with the amplitudes and phases calculated in the DFT, then we reconstruct the original signal exactly.

11 Discrete Fourier Transform (DFT) Since these N frequencies go all the way around the unit circle, half of them are redundant. The useful part of the unit circle (0 to π radians) is thus divided into (N/2) + 1 frequencies. π/2 π 0

12 function dft(x) % first find the number of points N = length(x); % fill a vector of test frequencies to plot % Use N frequencies evenly spaced between 0 and 2 pi radians w = linspace(0,2*pi-(2*pi)/n,n); % Compute a vector of z from w; % This will result in a vector of z's z = exp(j*w); % Create a vector F that will eventually contain the dft. % There will be N elements in this vector. % First set all the elements of this vector to 0 F = zeros(1,n);

13 % Now compute F by summing the terms of the polynomial in z for n = 0:N-1 F = F + (x(n+1).* (z.^ n)); end % Plot the magnitude of F figure(1) w = w/pi; stem (w,abs(f)) xlabel ('frequency in fractions of pi') ylabel ('amplitude') pause % Plot the argument of F figure(2) plot (w,angle(f)) xlabel ('frequency in fractions of pi') ylabel ('phase')

14 >> srate = 10000; >> f600= phasor(srate,600); >> dft(f600(1:50)); Example Hz

15 Output spectrum from 0 Hz to the Nyquist frequency. There is a non-zero frequency component only at the frequency of the phasor, 600Hz.

16 >> srate = 10000; >> f200= phasor(srate,200); >> dft(f200(1:50)); Example Hz

17 Example >> f26=f200+f600 >> dft(f26(1:50)); Hz

18 Frequency Resolution Since the there are N equally spaced frequencies returned by the DFT between 0 Hz and srate, the frequency spacing of the fourier components can be calculated as follows: fint = srate/n Since the duration (in seconds) of the analyzed signal is equal to N/srate, it is also true that: fint = 1/signal_duration So if take a 10ms dft, we will have a frequency resolution of 100 Hz.

19 Leakage If we analyze a 500 Hz phasor using the same analysis conditions, we get a suprising result: >> f500= phasor(srate,500); >> spectrum(f500(1:50), srate) Where do all these non-zero frequencies come from? They are called leakage.

20 Leakage The problem is that fourier analysis assumes that the section of signal analyzed repeats infinitely both directions in time. If the analyzed signal contains a fractional period, then duplicating the analyzed signal indefinitely in time produces a signal with transients 50 samples of 500 Hz signal repeated

21 Windowing To get around this problem, we multiply the sample to be analyzed by a windowing function, which eliminates the transients. hamming hanning

22 Windowing: The Signal Unwindowed Signal Windowed Signal (Hanning) >>plot ([hanning(50)'.*f500(1:50)], 'o-');

23 Windowing: The Spectrum unwindowed spectrum windowed spectrum >>spectrum (hanning(50)'.*f500(1:50),srate)

24 Windowing: Note Note that windowing cannot completely solve the problem. For one thing, there is no fourier component at 500 Hz when N=50, only components at 400 Hz and 600 Hz. Not all of the other leakage components have been completely eliminated.

25 More points... >> spectrum (f500(1:100),srate)

26 Zero-Padding There are cases when we want to use a very small time window to analyze a signal. If a signal that is changing over time, we do not want to use a window whose duration includes significant change in the frequency, amplitude, and phase. Consider the problem of formant frequency analysis. If we analyze a segment of a speech signal (e.g., a segment of the vowel in a synthetic [da] syllable), and we use a 25ms time window, we will get frequency components that are 40Hz apart.

27 Zero-Padding This means that individual harmonics of the voiced source will be resolved. *Note that it is usual to plot a spectrum on a decibel (db) scale, which is a log scale. >> spectrum(hamming(250).*da(2501:2750),10000)

28 Zero-Padding We may want to find single peaks in the spectrum corresponding to the vocal tract resonances. In this case, we should analyze a shorter time window. Formant resonances are, in fact, on a much faster time scale than the voiced source. However, if we reduce the number of input points to 40, we will only get 40 frequencies. >> spectrum(hamming(40).*da(2501:2540),10000)

29 Zero-Padding To solve this, we can pad an input signal with extra zeros. This means we can get the value of more frequencies, and the spectrum will look smoother. F1 F2 F3 We can now see the formants more clearly >> spectrum(hamming(40).*da(2501:2540),10000,256)

30 function spectrum(signal, srate, Nfreqs) if nargin < 3 N = length(signal); else N = Nfreqs*2; end Y = fft(signal, N); % get frequency values of successive fft points w = 0:2*pi/N:2*pi-(2*pi/N); % these are values in radians/sample freq = w*srate/(2*pi); % these are values in Hz figure (1) stem (freq(1:(n/2)+1), ((abs(y(1:(n/2)+1))))) xlabel ('Frequency in Hz') ylabel ('Amplitude') grid figure (2) plot (freq(1:(n/2)+1), (20*log(abs(Y(1:(N/2)+1))))) xlabel ('Frequency in Hz') ylabel ('Amplitude in db') grid

31 Zero-Padding Note that we cannot increase frequency resolution this way, but we get a better picture how the energy is distributed between the (non-padded) frequency components. If you look at the code for the dft, you can see that it will get exactly the same answer for frequencies that are in common (why)? So all we are doing is allowing ourselves to evaluate the z- transform of the input at more than N frequencies. And it turns out that if you add the resulting components up, it will produce the original signal, followed by some number of (padding) zeros.

32 Zero-Padding Note that padding will also help with the case of a signal that is not exactly periodic in the window (i.e., leakage). unpadded spectrum zero-padded spectrum >> spectrum(hamming(50).*f500(1:50),10000,200)

33 Pre-emphasis In order to analyze formant resonances it is sometimes useful to remove the 6db/octave decrease in spectral energy that is due to the nature of the voiced source. The voiced source actually rolls off at 12db/octave, but half of that is compensated by the radiation of the sound from the lips. This 6db/octave decrease can be removed by high-pass filtering the speech (this is called pre-emphasis). This can be easily done in MATLAB by: Using the filter command with b coefficients = [1 1] Using the diff command (differentiate)

34 Pre-emphasis: Example Without Pre-emphasis With Pre-emphasis > spectrum(hamming(40).*diff(da(2501:2541)),10000,256)

35 Pre-emphasis: Example With Pre-emphasis The resulting peaks in the spectrum agree well with the formant frequencies that were specified to the synthesizer: [ ]

36 Spectrograms A spectrogram shows how the spectrum of a signal is changing over time. A spectrogram can be generated in MATLAB, by calculating a sequence of FFTs, which results in a matrix of analysis frames by frequency, with the amplitude as the value in each cell of the matrix. We can then use the image (or imagesc) commands to create an image in which each cell of the fft matrix controls the grey-scale value or a rectangular patch in the image.

37 function make_spect (signal, srate, Wsize, maxfreq, contrast); clf; if nargin < 4, maxfreq = srate/2; end; if nargin < 5, contrast = 4; end; if maxfreq > srate/2, maxfreq = srate/2; end; if srate < 25000, Nfreqs = 256; else Nfreqs = 512; end; freqsplot = round (Nfreqs.* (maxfreq/(srate/2))); % pre-emphasize, so analyze diff of signal sg = ComputeSgram(diff(signal), srate, Nfreqs, freqsplot, Wsize, 1); nframes = size(sg,2); % frames are 1 millisecond f = linspace(0,maxfreq,freqsplot); set(axes, 'xlim', [1 nframes], 'ylim', [0 maxfreq]); figure (1) imagesc(1:nframes, f, sg); set(gca, 'ydir', 'normal', 'box', 'on'); colormap(flipud(gray(256).^contrast)); xlabel ('Time in Millliseconds'); ylabel ('Frequency in Hz');

38 [frame, ifreq, button] = ginput (1); while (length (frame) > 0) iframe = round(frame); isample = iframe.* round(srate/1000); sp = ComputeSpectrum (diff(signal), srate, Nfreqs, freqsplot, Wsize,isample); figure(2) clf plot (f, 20*log10(sp)) xlabel ('Frequency in Hz') ylabel ('DB') grid figure (1) [frame, ifreq,button] = ginput(1); end

39 function sg = ComputeSgram(s,sRate,Nfreqs,freqsPlot,wSize,shift); nsamps = length(s); wsize = floor(wsize*srate/1000); wsize = wsize + mod(wsize,2); shift = shift * srate/1000; nframes = round(nsamps/shift); w = hanning(wsize); sg = zeros(freqsplot, nframes); s = [s ; zeros(wsize,1)]; sx = 1; % window size (samples) % make sure it's even % fractional samples per shift % append zeros at end % fractional sample index for fi = 1 : nframes, si = round(sx); pf = abs(fft(w.* s(si:si+wsize-1),nfreqs*2)); sg(:,fi) = pf(2:freqsplot+1); % drop DC sx = sx + shift; end; sg = filter(ones(3,1)/3,1,abs(sg),[],2); % clean holes

40 function sp=computespectrum(s,srate,nfreqs,freqsplot,wsize, isample); wsize = floor(wsize*srate/1000); % window size (samples) wsize = wsize + mod(wsize,2); % make sure it's even w = hanning(wsize); pf = abs(fft(w.* s(si:si+wsize-1),nfreqs*2)); sp = pf(2:freqsplot+1); % drop DC and unwanted freqs

41 > make_spect(sad,srate,6,5000,10)

42 > make_spect(sad,srate,25,5000,10)

43 > make_spect(dude,srate,6,5000,10)

44 > make_spect(dude,srate,25,5000,10)

Formant Analysis using LPC

Formant Analysis using LPC Linguistics 582 Basics of Digital Signal Processing Formant Analysis using LPC LPC (linear predictive coefficients) analysis is a technique for estimating the vocal tract transfer function, from which

More information

Thursday, October 29, LPC Analysis

Thursday, October 29, LPC Analysis LPC Analysis Prediction & Regression We hypothesize that there is some systematic relation between the values of two variables, X and Y. If this hypothesis is true, we can (partially) predict the observed

More information

z as shift (delay) operator

z as shift (delay) operator z as shift (delay) operator We saw that in deriving the transfer function and frequency response of an averaging filter that it involved multiplying the input by e -j ω Y (k) =.5e j k +.5e j k e j Means

More information

Recovering f0 using autocorelation. Tuesday, March 31, 15

Recovering f0 using autocorelation. Tuesday, March 31, 15 Recovering f0 using autocorelation More on correlation More on correlation The correlation between two vectors is a measure of whether they share the same pattern of values at corresponding vector positions

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 Analysis of Signals Using the DFT

Fourier Analysis of Signals Using the DFT Fourier Analysis of Signals Using the DFT ECE 535 Lecture April 29, 23 Overview: Motivation Many applications require analyzing the frequency content of signals Speech processing study resonances of vocal

More information

SPEECH ANALYSIS AND SYNTHESIS

SPEECH ANALYSIS AND SYNTHESIS 16 Chapter 2 SPEECH ANALYSIS AND SYNTHESIS 2.1 INTRODUCTION: Speech signal analysis is used to characterize the spectral information of an input speech signal. Speech signal analysis [52-53] techniques

More information

SPEECH COMMUNICATION 6.541J J-HST710J Spring 2004

SPEECH COMMUNICATION 6.541J J-HST710J Spring 2004 6.541J PS3 02/19/04 1 SPEECH COMMUNICATION 6.541J-24.968J-HST710J Spring 2004 Problem Set 3 Assigned: 02/19/04 Due: 02/26/04 Read Chapter 6. Problem 1 In this problem we examine the acoustic and perceptual

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

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

Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 6 Solutions

Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 6 Solutions Problem 1 Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 6 Solutions The complex cepstrum, ˆx[n], of a sequence x[n] is the inverse Fourier transform of the complex

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

Chapter 9. Linear Predictive Analysis of Speech Signals 语音信号的线性预测分析

Chapter 9. Linear Predictive Analysis of Speech Signals 语音信号的线性预测分析 Chapter 9 Linear Predictive Analysis of Speech Signals 语音信号的线性预测分析 1 LPC Methods LPC methods are the most widely used in speech coding, speech synthesis, speech recognition, speaker recognition and verification

More information

Harmonic motion. time 1 - A. Wednesday, September 30, 2009

Harmonic motion. time 1 - A. Wednesday, September 30, 2009 Harmonic motion time 1 2 3 4 5 - A x 0 + A + A Block resting on air hockey table, with a spring attaching it to the side of the table. Such systems are effectively frictionless. Block will oscillate about

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

Feature extraction 2

Feature extraction 2 Centre for Vision Speech & Signal Processing University of Surrey, Guildford GU2 7XH. Feature extraction 2 Dr Philip Jackson Linear prediction Perceptual linear prediction Comparison of feature methods

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

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

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

Continuous Fourier transform of a Gaussian Function

Continuous Fourier transform of a Gaussian Function Continuous Fourier transform of a Gaussian Function Gaussian function: e t2 /(2σ 2 ) The CFT of a Gaussian function is also a Gaussian function (i.e., time domain is Gaussian, then the frequency domain

More information

The Impulse Signal. A signal I(k), which is defined as zero everywhere except at a single point, where its value is equal to 1

The Impulse Signal. A signal I(k), which is defined as zero everywhere except at a single point, where its value is equal to 1 The Impulse Signal A signal I(k), which is defined as zero everywhere except at a single point, where its value is equal to 1 I = [0 0 1 0 0 0]; stem(i) Filter Impulse through Feedforward Filter 0 0.25.5.25

More information

4.2 Acoustics of Speech Production

4.2 Acoustics of Speech Production 4.2 Acoustics of Speech Production Acoustic phonetics is a field that studies the acoustic properties of speech and how these are related to the human speech production system. The topic is vast, exceeding

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

Recursive, Infinite Impulse Response (IIR) Digital Filters:

Recursive, Infinite Impulse Response (IIR) Digital Filters: Recursive, Infinite Impulse Response (IIR) Digital Filters: Filters defined by Laplace Domain transfer functions (analog devices) can be easily converted to Z domain transfer functions (digital, sampled

More information

Damped Oscillators (revisited)

Damped Oscillators (revisited) Damped Oscillators (revisited) We saw that damped oscillators can be modeled using a recursive filter with two coefficients and no feedforward components: Y(k) = - a(1)*y(k-1) - a(2)*y(k-2) We derived

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

Discrete Fourier Transform

Discrete Fourier Transform Discrete Fourier Transform Virtually all practical signals have finite length (e.g., sensor data, audio records, digital images, stock values, etc). Rather than considering such signals to be zero-padded

More information

Optimal Design of Real and Complex Minimum Phase Digital FIR Filters

Optimal Design of Real and Complex Minimum Phase Digital FIR Filters Optimal Design of Real and Complex Minimum Phase Digital FIR Filters Niranjan Damera-Venkata and Brian L. Evans Embedded Signal Processing Laboratory Dept. of Electrical and Computer Engineering The University

More information

Discrete-Time David Johns and Ken Martin University of Toronto

Discrete-Time David Johns and Ken Martin University of Toronto Discrete-Time David Johns and Ken Martin University of Toronto (johns@eecg.toronto.edu) (martin@eecg.toronto.edu) University of Toronto 1 of 40 Overview of Some Signal Spectra x c () t st () x s () t xn

More information

Voiced Speech. Unvoiced Speech

Voiced Speech. Unvoiced Speech Digital Speech Processing Lecture 2 Homomorphic Speech Processing General Discrete-Time Model of Speech Production p [ n] = p[ n] h [ n] Voiced Speech L h [ n] = A g[ n] v[ n] r[ n] V V V p [ n ] = u [

More information

LAB 6: FIR Filter Design Summer 2011

LAB 6: FIR Filter Design 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 6: FIR Filter Design Summer 011

More information

1. Calculation of the DFT

1. Calculation of the DFT ELE E4810: Digital Signal Processing Topic 10: The Fast Fourier Transform 1. Calculation of the DFT. The Fast Fourier Transform algorithm 3. Short-Time Fourier Transform 1 1. Calculation of the DFT! Filter

More information

Chirp Transform for FFT

Chirp Transform for FFT Chirp Transform for FFT Since the FFT is an implementation of the DFT, it provides a frequency resolution of 2π/N, where N is the length of the input sequence. If this resolution is not sufficient in a

More information

Speech Signal Representations

Speech Signal Representations Speech Signal Representations Berlin Chen 2003 References: 1. X. Huang et. al., Spoken Language Processing, Chapters 5, 6 2. J. R. Deller et. al., Discrete-Time Processing of Speech Signals, Chapters 4-6

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

Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates

Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates Spectrograms Overview Introduction and motivation Windowed estimates as filter banks Uncertainty principle Examples Other estimates J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1 1 Introduction

More information

Signal representations: Cepstrum

Signal representations: Cepstrum Signal representations: Cepstrum Source-filter separation for sound production For speech, source corresponds to excitation by a pulse train for voiced phonemes and to turbulence (noise) for unvoiced phonemes,

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

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

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

Digital Signal Processing Lab 3: Discrete Fourier Transform

Digital Signal Processing Lab 3: Discrete Fourier Transform Digital Signal Processing Lab 3: Discrete Fourier Transform Discrete Time Fourier Transform (DTFT) The discrete-time Fourier transform (DTFT) of a sequence x[n] is given by (3.1) which is a continuous

More information

VII. Discrete Fourier Transform (DFT) Chapter-8. A. Modulo Arithmetic. (n) N is n modulo N, n is an integer variable.

VII. Discrete Fourier Transform (DFT) Chapter-8. A. Modulo Arithmetic. (n) N is n modulo N, n is an integer variable. 1 VII. Discrete Fourier Transform (DFT) Chapter-8 A. Modulo Arithmetic (n) N is n modulo N, n is an integer variable. (n) N = n m N 0 n m N N-1, pick m Ex. (k) 4 W N = e -j2π/n 2 Note that W N k = 0 but

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

Ch.11 The Discrete-Time Fourier Transform (DTFT)

Ch.11 The Discrete-Time Fourier Transform (DTFT) EE2S11 Signals and Systems, part 2 Ch.11 The Discrete-Time Fourier Transform (DTFT Contents definition of the DTFT relation to the -transform, region of convergence, stability frequency plots convolution

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

Discrete Time Systems

Discrete Time Systems Discrete Time Systems Valentina Hubeika, Jan Černocký DCGM FIT BUT Brno, {ihubeika,cernocky}@fit.vutbr.cz 1 LTI systems In this course, we work only with linear and time-invariant systems. We talked about

More information

EE482: Digital Signal Processing Applications

EE482: Digital Signal Processing Applications Professor Brendan Morris, SEB 3216, brendan.morris@unlv.edu EE482: Digital Signal Processing Applications Spring 2014 TTh 14:305:45 CBC C222 Lecture 8 Frequency Analysis 14/02/18 http://www.ee.unlv.edu/~b1morris/ee482/

More information

EE482: Digital Signal Processing Applications

EE482: Digital Signal Processing Applications Professor Brendan Morris, SEB 3216, brendan.morris@unlv.edu EE482: Digital Signal Processing Applications Spring 2014 TTh 14:30-15:45 CBC C222 Lecture 02 DSP Fundamentals 14/01/21 http://www.ee.unlv.edu/~b1morris/ee482/

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

Linear Prediction 1 / 41

Linear Prediction 1 / 41 Linear Prediction 1 / 41 A map of speech signal processing Natural signals Models Artificial signals Inference Speech synthesis Hidden Markov Inference Homomorphic processing Dereverberation, Deconvolution

More information

BME 50500: Image and Signal Processing in Biomedicine. Lecture 2: Discrete Fourier Transform CCNY

BME 50500: Image and Signal Processing in Biomedicine. Lecture 2: Discrete Fourier Transform CCNY 1 Lucas Parra, CCNY BME 50500: Image and Signal Processing in Biomedicine Lecture 2: Discrete Fourier Transform Lucas C. Parra Biomedical Engineering Department CCNY http://bme.ccny.cuny.edu/faculty/parra/teaching/signal-and-image/

More information

convenient means to determine response to a sum of clear evidence of signal properties that are obscured in the original signal

convenient means to determine response to a sum of clear evidence of signal properties that are obscured in the original signal Digital Speech Processing Lecture 9 Short-Time Fourier Analysis Methods- Introduction 1 General Discrete-Time Model of Speech Production Voiced Speech: A V P(z)G(z)V(z)R(z) Unvoiced Speech: A N N(z)V(z)R(z)

More information

CMPT 889: Lecture 5 Filters

CMPT 889: Lecture 5 Filters CMPT 889: Lecture 5 Filters Tamara Smyth, tamaras@cs.sfu.ca School of Computing Science, Simon Fraser University October 7, 2009 1 Digital Filters Any medium through which a signal passes may be regarded

More information

Frequency Domain Speech Analysis

Frequency Domain Speech Analysis Frequency Domain Speech Analysis Short Time Fourier Analysis Cepstral Analysis Windowed (short time) Fourier Transform Spectrogram of speech signals Filter bank implementation* (Real) cepstrum and complex

More information

Digital Filters. Linearity and Time Invariance. Linear Time-Invariant (LTI) Filters: CMPT 889: Lecture 5 Filters

Digital Filters. Linearity and Time Invariance. Linear Time-Invariant (LTI) Filters: CMPT 889: Lecture 5 Filters Digital Filters CMPT 889: Lecture 5 Filters Tamara Smyth, tamaras@cs.sfu.ca School of Computing Science, Simon Fraser University October 7, 29 Any medium through which a signal passes may be regarded as

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

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

ENT 315 Medical Signal Processing CHAPTER 2 DISCRETE FOURIER TRANSFORM. Dr. Lim Chee Chin

ENT 315 Medical Signal Processing CHAPTER 2 DISCRETE FOURIER TRANSFORM. Dr. Lim Chee Chin ENT 315 Medical Signal Processing CHAPTER 2 DISCRETE FOURIER TRANSFORM Dr. Lim Chee Chin Outline Introduction Discrete Fourier Series Properties of Discrete Fourier Series Time domain aliasing due to frequency

More information

The O () notation. Definition: Let f(n), g(n) be functions of the natural (or real)

The O () notation. Definition: Let f(n), g(n) be functions of the natural (or real) The O () notation When analyzing the runtime of an algorithm, we want to consider the time required for large n. We also want to ignore constant factors (which often stem from tricks and do not indicate

More information

Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 7 Solutions

Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 7 Solutions Problem 1 Department of Electrical and Computer Engineering Digital Speech Processing Homework No. 7 Solutions Linear prediction analysis is used to obtain an eleventh-order all-pole model for a segment

More information

Assignment 2. Signal Processing and Speech Communication Lab. Graz University of Technology

Assignment 2. Signal Processing and Speech Communication Lab. Graz University of Technology Signal Processing and Speech Communication Lab. Graz University of Technology Assignment 2 This homework has to be submitted via e-mail to the address hw1.spsc@tugraz.at not later than 25.5.2016. Let the

More information

Introduction to DSP Time Domain Representation of Signals and Systems

Introduction to DSP Time Domain Representation of Signals and Systems Introduction to DSP Time Domain Representation of Signals and Systems Dr. Waleed Al-Hanafy waleed alhanafy@yahoo.com Faculty of Electronic Engineering, Menoufia Univ., Egypt Digital Signal Processing (ECE407)

More information

Introduction to Sparsity in Signal Processing

Introduction to Sparsity in Signal Processing 1 Introduction to Sparsity in Signal Processing Ivan Selesnick Polytechnic Institute of New York University Brooklyn, New York selesi@poly.edu 212 2 Under-determined linear equations Consider a system

More information

Zeros of z-transform(zzt) representation and chirp group delay processing for analysis of source and filter characteristics of speech signals

Zeros of z-transform(zzt) representation and chirp group delay processing for analysis of source and filter characteristics of speech signals Zeros of z-transformzzt representation and chirp group delay processing for analysis of source and filter characteristics of speech signals Baris Bozkurt 1 Collaboration with LIMSI-CNRS, France 07/03/2017

More information

Digital Signal Processing Lab 4: Transfer Functions in the Z-domain

Digital Signal Processing Lab 4: Transfer Functions in the Z-domain Digital Signal Processing Lab 4: Transfer Functions in the Z-domain A very important category of LTI systems is described by difference equations of the following type N a y[ nk] b x[ nk] M k k0 k0 k From

More information

Lecture 19: Discrete Fourier Series

Lecture 19: Discrete Fourier Series EE518 Digital Signal Processing University of Washington Autumn 2001 Dept. of Electrical Engineering Lecture 19: Discrete Fourier Series Dec 5, 2001 Prof: J. Bilmes TA: Mingzhou

More information

Perturbation Theory: Why do /i/ and /a/ have the formants they have? Tuesday, March 3, 15

Perturbation Theory: Why do /i/ and /a/ have the formants they have? Tuesday, March 3, 15 Perturbation Theory: Why do /i/ and /a/ have the formants they have? Vibration: Harmonic motion time 1 2 3 4 5 - A x 0 + A + A Block resting on air hockey table, with a spring attaching it to the side

More information

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

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

More information

! Introduction. ! Discrete Time Signals & Systems. ! Z-Transform. ! Inverse Z-Transform. ! Sampling of Continuous Time Signals

! Introduction. ! Discrete Time Signals & Systems. ! Z-Transform. ! Inverse Z-Transform. ! Sampling of Continuous Time Signals ESE 531: Digital Signal Processing Lec 25: April 24, 2018 Review Course Content! Introduction! Discrete Time Signals & Systems! Discrete Time Fourier Transform! Z-Transform! Inverse Z-Transform! Sampling

More information

# FIR. [ ] = b k. # [ ]x[ n " k] [ ] = h k. x[ n] = Ae j" e j# ˆ n Complex exponential input. [ ]Ae j" e j ˆ. ˆ )Ae j# e j ˆ. y n. y n.

# FIR. [ ] = b k. # [ ]x[ n  k] [ ] = h k. x[ n] = Ae j e j# ˆ n Complex exponential input. [ ]Ae j e j ˆ. ˆ )Ae j# e j ˆ. y n. y n. [ ] = h k M [ ] = b k x[ n " k] FIR k= M [ ]x[ n " k] convolution k= x[ n] = Ae j" e j ˆ n Complex exponential input [ ] = h k M % k= [ ]Ae j" e j ˆ % M = ' h[ k]e " j ˆ & k= k = H (" ˆ )Ae j e j ˆ ( )

More information

DFT-Based FIR Filtering. See Porat s Book: 4.7, 5.6

DFT-Based FIR Filtering. See Porat s Book: 4.7, 5.6 DFT-Based FIR Filtering See Porat s Book: 4.7, 5.6 1 Motivation: DTFT View of Filtering There are two views of filtering: * Time Domain * Frequency Domain x[ X f ( θ ) h[ H f ( θ ) Y y[ = h[ * x[ f ( θ

More information

Windowing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples

Windowing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples ing Overview Relevance Main lobe/side lobe tradeoff Popular windows Examples ing In practice, we cannot observe a signal x(n) for n = to n = Thus we must truncate, or window, the signal: x(n) w(n) ing

More information

Topic 6. Timbre Representations

Topic 6. Timbre Representations Topic 6 Timbre Representations We often say that singer s voice is magnetic the violin sounds bright this French horn sounds solid that drum sounds dull What aspect(s) of sound are these words describing?

More information

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1

HW13 Solutions. Pr (a) The DTFT of c[n] is. C(e jω ) = 0.5 m e jωm e jω + 1 HW3 Solutions Pr..8 (a) The DTFT of c[n] is C(e jω ) = = =.5 n e jωn + n=.5e jω + n= m=.5 n e jωn.5 m e jωm.5e jω +.5e jω.75 =.5 cos(ω) }{{}.5e jω /(.5e jω ) C(e jω ) is the power spectral density. (b)

More information

INTRODUCTION TO DELTA-SIGMA ADCS

INTRODUCTION TO DELTA-SIGMA ADCS ECE37 Advanced Analog Circuits INTRODUCTION TO DELTA-SIGMA ADCS Richard Schreier richard.schreier@analog.com NLCOTD: Level Translator VDD > VDD2, e.g. 3-V logic? -V logic VDD < VDD2, e.g. -V logic? 3-V

More information

DSP. Chapter-3 : Filter Design. Marc Moonen. Dept. E.E./ESAT-STADIUS, KU Leuven

DSP. Chapter-3 : Filter Design. Marc Moonen. Dept. E.E./ESAT-STADIUS, KU Leuven DSP Chapter-3 : Filter Design Marc Moonen Dept. E.E./ESAT-STADIUS, KU Leuven marc.moonen@esat.kuleuven.be www.esat.kuleuven.be/stadius/ Filter Design Process Step-1 : Define filter specs Pass-band, stop-band,

More information

Introduction to Sparsity in Signal Processing

Introduction to Sparsity in Signal Processing 1 Introduction to Sparsity in Signal Processing Ivan Selesnick Polytechnic Institute of New York University Brooklyn, New York selesi@poly.edu 212 2 Under-determined linear equations Consider a system

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

Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as

Solutions. Chapter 5. Problem 5.1. Solution. Consider the driven, two-well Duffing s oscillator. which can be written in state variable form as Chapter 5 Solutions Problem 5.1 Consider the driven, two-well Duffing s oscillator which can be written in state variable form as ẍ + ɛγẋ x + x 3 = ɛf cos(ωt) ẋ = v v = x x 3 + ɛ( γv + F cos(ωt)). In the

More information

Discrete Fourier transform (DFT)

Discrete Fourier transform (DFT) Discrete Fourier transform (DFT) Signal Processing 2008/9 LEA Instituto Superior Técnico Signal Processing LEA (IST) Discrete Fourier transform 1 / 34 Periodic signals Consider a periodic signal x[n] with

More information

Acoustic holography. LMS Test.Lab. Rev 12A

Acoustic holography. LMS Test.Lab. Rev 12A Acoustic holography LMS Test.Lab Rev 12A Copyright LMS International 2012 Table of Contents Chapter 1 Introduction... 5 Chapter 2... 7 Section 2.1 Temporal and spatial frequency... 7 Section 2.2 Time

More information

COMP 546, Winter 2018 lecture 19 - sound 2

COMP 546, Winter 2018 lecture 19 - sound 2 Sound waves Last lecture we considered sound to be a pressure function I(X, Y, Z, t). However, sound is not just any function of those four variables. Rather, sound obeys the wave equation: 2 I(X, Y, Z,

More information

Signals and Systems. Problem Set: The z-transform and DT Fourier Transform

Signals and Systems. Problem Set: The z-transform and DT Fourier Transform Signals and Systems Problem Set: The z-transform and DT Fourier Transform Updated: October 9, 7 Problem Set Problem - Transfer functions in MATLAB A discrete-time, causal LTI system is described by the

More information

Perturbation Theory: Why do /i/ and /a/ have the formants they have? Wednesday, March 9, 16

Perturbation Theory: Why do /i/ and /a/ have the formants they have? Wednesday, March 9, 16 Perturbation Theory: Why do /i/ and /a/ have the formants they have? Components of Oscillation 1. Springs resist displacement from rest position springs return to rest position ẋ = k(x x 0 ) Stiffness

More information

Problem Set 9 Solutions

Problem Set 9 Solutions Problem Set 9 Solutions EE23: Digital Signal Processing. From Figure below, we see that the DTFT of the windowed sequence approaches the actual DTFT as the window size increases. Gibb s phenomenon is absent

More information

! Spectral Analysis with DFT. ! Windowing. ! Effect of zero-padding. ! Time-dependent Fourier transform. " Aka short-time Fourier transform

! Spectral Analysis with DFT. ! Windowing. ! Effect of zero-padding. ! Time-dependent Fourier transform.  Aka short-time Fourier transform Lecture Outline ESE 531: Digital Signal Processing Spectral Analysis with DFT Windowing Lec 24: April 18, 2019 Spectral Analysis Effect of zero-padding Time-dependent Fourier transform " Aka short-time

More information

APPLIED SIGNAL PROCESSING

APPLIED SIGNAL PROCESSING APPLIED SIGNAL PROCESSING DIGITAL FILTERS Digital filters are discrete-time linear systems { x[n] } G { y[n] } Impulse response: y[n] = h[0]x[n] + h[1]x[n 1] + 2 DIGITAL FILTER TYPES FIR (Finite Impulse

More information

OSE801 Engineering System Identification. Lecture 05: Fourier Analysis

OSE801 Engineering System Identification. Lecture 05: Fourier Analysis 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 1 Fourier Analysis

More information

EEO 401 Digital Signal Processing Prof. Mark Fowler

EEO 401 Digital Signal Processing Prof. Mark Fowler EEO 401 Digital Signal Processing Prof. Mark Fowler Note Set #21 Using the DFT to Implement FIR Filters Reading Assignment: Sect. 7.3 of Proakis & Manolakis Motivation: DTFT View of Filtering There are

More information

Fourier Series and the DFT

Fourier Series and the DFT Laboratory 4 June 10, 2002, Release v3.0 EECS 206 Laboratory 4 Fourier Series and the DF 4.1 Introduction As emphasized in the previous lab, sinusoids are an important part of signal analysis. We noted

More information

L8: Source estimation

L8: Source estimation L8: Source estimation Glottal and lip radiation models Closed-phase residual analysis Voicing/unvoicing detection Pitch detection Epoch detection This lecture is based on [Taylor, 2009, ch. 11-12] Introduction

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

Design Criteria for the Quadratically Interpolated FFT Method (I): Bias due to Interpolation

Design Criteria for the Quadratically Interpolated FFT Method (I): Bias due to Interpolation CENTER FOR COMPUTER RESEARCH IN MUSIC AND ACOUSTICS DEPARTMENT OF MUSIC, STANFORD UNIVERSITY REPORT NO. STAN-M-4 Design Criteria for the Quadratically Interpolated FFT Method (I): Bias due to Interpolation

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

Transforms and Orthogonal Bases

Transforms and Orthogonal Bases Orthogonal Bases Transforms and Orthogonal Bases We now turn back to linear algebra to understand transforms, which map signals between different domains Recall that signals can be interpreted as vectors

More information

Very useful for designing and analyzing signal processing systems

Very useful for designing and analyzing signal processing systems z-transform z-transform The z-transform generalizes the Discrete-Time Fourier Transform (DTFT) for analyzing infinite-length signals and systems Very useful for designing and analyzing signal processing

More information

ELEG 305: Digital Signal Processing

ELEG 305: Digital Signal Processing ELEG 305: Digital Signal Processing Lecture : Design of Digital IIR Filters (Part I) Kenneth E. Barner Department of Electrical and Computer Engineering University of Delaware Fall 008 K. E. Barner (Univ.

More information

3 THE P HYSICS PHYSICS OF SOUND

3 THE P HYSICS PHYSICS OF SOUND Chapter 3 THE PHYSICS OF SOUND Contents What is sound? What is sound wave?» Wave motion» Source & Medium How do we analyze sound?» Classifications» Fourier Analysis How do we measure sound?» Amplitude,

More information

Discrete Fourier transform (DFT)

Discrete Fourier transform (DFT) Discrete Fourier transform (DFT) Alejandro Ribeiro January 19, 2018 Let x : [0, N 1] C be a discrete signal of duration N and having elements x(n) for n [0, N 1]. The discrete Fourier transform (DFT) of

More information