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

Size: px
Start display at page:

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

Transcription

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

2 Introduction and Motivation In practical applications, many the frequency content of signals changes over time These signals are often described as nonstationary In order to apply the techniques, we usually assume the signal statistics change slowly Locally stationary Rate of change depends on the process Spectrograms estimate how these properties change with time J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

3 x[n] = 1 π Practical Application X(e jω ) e jωn dω X(e jω ) = π + n= x[n] e jωn In practice, time-frequency analysis is most frequently performed by displaying the squared magnitude of segments of the signal Often called sliding windows Resulting DTFT s are a function of two independent variables: time and frequency X(e jω, n) = n+n/ k=n N/ w[k]x[k] e jωk where w[k] is a user-specified window function J. McNames Portland State University ECE 3 Spectrograms Ver

4 Comments on Spectrograms X(e jω, n) = n+n/ k=n N/ w[k]x[k] e jωk The spectrogram only shows the magnitude X(e jω, n) or the squared magnitude X(e jω, n) The squared magnitude can be interpreted as an estimate of the power spectral density (PSD) The phase is never plotted No clear means of interpretation Typically represented with three-dimensional meshes, contour plots, or pseudo-colored images When used to estimate the time-varying PSD, are called spectrograms or short-time Fourier transforms (STFT) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

5 Example 1: Chirp Spectrogram Apply the windowed DTFT to a chirp signal with a linear frequency sweep from 1 1 Hz over a period of s. J. McNames Portland State University ECE 3 Spectrograms Ver

6 Example 1: Chirp Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

7 Example 1: Chirp Spectrogram T w =.5 s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

8 Example 1: Chirp Spectrogram T w = 1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

9 Example 1: Chirp Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

10 Example 1: Chirp Spectrogram T w = 5. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

11 Example 1: Chirp Spectrogram T w =1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

12 Example 1: Chirp Spectrogram T w =15. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

13 J. McNames Portland State University ECE 3 Spectrograms Ver

14 Example 1: Relevant MATLAB Code clear; close all; %============================================================================== % User- Specified Parameters %============================================================================== fs = ; % Sample rate (Hz) T = ; % Signal duration (s) f = [1 1]; % Chirp frequencies [start stop] Tw = [ ]; % Window lengths k = 1:T*fs; t = (k-.5)/fs; % Discrete time index % Sample times (s) %============================================================================== % Preprocessing %============================================================================== functionname = sprintf( %s,mfilename); % Get the function name %============================================================================== % Main Loop %============================================================================== for c=1: % DEBUG switch c case 1, x = chirp(t,f(1),t,f()); sg = Chirp ; J. McNames Portland State University ECE 3 Spectrograms Ver

15 end case, x = cos(*pi*5*t); sg = Cosine ; case 3, [jnk,id] = min(abs(t-t/)); x = zeros(length(k),1); x(id) = 1; sg = Impulse ; case, id = find(t>t/); x = zeros(length(k),1); x(id) = 1; sg = UnitStep ; case 5, id = 1:1*fs:max(k); x = zeros(length(k),1); x(id) = 1; sg = ImpulseTrain ; case, x = randn(length(k),1); sg = WhiteNoise ; fileidentifier = fopen([functionname - sg.tex ], w ); for c1=1:length(tw), tw = Tw(c1); [S,ts,f] = NonparametricSpectrogram(x,fs,tw); figure; FigureSet(1, Slides ); J. McNames Portland State University ECE 3 Spectrograms Ver

16 I = abs(s).^; cr = prctile(reshape(i,prod(size(i)),1),[ ]); ha = axes( Position,[ ]); h = imagesc(ts,f,abs(s).^,cr); hold on; h = plot(tw/*[1 1],[ fs/], k,tw/*[1 1],[ fs/], w ); set(h(1), LineWidth,); set(h(), LineWidth,1); h = plot((t-tw/)*[1 1],[ fs/], k,(t-tw/)*[1 1],[ fs/], w ); set(h(1), LineWidth,); set(h(), LineWidth,1); hold off; set(gca, YDir, Normal ); set(gca, XAxisLocation, Top ); set(gca, YAxisLocation, Right ); xlim([ T]); ylim([ fs/]); %ht = title(sprintf( %s Signal T_w=%.1f s,sg,tw)); ha = axes( Position,[ ]); h = plot((k-.5)/fs,x, b ); set(h, LineWidth,.5); xlim([ T]); set(ha, YTick,[]) xlabel( Time (s) ); ha = axes( Position,[ ]); Rx = mean(i,); h = plot(rx,f, r ); set(h, LineWidth,.5); ylim([ fs/]); J. McNames Portland State University ECE 3 Spectrograms Ver

17 set(ha, XTick,[]) ylabel( ); AxisSet(); %set(ht, VerticalAlignment, Top ) end filename = sprintf( %s-%s-window%d,functionname,sg,c1); print(filename, -depsc ); fprintf(fileidentifier, %%========================================================================= fprintf(fileidentifier, \\newslide\n ); fprintf(fileidentifier, \\slideheading{example \\arabic{exc}: %s Spectrogram $T_w$=%.1f s}\n,sg,t fprintf(fileidentifier, %%========================================================================= fprintf(fileidentifier, \\includegraphics[scale=1]{matlab/%s}\n,filename); %print(sprintf( %sex%3d,sg,tw*1), -depsc ); end fclose(fileidentifier); J. McNames Portland State University ECE 3 Spectrograms Ver

18 Why the Windowed Periodogram? Why window the segments? Could use a rectangular window If tapered window is not applied, estimate will vary even if the signal is a constant sinusoid Due to variation of phase of sinusoid that is included in the segment (covered by the window) Taper reduces this effect Also reduces sidelobe leakage (more later) J. McNames Portland State University ECE 3 Spectrograms Ver

19 Filter Bank Interpretation X(e jω, n) = x(n + l)w(l)e jωl = = l= m= m= x(m)w(m n)e jω(m n) x(m)w( (n m))e jω(n m) = x(n) w( n)e jωn The spectrogram can be thought of as the squared magnitude of the output of an LTI system with impulse response h Ω (n) = w( n)e jωn The magnitude response evaluated at Ω o is then W ( e j(ω o Ω) ) J. McNames Portland State University ECE 3 Spectrograms Ver

20 Filter Bank Frequency Responses without Padding FFT Filters Blackman Window L=17 P= W(e j ω ) Frequency (radians/sample) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

21 Effect of Zero Padding.5 Time Domain 3 Frequency Domain 1 points points (11 zeros) Frequency Domain J. McNames Portland State University ECE 3 Spectrograms Ver

22 Filter Bank Frequency Responses with Padding FFT Filters Blackman Window L=17 P=3 1 1 W(e j ω ) Frequency (radians/sample) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

23 Primary Tradeoff: Segment Length Primary purpose of windowing is to guarantee local stationarity Window shape controls tradeoff between sidelobe leakage and main lob width Primary parameter is the window length Long window Poor time resolution Good frequency resolution Use with slowly varying signal characteristics Short window Good time resolution Poor frequency resolution Use with rapidly changing signal characteristics Thus L primarily controls the tradeoff between time and frequency resolution J. McNames Portland State University ECE 3 Spectrograms Ver

24 Uncertainty Principle Let σ t,x represent the duration of a signal and σ Ω,x represent the bandwidth of a signal. It can be shown that σ t,x σ Ω,x 1 In this context, it is not actually an expression of uncertainty Signals with short duration have broad bandwidth Signals with long duration can have narrow bandwidth Equivalently, if one density is narrow then the other is wide They can t both be arbitrarily narrow In quantum mechanics, applies to probability densities of position and velocity so uncertainty is appropriate J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

25 Time Bandwidth Product L=33 Windowed Sinusoid ω =. rad/sample X(e jω 1 5 Frequency Domain 1 3 L=5 L= Sample Index (n) X(e jω X(e jω Frequency (rad/sec) J. McNames Portland State University ECE 3 Spectrograms Ver

26 MATLAB Code %function [] = TimeBandwidthEx(); close all; NZ = ^1; w = pi/5; L = [3 1]+1; nl = length(l); k = (:NZ-1) ; w = k**pi/nz; kw = 1:NZ/; l = 11; wn = blackman(l); wn = wn*sqrt(l/sum(wn.^)); n = (-(l-1)/:(l-1)/) ; x = cos(w*n).*wn; ymx = max(x); ymn = min(x); yrg = ymx-ymn; figure; FigureSet(1, LTX ); for c1=1:nl, l = L(c1); n = (-(l-1)/:(l-1)/) ; J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

27 wn = blackman(l+); wn = wn(:end-1); % Trim off the zeros wn = wn*sqrt(l/sum(wn.^)); % Scale appropriately x = cos(w*n).*wn; % Windowed signal segment X = exp(j*(l-1)/*w).*fft(x,nz); % Calculate frequency response %disp(max(imag(x))); X = real(x); % Eliminate imaginary part due to finite resolution subplot(nl,,c1*-1); h = plot(n,x); xlim([-max(l) max(l)]); ylim([ymn-.5*yrg ymx+.5*yrg]); AxisLines; box off; ylabel(sprintf( L=%d,l)); if c1==1, title(sprintf( Windowed Sinusoid \\omega_=%5.3f rad/sample,w)); elseif c1==nl, xlabel( Sample Index (n) ); end; subplot(nl,,c1*); h = plot(w(kw),x(kw), r ); xlim([ pi]); ylim([ 1.5*max(X)]); AxisLines; ylabel( X(e^{j\omega} ); box off; if c1==1, title( Frequency Domain ); elseif c1==nl, xlabel( Frequency (rad/sec) ); end; J. McNames Portland State University ECE 3 Spectrograms Ver

28 end; AxisSet(); print( TimeBandwidthEx, -depsc ); J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

29 Attaining the Uncertainty Principle The Gaussian function attains the uncertainty principle with equality x(t) = 1 t e σ πσ X(jΩ) = e Ω σ e x (t) = 1 πσ e t σ E x (Ω) = σ t,x = σ σ Ω,x = 1 σ 1 πσ 1 e Ω σ σ t,x σ Ω,x = 1 If this has the best duration-bandwidth product (i.e., resolution), why don t we use this as a window? J. McNames Portland State University ECE 3 Spectrograms Ver

30 Practical Implementation of Spectrograms Remove the signal mean (center the signal) Apply a highpass filter, if necessary The MATLAB implementation is not very good Time and frequency resolution should not exceed that of the display Use sufficient zero padding and time resolution Make user-specified parameters Do not ask for degree of overlap - calculate it Edge effects Notify user of the extent of edge effects Handle edges elegantly (repeat last value, extrapolate by prediction, etc.) J. McNames Portland State University ECE 3 Spectrograms Ver

31 Example : Cosine, Impulse, and Step Spectrograms Repeat the previous example for a 5 Hz sinusoidal signal, the unit impulse at t = 1 s, and the unit step starting at t = 1 s. J. McNames Portland State University ECE 3 Spectrograms Ver

32 Example : Cosine Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

33 Example : Cosine Spectrogram T w =.5 s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

34 Example : Cosine Spectrogram T w = 1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

35 Example : Cosine Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

36 Example : Cosine Spectrogram T w = 5. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

37 Example : Cosine Spectrogram T w =1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

38 Example : Cosine Spectrogram T w =15. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

39 J. McNames Portland State University ECE 3 Spectrograms Ver

40 Example : Impulse Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

41 Example : Impulse Spectrogram T w =.5 s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

42 Example : Impulse Spectrogram T w = 1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

43 Example : Impulse Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

44 Example : Impulse Spectrogram T w = 5. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

45 Example : Impulse Spectrogram T w =1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

46 Example : Impulse Spectrogram T w =15. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

47 J. McNames Portland State University ECE 3 Spectrograms Ver

48 Periodic Signals Periodic signals consist of frequency components only at multiples of the fundamental frequency If the window length is smaller than the fundamental period, these areas analyzed as discrete events (insufficient frequency resolution) If the window length is several times the fundamental period, these areas appear to be periodic J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

49 Example 3: Impulse Train Spectrograms Repeat the previous example for a 1 Hz impulse train. J. McNames Portland State University ECE 3 Spectrograms Ver

50 Example 3: ImpulseTrain Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

51 Example 3: ImpulseTrain Spectrogram T w =.5 s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

52 Example 3: ImpulseTrain Spectrogram T w = 1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

53 Example 3: ImpulseTrain Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

54 Example 3: ImpulseTrain Spectrogram T w = 5. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

55 Example 3: ImpulseTrain Spectrogram T w =1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

56 Example 3: ImpulseTrain Spectrogram T w =15. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

57 J. McNames Portland State University ECE 3 Spectrograms Ver

58 Random Signals It s important to be able to distinguish significant features from random fluctuations due to estimation error White noise is a signal with random sample values Often, but not necessarily, from a Gaussian distribution Helpful to examine the spectrograms of white noise J. McNames Portland State University ECE 3 Spectrograms Ver

59 Example : White Noise Spectrograms Repeat the previous example for a white noise signal. J. McNames Portland State University ECE 3 Spectrograms Ver

60 Example : WhiteNoise Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

61 Example : WhiteNoise Spectrogram T w =.5 s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

62 Example : WhiteNoise Spectrogram T w = 1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

63 Example : WhiteNoise Spectrogram T w =. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

64 Example : WhiteNoise Spectrogram T w = 5. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

65 Example : WhiteNoise Spectrogram T w =1. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

66 Example : WhiteNoise Spectrogram T w =15. s Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

67 J. McNames Portland State University ECE 3 Spectrograms Ver

68 Example 5: Detecting Sleep Apnea Can obstructive sleep apnea be detected from the electrocardiogram alone? If possible, could build simple and cheap, portable diagnostic device International competition in Data set 5 recordings labelled by expert 1 unlabelled recording Approximately hours each Objective: detect OSA for every minute of the 1 recordings J. McNames Portland State University ECE 3 Spectrograms Ver. 1.1

69 Example 5: Detecting Sleep Apnea Our approach was based on spectrograms Implemented QRS detector Applied spectrogram to instantaneous heart rate and other features Interbeat intervals (R-R) S amplitude Pulse energy Winning entry! 9.% of minutes classified correctly Third attempt J. McNames Portland State University ECE 3 Spectrograms Ver

70 Example 5: Apnea Detection Sleep Apnea fs:. Hz WL:5 s Signal Time (min) J. McNames Portland State University ECE 3 Spectrograms Ver

71 Example : Arterial Blood Pressure Generate the spectrogram of an arterial blood pressure signal from a child in an intensive care unit (ICU) with sepsis. Interpret the figure. J. McNames Portland State University ECE 3 Spectrograms Ver

72 ABP (mmhg) Example : ABP Spectrogram ) Respiration Fundamental Respiration Second Harmonic Cardiac Second Harmonic ) Amplitude Cardiac Modulation Fundamental 3) Frequency Modulation Time (s) J. McNames Portland State University ECE 3 Spectrograms Ver

73 Example 7: ABP and ICP Generate the spectrogram of arterial blood pressure and intracranial pressure signals from a child with traumatic brain injury. J. McNames Portland State University ECE 3 Spectrograms Ver

74 Example 7: ABP and ICP 3 ICP (mmhg) ABP (mmhg) Time (min) J. McNames Portland State University ECE 3 Spectrograms Ver

75 Example 7: ABP and ICP ICP (mmhg) L=. s 1 ABP (mmhg) L=. s J. McNames Portland State University ECE 3 Spectrograms Ver

76 Example 7: ABP and ICP 1 1 ICP Time (min) ABP Time (min) J. McNames Portland State University ECE 3 Spectrograms Ver

77 Other Estimators Spectrograms (and their generalizations) is a topic that warrants an entire class itself There are many estimators of how power is distributed across time and frequency Includes wavelets ( scaleograms ) J. McNames Portland State University ECE 3 Spectrograms Ver

78 Summary Moving window estimates can be used to perform spectrogram analysis of locally stationary signals Window length is the most critical parameter Controls tradeoff between time and frequency resolution Duration-bandwidth product is limited by the uncertainty principle Can apply to joint estimation techniques as well Very useful for observing time-varying statistical properties J. McNames Portland State University ECE 3 Spectrograms Ver

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

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

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

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

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

More information

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

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

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

More information

x(n) = a k x(n k)+w(n) k=1

x(n) = a k x(n k)+w(n) k=1 Autoregressive Models Overview Direct structures Types of estimators Parametric spectral estimation Parametric time-frequency analysis Order selection criteria Lattice structures? Maximum entropy Excitation

More information

J. McNames Portland State University ECE 223 Sampling Ver

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

More information

Overview of Sampling Topics

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

More information

Assignment 4 Solutions Continuous-Time Fourier Transform

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

More information

Introduction. Spectral Estimation Overview Periodogram Bias, variance, and distribution Blackman-Tukey Method Welch-Bartlett Method Others

Introduction. Spectral Estimation Overview Periodogram Bias, variance, and distribution Blackman-Tukey Method Welch-Bartlett Method Others Spectral Estimation Overview Periodogram Bias, variance, and distribution Blackman-Tukey Method Welch-Bartlett Method Others Introduction R x (e jω ) r x (l)e jωl l= Most stationary random processes have

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

Change in Notation. e (i) (n) Note that this is inconsistent with the notation used earlier, c k+1x(n k) e (i) (n) x(n i) ˆx(n i) M

Change in Notation. e (i) (n) Note that this is inconsistent with the notation used earlier, c k+1x(n k) e (i) (n) x(n i) ˆx(n i) M Overview of Linear Prediction Terms and definitions Nonstationary case Stationary case Forward linear prediction Backward linear prediction Stationary processes Exchange matrices Examples Properties Introduction

More information

Elec4621 Advanced Digital Signal Processing Chapter 11: Time-Frequency Analysis

Elec4621 Advanced Digital Signal Processing Chapter 11: Time-Frequency Analysis Elec461 Advanced Digital Signal Processing Chapter 11: Time-Frequency Analysis Dr. D. S. Taubman May 3, 011 In this last chapter of your notes, we are interested in the problem of nding the instantaneous

More information

x n C l 1 u n C m 1 y n C p 1 v n C p 1

x n C l 1 u n C m 1 y n C p 1 v n C p 1 Kalman Filter Derivation Examples Time and Measurement Updates x u n v n, State Space Model Review x n+ = F n x n + G n u n x u k v k y n = H n x n + v n Π = Q n δ nk S n δ nk Snδ nk R n δ nk F n C l l

More information

Extended Kalman Filter Derivation Example application: frequency tracking

Extended Kalman Filter Derivation Example application: frequency tracking Extended Kalman Filter Derivation Example application: frequency tracking Nonlinear State Space Model Consider the nonlinear state-space model of a random process x n+ = f n (x n )+g n (x n )u n y n =

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

Probability Space. J. McNames Portland State University ECE 538/638 Stochastic Signals Ver

Probability Space. J. McNames Portland State University ECE 538/638 Stochastic Signals Ver Stochastic Signals Overview Definitions Second order statistics Stationarity and ergodicity Random signal variability Power spectral density Linear systems with stationary inputs Random signal memory Correlation

More information

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

The Z-Transform. For a phasor: X(k) = e jωk. We have previously derived: Y = H(z)X 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)).

More information

Practical Spectral Estimation

Practical Spectral Estimation Digital Signal Processing/F.G. Meyer Lecture 4 Copyright 2015 François G. Meyer. All Rights Reserved. Practical Spectral Estimation 1 Introduction The goal of spectral estimation is to estimate how the

More information

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

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

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science : Discrete-Time Signal Processing

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science : Discrete-Time Signal Processing Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.34: Discrete-Time Signal Processing OpenCourseWare 006 ecture 8 Periodogram Reading: Sections 0.6 and 0.7

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

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

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

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

More information

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

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

! 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

TTT4120 Digital Signal Processing Suggested Solutions for Problem Set 2

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

More information

EE123 Digital Signal Processing

EE123 Digital Signal Processing EE123 Digital Signal Processing Lecture 1 Time-Dependent FT Announcements! Midterm: 2/22/216 Open everything... but cheat sheet recommended instead 1am-12pm How s the lab going? Frequency Analysis with

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

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

II. Nonparametric Spectrum Estimation for Stationary Random Signals - Non-parametric Methods -

II. Nonparametric Spectrum Estimation for Stationary Random Signals - Non-parametric Methods - II. onparametric Spectrum Estimation for Stationary Random Signals - on-parametric Methods - - [p. 3] Periodogram - [p. 12] Periodogram properties - [p. 23] Modified periodogram - [p. 25] Bartlett s method

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

Terminology Suppose we have N observations {x(n)} N 1. Estimators as Random Variables. {x(n)} N 1

Terminology Suppose we have N observations {x(n)} N 1. Estimators as Random Variables. {x(n)} N 1 Estimation Theory Overview Properties Bias, Variance, and Mean Square Error Cramér-Rao lower bound Maximum likelihood Consistency Confidence intervals Properties of the mean estimator Properties of the

More information

Nonparametric and Parametric Defined This text distinguishes between systems and the sequences (processes) that result when a WN input is applied

Nonparametric and Parametric Defined This text distinguishes between systems and the sequences (processes) that result when a WN input is applied Linear Signal Models Overview Introduction Linear nonparametric vs. parametric models Equivalent representations Spectral flatness measure PZ vs. ARMA models Wold decomposition Introduction Many researchers

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

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this:

Lecture 17: variance in a band = log(s xx (f)) df (2) If we want to plot something that is more directly representative of variance, we can try this: UCSD SIOC 221A: (Gille) 1 Lecture 17: Recap We ve now spent some time looking closely at coherence and how to assign uncertainties to coherence. Can we think about coherence in a different way? There are

More information

Introduction to time-frequency analysis Centre for Doctoral Training in Healthcare Innovation

Introduction to time-frequency analysis Centre for Doctoral Training in Healthcare Innovation Introduction to time-frequency analysis Centre for Doctoral Training in Healthcare Innovation Dr. Gari D. Clifford, University Lecturer & Director, Centre for Doctoral Training in Healthcare Innovation,

More information

Definition of Discrete-Time Fourier Transform (DTFT)

Definition of Discrete-Time Fourier Transform (DTFT) Definition of Discrete-Time ourier Transform (DTT) {x[n]} = X(e jω ) + n= {X(e jω )} = x[n] x[n]e jωn Why use the above awkward notation for the transform? X(e jω )e jωn dω Answer: It is consistent with

More information

From Fourier Series to Analysis of Non-stationary Signals - X

From Fourier Series to Analysis of Non-stationary Signals - X From Fourier Series to Analysis of Non-stationary Signals - X prof. Miroslav Vlcek December 14, 21 Contents Stationary and non-stationary 1 Stationary and non-stationary 2 3 Contents Stationary and non-stationary

More information

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) =

Notes perso. - cb1 1. Version 3 - November u(t)e i2πft dt u(t) = Notes perso. - cb1 1 Tutorial : fft, psd & coherence with Matlab Version 3 - November 01 1 Fourier transform by Fast Fourier Transform (FFT) Definition of the Fourier transform : û(f) = F[u(t)] = As an

More information

Lecture 27 Frequency Response 2

Lecture 27 Frequency Response 2 Lecture 27 Frequency Response 2 Fundamentals of Digital Signal Processing Spring, 2012 Wei-Ta Chu 2012/6/12 1 Application of Ideal Filters Suppose we can generate a square wave with a fundamental period

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

Digital Signal Processing. Midterm 1 Solution

Digital Signal Processing. Midterm 1 Solution EE 123 University of California, Berkeley Anant Sahai February 15, 27 Digital Signal Processing Instructions Midterm 1 Solution Total time allowed for the exam is 8 minutes Some useful formulas: Discrete

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

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

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

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

Final Exam of ECE301, Prof. Wang s section 8 10am Tuesday, May 6, 2014, EE 129.

Final Exam of ECE301, Prof. Wang s section 8 10am Tuesday, May 6, 2014, EE 129. Final Exam of ECE301, Prof. Wang s section 8 10am Tuesday, May 6, 2014, EE 129. 1. Please make sure that it is your name printed on the exam booklet. Enter your student ID number, e-mail address, and signature

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

Complex symmetry Signals and Systems Fall 2015

Complex symmetry Signals and Systems Fall 2015 18-90 Signals and Systems Fall 015 Complex symmetry 1. Complex symmetry This section deals with the complex symmetry property. As an example I will use the DTFT for a aperiodic discrete-time signal. The

More information

6.003: Signal Processing

6.003: Signal Processing 6.003: Signal Processing Discrete Fourier Transform Discrete Fourier Transform (DFT) Relations to Discrete-Time Fourier Transform (DTFT) Relations to Discrete-Time Fourier Series (DTFS) October 16, 2018

More information

OLA and FBS Duality Review

OLA and FBS Duality Review OLA and FBS Duality Review MUS421/EE367B Lecture 10A Review of OverLap-Add (OLA) and Filter-Bank Summation (FBS) Interpretations of Short-Time Fourier Analysis, Modification, and Resynthesis Julius O.

More information

OLA and FBS Duality Review

OLA and FBS Duality Review MUS421/EE367B Lecture 10A Review of OverLap-Add (OLA) and Filter-Bank Summation (FBS) Interpretations of Short-Time Fourier Analysis, Modification, and Resynthesis Julius O. Smith III (jos@ccrma.stanford.edu)

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

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

Chap 2. Discrete-Time Signals and Systems

Chap 2. Discrete-Time Signals and Systems Digital Signal Processing Chap 2. Discrete-Time Signals and Systems Chang-Su Kim Discrete-Time Signals CT Signal DT Signal Representation 0 4 1 1 1 2 3 Functional representation 1, n 1,3 x[ n] 4, n 2 0,

More information

Introduction to Time-Frequency Distributions

Introduction to Time-Frequency Distributions Introduction to Time-Frequency Distributions Selin Aviyente Department of Electrical and Computer Engineering Michigan State University January 19, 2010 Motivation for time-frequency analysis When you

More information

Aspects of Continuous- and Discrete-Time Signals and Systems

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

More information

Assignment 2 Solutions Fourier Series

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

More information

CHAPTER 2 RANDOM PROCESSES IN DISCRETE TIME

CHAPTER 2 RANDOM PROCESSES IN DISCRETE TIME CHAPTER 2 RANDOM PROCESSES IN DISCRETE TIME Shri Mata Vaishno Devi University, (SMVDU), 2013 Page 13 CHAPTER 2 RANDOM PROCESSES IN DISCRETE TIME When characterizing or modeling a random variable, estimates

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

-Digital Signal Processing- FIR Filter Design. Lecture May-16

-Digital Signal Processing- FIR Filter Design. Lecture May-16 -Digital Signal Processing- FIR Filter Design Lecture-17 24-May-16 FIR Filter Design! FIR filters can also be designed from a frequency response specification.! The equivalent sampled impulse response

More information

Fourier Representations of Signals & LTI Systems

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

More information

I. Signals & Sinusoids

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

More information

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

ECE-314 Fall 2012 Review Questions for Midterm Examination II

ECE-314 Fall 2012 Review Questions for Midterm Examination II ECE-314 Fall 2012 Review Questions for Midterm Examination II First, make sure you study all the problems and their solutions from homework sets 4-7. Then work on the following additional problems. Problem

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

Final Exam of ECE301, Prof. Wang s section 1 3pm Tuesday, December 11, 2012, Lily 1105.

Final Exam of ECE301, Prof. Wang s section 1 3pm Tuesday, December 11, 2012, Lily 1105. Final Exam of ECE301, Prof. Wang s section 1 3pm Tuesday, December 11, 2012, Lily 1105. 1. Please make sure that it is your name printed on the exam booklet. Enter your student ID number, e-mail address,

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

Final Exam January 31, Solutions

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

More information

CHAPTER 7. The Discrete Fourier Transform 436

CHAPTER 7. The Discrete Fourier Transform 436 CHAPTER 7. The Discrete Fourier Transform 36 hfa figconfg( P7a, long ); subplot() stem(k,abs(ck), filled );hold on stem(k,abs(ck_approx), filled, color, red ); xlabel( k, fontsize,lfs) title( Magnitude

More information

Contents. Digital Signal Processing, Part II: Power Spectrum Estimation

Contents. Digital Signal Processing, Part II: Power Spectrum Estimation Contents Digital Signal Processing, Part II: Power Spectrum Estimation 5. Application of the FFT for 7. Parametric Spectrum Est. Filtering and Spectrum Estimation 7.1 ARMA-Models 5.1 Fast Convolution 7.2

More information

3.2 Complex Sinusoids and Frequency Response of LTI Systems

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

More information

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

Chapter 5 Frequency Domain Analysis of Systems

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

More information

Discrete Time Fourier Transform (DTFT)

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

More information

DSP-I DSP-I DSP-I DSP-I

DSP-I DSP-I DSP-I DSP-I NOTES FOR 8-79 LECTURES 3 and 4 Introduction to Discrete-Time Fourier Transforms (DTFTs Distributed: September 8, 2005 Notes: This handout contains in brief outline form the lecture notes used for 8-79

More information

Digital Signal Processing Lecture 3 - Discrete-Time Systems

Digital Signal Processing Lecture 3 - Discrete-Time Systems Digital Signal Processing - Discrete-Time Systems Electrical Engineering and Computer Science University of Tennessee, Knoxville August 25, 2015 Overview 1 2 3 4 5 6 7 8 Introduction Three components of

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

8 The Discrete Fourier Transform (DFT)

8 The Discrete Fourier Transform (DFT) 8 The Discrete Fourier Transform (DFT) ² Discrete-Time Fourier Transform and Z-transform are de ned over in niteduration sequence. Both transforms are functions of continuous variables (ω and z). For nite-duration

More information

Each problem is worth 25 points, and you may solve the problems in any order.

Each problem is worth 25 points, and you may solve the problems in any order. EE 120: Signals & Systems Department of Electrical Engineering and Computer Sciences University of California, Berkeley Midterm Exam #2 April 11, 2016, 2:10-4:00pm Instructions: There are four questions

More information

Random signals II. ÚPGM FIT VUT Brno,

Random signals II. ÚPGM FIT VUT Brno, Random signals II. Jan Černocký ÚPGM FIT VUT Brno, cernocky@fit.vutbr.cz 1 Temporal estimate of autocorrelation coefficients for ergodic discrete-time random process. ˆR[k] = 1 N N 1 n=0 x[n]x[n + k],

More information

Lab 4: Quantization, Oversampling, and Noise Shaping

Lab 4: Quantization, Oversampling, and Noise Shaping Lab 4: Quantization, Oversampling, and Noise Shaping Due Friday 04/21/17 Overview: This assignment should be completed with your assigned lab partner(s). Each group must turn in a report composed using

More information

Test 2 Electrical Engineering Bachelor Module 8 Signal Processing and Communications

Test 2 Electrical Engineering Bachelor Module 8 Signal Processing and Communications Test 2 Electrical Engineering Bachelor Module 8 Signal Processing and Communications (201400432) Tuesday May 26, 2015, 14:00-17:00h This test consists of three parts, corresponding to the three courses

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

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

ELEN 4810 Midterm Exam

ELEN 4810 Midterm Exam ELEN 4810 Midterm Exam Wednesday, October 26, 2016, 10:10-11:25 AM. One sheet of handwritten notes is allowed. No electronics of any kind are allowed. Please record your answers in the exam booklet. Raise

More information

Solutions for examination in TSRT78 Digital Signal Processing,

Solutions for examination in TSRT78 Digital Signal Processing, Solutions for examination in TSRT78 Digital Signal Processing, 2014-04-14 1. s(t) is generated by s(t) = 1 w(t), 1 + 0.3q 1 Var(w(t)) = σ 2 w = 2. It is measured as y(t) = s(t) + n(t) where n(t) is white

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

Chapter 7: The z-transform

Chapter 7: The z-transform Chapter 7: The -Transform ECE352 1 The -Transform - definition Continuous-time systems: e st H(s) y(t) = e st H(s) e st is an eigenfunction of the LTI system h(t), and H(s) is the corresponding eigenvalue.

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

The Discrete-Time Fourier

The Discrete-Time Fourier Chapter 3 The Discrete-Time Fourier Transform 清大電機系林嘉文 cwlin@ee.nthu.edu.tw 03-5731152 Original PowerPoint slides prepared by S. K. Mitra 3-1-1 Continuous-Time Fourier Transform Definition The CTFT of

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

Let x(t) be a finite energy signal with Fourier transform X(jω). Let E denote the energy of the signal. Thus E <. We have.

Let x(t) be a finite energy signal with Fourier transform X(jω). Let E denote the energy of the signal. Thus E <. We have. Notes on the Uncertainty principle Let x(t) be a finite energy signal with Fourier transform X(jω). Let E denote the energy of the signal. Thus E

More information

Review of Fundamentals of Digital Signal Processing

Review of Fundamentals of Digital Signal Processing Solution Manual for Theory and Applications of Digital Speech Processing by Lawrence Rabiner and Ronald Schafer Click here to Purchase full Solution Manual at http://solutionmanuals.info Link download

More information

6.003: Signals and Systems. Sampling and Quantization

6.003: Signals and Systems. Sampling and Quantization 6.003: Signals and Systems Sampling and Quantization December 1, 2009 Last Time: Sampling and Reconstruction Uniform sampling (sampling interval T ): x[n] = x(nt ) t n Impulse reconstruction: x p (t) =

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

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