Mathematical Foundations of Signal Processing

Size: px
Start display at page:

Download "Mathematical Foundations of Signal Processing"

Transcription

1 Mathematical Foundations of Signal Processing Module 4: Continuous-Time Systems and Signals Benjamín Béjar Haro Mihailo Kolundžija Reza Parhizkar Adam Scholefield October 24, 2016

2 Continuous Time Signals 1 Modeling Continuous Time Signals Functions Continuous Time Systems 2 Analyzing Continuous Time Signals Why do we need Transforms? Fourier Transforms Fourier Series

3 Modeling Continuous Time Signals

4 Functions Any observed signal can be considered as a function (the values of a function) Harmonic Signal For instance, if we play a tone with a violin, the signal we observe (we hear) can be modeled by a harmonic signal s(t) = K α k e j2πfkt, k=1 that is, linear combination of sinusoids with frequencies f 1,...,f K (see courses Statistical Signal Processing and Signal Processing for Audio & Acoustics) 4.1 4

5 Functions Harmonic SIgnal (ct d) s(t) = 5e i2πν0t +10e i2π4ν0t +2e i2π20ν0t +0.7e i2π200ν0t

6 Functions: Spaces Space of integrable functions L 1 (R) (required to apply integral tools) { } L 1 (R) = x(t) s.t. x(t) dt <. Note: f L 1 (R) is a sufficient condition to define R f(t)dt. Finite energy functions L 2 (R) (square integrable functions, a Hilbert space) { } L 2 (R) = x(t) s.t. x(t) 2 dt <. Note: Being in a Hilbert space is equivalent to observing quantities that make sense from a physical point of view signals of finite energy In case of periodic functions of period T, we rather consider L 1 ([ T/2,T/2)) and L 2 ([ T/2,T/2)) (absolutely and square absolutely integrable over the period) R R 4.1 6

7 Functions: Spaces Bounded functions L (R) (the magnitude of the signal is bounded) Recall that s(t) = esssup x(t). Notice that any measured quantity is t R bounded by the saturation level of the measuring instrument Space of smooth functions C p (continuously-differentiable functions), with p = 1,2,... Functions that are smooth, that is continuously differentiable up to the order p. Such notion is related to the bandwidth of the function (how fast the function varies) We should also mention piecewise smooth functions, i.e. functions that are smooth only on intervals 4.1 7

8 Piecewise smooth function: Linear interpolator Consider a finite sequences of (real) bounded values x 0,x 1,...,x K corresponding to the time instants 0,T,...,KT. For simplicity, we assume x 0 = x K = 0. The function that interpolates with lines such values is given by { x n +(t nt)(x n+1 x n ) nt t < (n+1)t, n = 0,...,K 1 x(t) = 0 t / [0,KT) Notice that, by construction, x(t) L 1 (R) L 2 (R) L (R)

9 Special Functions Dirac delta (generalized function) The Dirac delta is formally defined as δ(t) = 0, t 0 and f(t)δ(t)dt = f(0), with Why it is not a function? A function is defined point-wise; R R δ(t)dt = 1. If a function is 0 for every t 0 (i.e., zero almost everywhere), then its integral is 0, not 1. Ergo, δ(t) is a generalized function. Within the framework of this course, we can keep treating it as a function with not much risk, but for more complex signal models, a more precise definition is required (see course Mathematical Principles of Signal Processing). δ(t) is very handy to model: Events localized in time (spikes, impulses) Impulse response of a LSI system 4.1 9

10 Special Functions Heaviside function Another important function, particularly used in system theory, for instance to measure the response time of a system. The Heaviside function is defined as { 1 t 0; u(t) = 0 t < 0. Notice that the Dirac delta generalized function is commonly considered to be the derivative of the Heaviside function. Such a result is defined within a specific theory (distribution theory) and it is definitively not trivial

11 Special Functions Gaussian The Gaussian function is widely used: It has nice mathematical properties (Gaussian kernel) It models important physical phenomena such as diffusion It provides a good approximation, via the central limit theorem, of many other phenomena The Gaussian is a symmetric function with general form given by f(t) = γe α(t µ)2, where µ defines the symmetry point. By choosing α = 1/2σ 2, γ = 1/σ 2π the function is L 1 -normalized, i.e., f(t) L 1 = 1 and it can play the role of a probability density function

12 Deterministic correlation Deterministic autocorrelation a(τ) = Properties x(t)x (t τ)dt = x(t), x(t τ) t, τ R a(τ) = a ( τ), a(0) = Deterministic crosscorrelation c(τ) = x(t) 2 dt = x 2 x(t)y (t τ)dt = x(t), y(t τ) t, τ R Properties: ( ( ) c x,y(τ) = y(t τ)x (t)dt) = y(t )x (t +τ)dt = cy,x( τ)

13 Continuous Time Systems We are used to see a system as a box that outputs a certain function y(t) when fed by a function x(t) x T y We can actually elegantly formalize a system by considering it as an operator mapping an input function x V into an output function y V y = T(x) The function space V is typically L 2 (R) or L (R) Notice that a priori T is time-dependent

14 Types of Systems Definition (Linear system) A continuous-time system T is called linear when, for any inputs x and y and any α, β C, T(αx +βy) = αt(x)+βt(y) Definition (Memoryless system) A continuous-time system T is called memoryless when, for any real τ and inputs x and x, 1 {τ} x = 1 {τ} x 1 {τ} T(x) = 1 {τ} T(x ) Definition (Causal system) A continuous-time system T is called causal when, for any real τ and inputs x and x, 1 (,τ] x = 1 (,τ] x 1 (,τ] T(x) = 1 (,τ] T(x )

15 Types of Systems Definition (Shift-invariant system) A continuous-time system T is called shift invariant when, for any real τ and input x, y = T(x) y = T(x ), where x (t) = x(t τ) and y (t) = y(t τ) Definition (BIBO stable system) A continuous-time system T is called bounded-input bounded-output stable when a bounded input x produces a bounded output y = T(x): x L (R) y L (R)

16 Basic Systems Shift Modulator Integrator Averaging operators y(t) = x(t t 0 ) y(t) = e jω0t x(t) y(t) = t x(τ)dτ y(t) = 1 T t+t/2 t T/2 x(τ)dτ, t R

17 Systems: Differential Equation Linear constant-coefficient differential equations describe LSI systems and are of the form: M d k x(t) N d k y(t) y(t) = b k dt k a k dt k k=0 Solution y (h) (t) to the homogeneous equation obtained by setting the input x(t) to zero Particular solution y (p) (t) found typically by assuming the output to be of the same form as the input k=1 Complete solution formed by superposition of the solution to the homogeneous equation and the particular solution

18 Linear Shift-Invariant System Systems that are linear shift invariant (LSI) are the most important ones: Several physical systems (real world) can be modeled as such They have very nice properties, the salient one being that they can be be described via the impulse response h(t) Definition (Impulse response) δ(t) T h(t) A function h is called the impulse response of LSI continuous-time system T when input δ produces output h Remark: We are used to consider the impulse response as the output when the input is a Dirac impulse. We shall see that the definition of the impulse response of an LSI system finds it natural and most rigorous context in the transform domain

19 Linear Shift-Invariant System Convolution We can express an arbitrary input to LSI system T as x(t) = x(τ)δ(t τ)dτ The output resulting from this input is y = T x = T = x(τ)δ(t τ)dτ = x(τ)h(t τ)dτ = h x x(τ)tδ(t τ)dτ

20 Linear Shift-Invariant System Convolution Definition (Convolution) The convolution between functions h and x is defined as (Hx)(t) = (h x)(t) = x(τ)h(t τ)dτ = where H is called the convolution operator associated with h. x(t τ)h(τ)dτ, In signal processing framework, convolution operator is commonly called filtering and the impulse response filter

21 Linear Shift-Invariant System Properties 1) Convolution and BIBO stability Theorem An LSI system is BIBO stable if and only if its impulse response h(t) is in L 1 (R) (h(t) is absolutely integrable). Proof. a) BIBO stable if h(t) L 1 (R): A good exercise, try to do it yourself b) h(t) L 1 (R) if BIBO stable: We proceed by contradiction... Theorem If the input to a BIBO-stable system is in L p (R), the output is in L p (R) as well

22 Linear Shift-Invariant System Linear Convolution with Circularly-Extended Signal Let a T-periodic signal x(t) L 1 ([0,T]) or L 2 ([0,T]) be the input of a convolutional system (filter) with impulse response h(t) L 1 (R) Call h T (t) the periodized version of h(t) h T (t) = n Zh(t nt) Then the output y(t) of the convolutional filter is given (h x)(t) = (h T x)(t) Definition (Circular convolution) The circular convolution between T-periodic functions h and x is defined as (Hx)(t) = (h x)(t) = T/2 T/2 x(τ)h(t τ)dτ = T/2 T/2 x(t τ)h(τ)dτ, where H is called the circular convolution operator associated with h

23 Analyzing Continuous Time Signals

24 Why do we need Transforms? Transforming a function (here a signal or the impulse response of a system) is motivated by one or both of the two following reasons: View from a different perspective the characteristics of the function (for example, the energy of the function) For instance, the Fourier transform enables to compute the power spectrum and therefore to see the distribution of the energy in the frequency domain Move to a space where certain computations and manipulations are simplified For instance, a convolution in the time domain becomes a product in the Fourier domain Notice that here we need the transform to be invertible Remark: For a deterministic function, Fourier and Laplace transforms provide a different perspective of its characteristics and a space where certain computations are simplified (the two above motivations are strictly linked). For a stochastic process this is not the case! (see course Mathematical Principles of Signal Processing)

25 Fourier transform Eigenfunctions of the convolution operator LSI systems have all unit-modulus complex exponential functions as eigenfunctions v(t) = e jωt, t R (H v)(t) = (h v)(t) = = h(τ)e jωτ dτ } {{ } λ ω v(t τ)h(τ)dτ = e jωt }{{} v(t) e jω(t τ) h(τ)dτ v is an eigenfunction of H with corresponding eigenvalue λ ω that we call the frequency response of the system H(ω) H e jωt = h e jωt = H(ω)e jωt

26 Fourier Transform It is straightforwardly defined for L 1 (R) signals, for L 2 (R) signal one needs to exploit Hilbert space tools It provides a representation of the signal in the frequency domain Under certain conditions, it is invertible

27 Fourier Transform Definition (Fourier transform) The Fourier transform of a function x is X(ω) = x(t)e jωt dt, ω R. (1a) It exists when (1a) is defined and is finite for all ω R; we then call it the spectrum of x. The inverse Fourier transform of X is x(t) = 1 2π X(ω)e jωt dω, t R. (1b) It exists when (1b) is defined and is finite for all t R. When the Fourier transform and inverse Fourier transform exist, we denote the Fourier transform pair as FT x(t) X(ω). We discuss two cases: x(t) L 1 (R) x(t) L 2 (R) allows the use of all the tools from Hilbert space theory

28 Fourier Transform Functions in L 1 (R) Existence: Existence of the Fourier transform straightforwardly follows from the existence of the integral for L 1 (R) functions, that is, x(t)e jωt dt = x(t) dt < Riemann-Lebesgue Theorem: Theorem R Let x(t) L 1 (R) and call X(ω) its Fourier transform. Then X(ω) is continuous and bounded (proof requires the Dominated Convergence Thm.) lim ω ± X(ω) = 0 The Fourier transform is a mapping from L 1 (R) to the space of continuous and bounded functions R

29 Fourier Transform Functions in L 1 (R) Fourier transform of the box function Let x be the box function, which is in L 1 (R) x(t) = { 1/ t0, for t t 0 /2; 0, otherwise Its Fourier transform is given by X(ω) = 1 t0/2 t0 t0/2 = ejωt0/2 e jωt0/2 jω t 0 e jωt dt = 1 jω t 0 e jωt t0/2 t0/2 = t 0 sinc ( ωt0 ) 2 which is bounded and continuous, but in L 2 (R), and not in L 1 (R) 1 x(t) 1 X(ω) t 6Π 2Π 2Π 6Π ω

30 Fourier Transform Functions in L 1 (R) Inverse transform: x(t) L 1 (R) does not guarantee that X(ω) can be inverse-transformed In order to be inverse-transformed X(ω) must be in L 1 (R), and there is no subspace of x(t) L 1 (R) that implies this. This is one of the main drawbacks of the Fourier transform of L 1 (R) functions! If X(ω) L 1 (R) then x(t) = R X(ω)e jωt dω (the proof makes use of Gaussian kernel and standard Calculus arguments. Nevertheless, it is a bit tedious)

31 Fourier Transform Functions in L 2 (R) If x L 2 (R), the Fourier transform integral may or may not be defined for every ω R. The extension of the Fourier transform and its inverse from L 1 (R) to L 2 (R) is technically nontrivial Existence: The Fourier transform gives for any x in L 2 (R) a Fourier transform X itself in L 2 (R) (the Fourier transform in L 2 (R) is a mapping from a Hilbert space to a Hilbert space) Inverse transform: The inverse Fourier transform can be defined similarly for any X in L 2 (R), and it indeed provides an inversion, so x can be recovered from X (Going to the Fourier domain for performing computations really makes sense. Knowing that the Fourier transform can be extended rigorously to all of L 2 (R), we can put the technicalities aside)

32 Fourier Transform Functions in L 2 (R) Fourier transform of the sinc function ω0 ( x(t) = 2π sinc ω0 t ). 2 x(t) is in L 2 (R), but not in L 1 (R), and we cannot find the Fourier transform from the defining integral We find the Fourier transform by recognizing that the sinc function and the box function are a Fourier transform pair, and verify that X(ω) = { 2π/ω0, for ω ω 0 /2; 0, otherwise x(t) 1 X(ω) t π π ω

33 Fourier Transform Properties Linearity Shift in time Shift in frequency Differentiation in time Integration Convolution in time αx(t) + βy(t) x(t t 0 ) e jω0t x(t) t d n x(t) dt n x(τ) dτ FT αx(ω)+βy(ω) FT e jωt0 X(ω) FT X(ω ω 0 ) FT (jω) n X(ω) FT 1 jω X(ω) (h x)(t) FT H(ω)X(ω) Convolution in frequency h(t) x(t) FT 1 (H X)(ω) 2π

34 Fourier Transform Properties Deterministic autocorrelation a(t) = x(τ)x (τ t)dτ FT A(ω) = X(ω) 2 Parseval s equality: unitary transform up to a scale factor and x 2 = 1 2π X 2 x, y = 1 X, Y 2π Adjoint The adjoint of the Fourier transform, F : L 2 (R) L 2 (R), is determined uniquely by Fx, y = x, F y for every x,y L 2 (R) Since Parseval s equality shows that F/ 2π is a unitary operator, we have Thus, ( 1 2π F) = ( 1 2π F) 1 = 2πF 1 F = 2πF

35 Fourier Transform Transform pairs Dirac delta Box Function { 1/ t0, for t t x(t) = 0 /2; 0, otherwise, Sinc function 1 FT 2π δ(ω) FT X(ω) = t 0 sinc(ωt 0 /2) x(t) = ω0 2π sinc(ω 0t/2) { FT 2π/ω0, for ω ω X(ω) = 0 /2; 0, otherwise. Heaviside function u(t) = { 1, for t 0; 0, otherwise. FT U(ω) = πδ(ω)+ 1 jω Gaussian function g(t) = γe αt2 FT π /(4α) G(ω) = γ α e ω

36 Fourier Transform Regularity and spectral decay If X(ω) γ 1+ ω 1+ε, for all ω R, for some positive constants γ and ε, then X(ω) is integrable, or, X L 1 (R). Therefore, the inverse Fourier transform x is bounded and continuous, or, x C 0 If X(ω) γ 1+ ω p+1+ε for all ω R, for some nonnegative integer p and positive constants γ and ε, then x C p The Fourier transform of any x in C p is bounded by X(ω) for some positive constant γ γ 1+ ω p+1, for all ω R, Fourier transform of any continuous function is bounded by X(ω) for some positive constant γ γ, for all ω R, 1+ ω

37 Fourier Series Eigenfunctions of the Circular Convolution Operator The Fourier series arises from identifying the eigenfunctions of the circular convolution operator, which have the following form v(t) = e j(2π/t)kt, t R (H v)(t) = (h v)(t) = = = T/2 T/2 T/2 T/2 T/2 T/2 e j(2π/t)k(t τ) h(τ)dτ h(τ)e j(2π/t)kτ dτ } {{ } λ k v(t τ)h(τ)dτ e j(2π/t)kt }{{} v(t) v is an eigenfunction of H with corresponding eigenvalue λ k that we call the frequency response H k H e j(2π/t)kt = h e j(2π/t)kt = H k e j(2π/t)kt

38 Fourier Series Projecting onto the subspaces generated by each of the eigenfunctions Definition (Fourier series) The Fourier series coefficients of a periodic function x with period T are X k = 1 T T/2 T/2 x(t)e j(2π/t)kt dt, k Z. (4a) They exist when (4a) is defined and finite for all k Z; we then call them the spectrum of x. The Fourier series reconstruction from X is x(t) = k ZX k e j(2π/t)kt, t [ T/2,T/2). When the Fourier series coefficients exist and the reconstruction converges, we denote the Fourier series pair as x(t) FS X k

39 Fourier Series Spectrum in l 1 (Z) Let the T-periodic function x have spectrum X l 1 (Z). Then Fourier series converges absolutely for every t since Xk e j(2π/t)kt = X k e j(2π/t)kt = X k = X 1 <. k Z k Z Moreover, the Fourier series converges to a continuous function x(t) When x is continuous and X l 1 (Z), k Z x(t) = x(t), for all t R

40 Fourier series Fourier Series as an Orthonormal Basis Expansion Theorem (Orthonormal basis from Fourier series) The set {ϕ k } k Z with ϕ k (t) = 1 T e j(2π/t)kt, t [ T/2,T/2), forms an orthonormal basis for L 2 ([ T/2,T/2)). Up to scaling by the constant T, the Fourier series is an orthonormal basis expansion. The orthonormality leads to geometrically-intuitive properties using Hilbert space tools

41 Fourier series Spectrum in l 2 (Z) Theorem (Fourier series on L 2 ([ T/2,T/2))) Let x L 2 ([ T/2, T/2)) have Fourier series coefficients X = Fx. Then the following hold: L 2 inversion: Let x be the Fourier series reconstruction from X. Then using the L 2 ([ T/2,T/2)) norm. x x = 0 Norm conservation: The linear operator TF : L 2 ([ T/2,T/2)) l 2 (Z) is unitary. This yields the Parseval s equalities x 2 = x, y = T/2 T/2 x(t) 2 dt = T k Z T/2 X k 2, T/2x(t)y (t)dt = T k Z X k Y k, where T-periodic function y has Fourier series coefficients Y. Least-squares approximation: The function x N (t) = N X k e j(2π/t)kt k= N is the least-squares approximation of x on the subspace spanned by {ϕ k (t)} N k= N

42 Fourier series Properties Linearity Shift in time Shift in frequency Differentiation Integration t T/2 αx(t) + βy(t) x(t t 0) e j(2π/t)k0t x(t) d n x(t) dt n x(τ) dτ Circular convolution in time (h x)(t) Circular convolution in frequency FS αx k +βy k FS e j(2π/t)kt0 X k FS FS FS X k k0 ( j 2π ) n T k X k T Xk, for k 0 j2πk FS T H k X k h(t) x(t) FS (H X) k Circular deterministic autocorrelation a(t) = T/2 T/2 x(τ)x (τ t)dτ FS A k = T X k

43 Fourier series Transform pairs Square wave x(t) = { 1, for 1/2 t < 0; 1, for 0 t < 1/2; X k = { 2j/(πk), for k odd; 0, for k even x(t) = l Z 2j π(2l+1) ej2π(2l+1)t = 1 x(t) l=0 4 π(2l+1) sin(2π(2l+1)t). 2 Π X k t k

44 Fourier series Transform pairs Triangle wave y(t) = 1 2 t, for t [ 1/2,1/2) Y 0 = 0 { 1/(πk) Y k = 2, for k odd; 0, for k nonzero and even. x(t) X k t k

45 Fourier series Transform pairs Dirac comb s T (t) = n Zδ(t nt) S T,k = = = 1 T/2 T T/2 n Z δ(t nt)e j(2π/t)kt dt 1 T/2 δ(t)e j(2π/t)kt dt T T/2 1 T, k Z 1 T k Ze j(2π/t)kt = δ(t nt) n Z

46 Fourier series Relation of the Fourier series coefficients to the Fourier transform For a function that is identically zero outside of [ T/2,T/2), the Fourier series integral is the same as the Fourier transform integral for frequency ω = (2π/T)k An arbitrary T-periodic function x can be restricted to [ T/2,T/2) by defining x = 1 [ T/2,T/2) x It is then easy to verify that X k = 1 T X where X is the Fourier transform of x ( ) 2π T k, k Z,

47 Fourier series Fourier transform of periodic functions Let x be a T-periodic function, and let x be the restriction of x to [ T/2,T/2): x(t) = 1 [ T/2,T/2) x(t), t R Using the Dirac comb, we can write x(t) = (s T x)(t), t R Assuming we may apply the convolution theorem, we have X(ω) = S T (ω) X(ω), ω R We can write the Fourier transform of the Dirac comb as S T (ω) = n Z e jωnt The Dirac delta function S T can be expressed as a scaled Dirac comb with spacing 2π/T: S T (ω) = n Ze jωnt = 2π T δ ( ω 2π T k) = 2π T s 2π/T(ω). Finally, we may write the Fourier transform of X(ω) using the Fourier series coefficients of x: X(ω) = 2π X k δ ( ω 2π T k) k Z k Z

48 Fourier series Poisson sum formula Theorem (Poisson sum formula) Let s T be the Dirac comb and let x be a function with decay sufficient for the periodization (s T x)(t) = n Zx(t nt) to converge absolutely for all t. Then x(t nt) = 1 T n Z k Z X ( 2π T k) e j(2π/t)kt, where X is the Fourier transform of x. Specializing to T = 1 and t = 0, = n Zx(n) X(2πk). k Z

49 Fourier series Regularity and spectral decay Note A discontinuous function such as the square wave has Fourier series coefficients decaying only as O(1/k) A continuous function such as the triangle wave leads to a decay of O(1/k 2 ) Generally X k γ 1+ k q+1+ε for all k Z for some nonnegative integer q and positive constants γ and ε, implies x has q continuous derivatives If the periodic function x has q continuous derivatives, then its Fourier series coefficients satisfy X k γ 1+ k q+1 for all k Z

2 Classification of Continuous-Time Systems

2 Classification of Continuous-Time Systems Continuous-Time Signals and Systems 1 Preliminaries Notation for a continuous-time signal: x(t) Notation: If x is the input to a system T and y the corresponding output, then we use one of the following

More information

EE 224 Signals and Systems I Review 1/10

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

More information

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

Foundations of Signal Processing Tables

Foundations of Signal Processing Tables Foundations of Signal Processing Tables Martin Vetterli École Polytechnique Fédérale de Lausanne and University of California, Berkeley Jelena Kovačević Carnegie Mellon University Vivek K Goyal Massachusetts

More information

Signal and systems. Linear Systems. Luigi Palopoli. Signal and systems p. 1/5

Signal and systems. Linear Systems. Luigi Palopoli. Signal and systems p. 1/5 Signal and systems p. 1/5 Signal and systems Linear Systems Luigi Palopoli palopoli@dit.unitn.it Wrap-Up Signal and systems p. 2/5 Signal and systems p. 3/5 Fourier Series We have see that is a signal

More information

EECE 3620: Linear Time-Invariant Systems: Chapter 2

EECE 3620: Linear Time-Invariant Systems: Chapter 2 EECE 3620: Linear Time-Invariant Systems: Chapter 2 Prof. K. Chandra ECE, UMASS Lowell September 7, 2016 1 Continuous Time Systems In the context of this course, a system can represent a simple or complex

More information

Fourier transform representation of CT aperiodic signals Section 4.1

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

More information

Review of Frequency Domain Fourier Series: Continuous periodic frequency components

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

More information

2.1 Basic Concepts Basic operations on signals Classication of signals

2.1 Basic Concepts Basic operations on signals Classication of signals Haberle³me Sistemlerine Giri³ (ELE 361) 9 Eylül 2017 TOBB Ekonomi ve Teknoloji Üniversitesi, Güz 2017-18 Dr. A. Melda Yüksel Turgut & Tolga Girici Lecture Notes Chapter 2 Signals and Linear Systems 2.1

More information

CH.3 Continuous-Time Linear Time-Invariant System

CH.3 Continuous-Time Linear Time-Invariant System CH.3 Continuous-Time Linear Time-Invariant System 1 LTI System Characterization 1.1 what does LTI mean? In Ch.2, the properties of the system are investigated. We are particularly interested in linear

More information

LTI Systems (Continuous & Discrete) - Basics

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

More information

1 Signals and systems

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

More information

SIGNALS AND SYSTEMS: PAPER 3C1 HANDOUT 6. Dr Anil Kokaram Electronic and Electrical Engineering Dept.

SIGNALS AND SYSTEMS: PAPER 3C1 HANDOUT 6. Dr Anil Kokaram Electronic and Electrical Engineering Dept. SIGNALS AND SYSTEMS: PAPER 3C HANDOUT 6. Dr Anil Kokaram Electronic and Electrical Engineering Dept. anil.kokaram@tcd.ie www.mee.tcd.ie/ sigmedia FOURIER ANALYSIS Have seen how the behaviour of systems

More information

Discrete Time Signals and Systems Time-frequency Analysis. Gloria Menegaz

Discrete Time Signals and Systems Time-frequency Analysis. Gloria Menegaz Discrete Time Signals and Systems Time-frequency Analysis Gloria Menegaz Time-frequency Analysis Fourier transform (1D and 2D) Reference textbook: Discrete time signal processing, A.W. Oppenheim and R.W.

More information

EC Signals and Systems

EC Signals and Systems UNIT I CLASSIFICATION OF SIGNALS AND SYSTEMS Continuous time signals (CT signals), discrete time signals (DT signals) Step, Ramp, Pulse, Impulse, Exponential 1. Define Unit Impulse Signal [M/J 1], [M/J

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

Fourier Series. Spectral Analysis of Periodic Signals

Fourier Series. Spectral Analysis of Periodic Signals Fourier Series. Spectral Analysis of Periodic Signals he response of continuous-time linear invariant systems to the complex exponential with unitary magnitude response of a continuous-time LI system at

More information

CH.4 Continuous-Time Fourier Series

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

More information

Chapter 4 The Fourier Series and Fourier Transform

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

More information

2.161 Signal Processing: Continuous and Discrete Fall 2008

2.161 Signal Processing: Continuous and Discrete Fall 2008 MIT OpenCourseWare http://ocw.mit.edu 2.6 Signal Processing: Continuous and Discrete Fall 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. MASSACHUSETTS

More information

ECE 301 Division 1 Final Exam Solutions, 12/12/2011, 3:20-5:20pm in PHYS 114.

ECE 301 Division 1 Final Exam Solutions, 12/12/2011, 3:20-5:20pm in PHYS 114. ECE 301 Division 1 Final Exam Solutions, 12/12/2011, 3:20-5:20pm in PHYS 114. The exam for both sections of ECE 301 is conducted in the same room, but the problems are completely different. Your ID will

More information

Summary of Fourier Transform Properties

Summary of Fourier Transform Properties Summary of Fourier ransform Properties Frank R. Kschischang he Edward S. Rogers Sr. Department of Electrical and Computer Engineering University of oronto January 7, 207 Definition and Some echnicalities

More information

Lecture 6 January 21, 2016

Lecture 6 January 21, 2016 MATH 6/CME 37: Applied Fourier Analysis and Winter 06 Elements of Modern Signal Processing Lecture 6 January, 06 Prof. Emmanuel Candes Scribe: Carlos A. Sing-Long, Edited by E. Bates Outline Agenda: Fourier

More information

University Question Paper Solution

University Question Paper Solution Unit 1: Introduction University Question Paper Solution 1. Determine whether the following systems are: i) Memoryless, ii) Stable iii) Causal iv) Linear and v) Time-invariant. i) y(n)= nx(n) ii) y(t)=

More information

1.1 SPECIAL FUNCTIONS USED IN SIGNAL PROCESSING. δ(t) = for t = 0, = 0 for t 0. δ(t)dt = 1. (1.1)

1.1 SPECIAL FUNCTIONS USED IN SIGNAL PROCESSING. δ(t) = for t = 0, = 0 for t 0. δ(t)dt = 1. (1.1) SIGNAL THEORY AND ANALYSIS A signal, in general, refers to an electrical waveform whose amplitude varies with time. Signals can be fully described in either the time or frequency domain. This chapter discusses

More information

ENSC327 Communications Systems 2: Fourier Representations. School of Engineering Science Simon Fraser University

ENSC327 Communications Systems 2: Fourier Representations. School of Engineering Science Simon Fraser University ENSC37 Communications Systems : Fourier Representations School o Engineering Science Simon Fraser University Outline Chap..5: Signal Classiications Fourier Transorm Dirac Delta Function Unit Impulse Fourier

More information

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

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

More information

Review of Discrete-Time System

Review of Discrete-Time System Review of Discrete-Time System Electrical & Computer Engineering University of Maryland, College Park Acknowledgment: ENEE630 slides were based on class notes developed by Profs. K.J. Ray Liu and Min Wu.

More information

Review of Linear Time-Invariant Network Analysis

Review of Linear Time-Invariant Network Analysis D1 APPENDIX D Review of Linear Time-Invariant Network Analysis Consider a network with input x(t) and output y(t) as shown in Figure D-1. If an input x 1 (t) produces an output y 1 (t), and an input x

More information

Homework 7 Solution EE235, Spring Find the Fourier transform of the following signals using tables: te t u(t) h(t) = sin(2πt)e t u(t) (2)

Homework 7 Solution EE235, Spring Find the Fourier transform of the following signals using tables: te t u(t) h(t) = sin(2πt)e t u(t) (2) Homework 7 Solution EE35, Spring. Find the Fourier transform of the following signals using tables: (a) te t u(t) h(t) H(jω) te t u(t) ( + jω) (b) sin(πt)e t u(t) h(t) sin(πt)e t u(t) () h(t) ( ejπt e

More information

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

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

More information

ENSC327 Communications Systems 2: Fourier Representations. Jie Liang School of Engineering Science Simon Fraser University

ENSC327 Communications Systems 2: Fourier Representations. Jie Liang School of Engineering Science Simon Fraser University ENSC327 Communications Systems 2: Fourier Representations Jie Liang School of Engineering Science Simon Fraser University 1 Outline Chap 2.1 2.5: Signal Classifications Fourier Transform Dirac Delta Function

More information

ECEN 420 LINEAR CONTROL SYSTEMS. Lecture 2 Laplace Transform I 1/52

ECEN 420 LINEAR CONTROL SYSTEMS. Lecture 2 Laplace Transform I 1/52 1/52 ECEN 420 LINEAR CONTROL SYSTEMS Lecture 2 Laplace Transform I Linear Time Invariant Systems A general LTI system may be described by the linear constant coefficient differential equation: a n d n

More information

Math Fall Linear Filters

Math Fall Linear Filters Math 658-6 Fall 212 Linear Filters 1. Convolutions and filters. A filter is a black box that takes an input signal, processes it, and then returns an output signal that in some way modifies the input.

More information

2.161 Signal Processing: Continuous and Discrete Fall 2008

2.161 Signal Processing: Continuous and Discrete Fall 2008 MIT OpenCourseWare http://ocw.mit.edu.6 Signal Processing: Continuous and Discrete Fall 008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. MASSACHUSETTS

More information

Solutions to Problems in Chapter 4

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

More information

Series FOURIER SERIES. Graham S McDonald. A self-contained Tutorial Module for learning the technique of Fourier series analysis

Series FOURIER SERIES. Graham S McDonald. A self-contained Tutorial Module for learning the technique of Fourier series analysis Series FOURIER SERIES Graham S McDonald A self-contained Tutorial Module for learning the technique of Fourier series analysis Table of contents Begin Tutorial c 24 g.s.mcdonald@salford.ac.uk 1. Theory

More information

A6523 Linear, Shift-invariant Systems and Fourier Transforms

A6523 Linear, Shift-invariant Systems and Fourier Transforms A6523 Linear, Shift-invariant Systems and Fourier Transforms Linear systems underly much of what happens in nature and are used in instrumentation to make measurements of various kinds. We will define

More information

Chapter 4 The Fourier Series and Fourier Transform

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

More information

Introduction to Signal Spaces

Introduction to Signal Spaces Introduction to Signal Spaces Selin Aviyente Department of Electrical and Computer Engineering Michigan State University January 12, 2010 Motivation Outline 1 Motivation 2 Vector Space 3 Inner Product

More information

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

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

More information

Fourier series for continuous and discrete time signals

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

More information

4 The Continuous Time Fourier Transform

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

More information

Professor Fearing EECS120/Problem Set 2 v 1.01 Fall 2016 Due at 4 pm, Fri. Sep. 9 in HW box under stairs (1st floor Cory) Reading: O&W Ch 1, Ch2.

Professor Fearing EECS120/Problem Set 2 v 1.01 Fall 2016 Due at 4 pm, Fri. Sep. 9 in HW box under stairs (1st floor Cory) Reading: O&W Ch 1, Ch2. Professor Fearing EECS120/Problem Set 2 v 1.01 Fall 20 Due at 4 pm, Fri. Sep. 9 in HW box under stairs (1st floor Cory) Reading: O&W Ch 1, Ch2. Note: Π(t) = u(t + 1) u(t 1 ), and r(t) = tu(t) where u(t)

More information

Fourier transforms. Definition F(ω) = - should know these! f(t).e -jωt.dt. ω = 2πf. other definitions exist. f(t) = - F(ω).e jωt.

Fourier transforms. Definition F(ω) = - should know these! f(t).e -jωt.dt. ω = 2πf. other definitions exist. f(t) = - F(ω).e jωt. Fourier transforms This is intended to be a practical exposition, not fully mathematically rigorous ref The Fourier Transform and its Applications R. Bracewell (McGraw Hill) Definition F(ω) = - f(t).e

More information

2 Frequency-Domain Analysis

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

More information

LECTURE 12 Sections Introduction to the Fourier series of periodic signals

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

More information

Chapter 2: Linear systems & sinusoids OVE EDFORS DEPT. OF EIT, LUND UNIVERSITY

Chapter 2: Linear systems & sinusoids OVE EDFORS DEPT. OF EIT, LUND UNIVERSITY Chapter 2: Linear systems & sinusoids OVE EDFORS DEPT. OF EIT, LUND UNIVERSITY Learning outcomes After this lecture, the student should understand what a linear system is, including linearity conditions,

More information

MEDE2500 Tutorial Nov-7

MEDE2500 Tutorial Nov-7 (updated 2016-Nov-4,7:40pm) MEDE2500 (2016-2017) Tutorial 3 MEDE2500 Tutorial 3 2016-Nov-7 Content 1. The Dirac Delta Function, singularity functions, even and odd functions 2. The sampling process and

More information

Lecture 8 ELE 301: Signals and Systems

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

More information

Notes 07 largely plagiarized by %khc

Notes 07 largely plagiarized by %khc Notes 07 largely plagiarized by %khc Warning This set of notes covers the Fourier transform. However, i probably won t talk about everything here in section; instead i will highlight important properties

More information

Fourier Series Example

Fourier Series Example Fourier Series Example Let us compute the Fourier series for the function on the interval [ π,π]. f(x) = x f is an odd function, so the a n are zero, and thus the Fourier series will be of the form f(x)

More information

RKHS, Mercer s theorem, Unbounded domains, Frames and Wavelets Class 22, 2004 Tomaso Poggio and Sayan Mukherjee

RKHS, Mercer s theorem, Unbounded domains, Frames and Wavelets Class 22, 2004 Tomaso Poggio and Sayan Mukherjee RKHS, Mercer s theorem, Unbounded domains, Frames and Wavelets 9.520 Class 22, 2004 Tomaso Poggio and Sayan Mukherjee About this class Goal To introduce an alternate perspective of RKHS via integral operators

More information

Discussion Section #2, 31 Jan 2014

Discussion Section #2, 31 Jan 2014 Discussion Section #2, 31 Jan 2014 Lillian Ratliff 1 Unit Impulse The unit impulse (Dirac delta) has the following properties: { 0, t 0 δ(t) =, t = 0 ε ε δ(t) = 1 Remark 1. Important!: An ordinary function

More information

Question Paper Code : AEC11T02

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

More information

ECE 301: Signals and Systems. Course Notes. Prof. Shreyas Sundaram. School of Electrical and Computer Engineering Purdue University

ECE 301: Signals and Systems. Course Notes. Prof. Shreyas Sundaram. School of Electrical and Computer Engineering Purdue University ECE 301: Signals and Systems Course Notes Prof. Shreyas Sundaram School of Electrical and Computer Engineering Purdue University ii Acknowledgments These notes very closely follow the book: Signals and

More information

ECE 3620: Laplace Transforms: Chapter 3:

ECE 3620: Laplace Transforms: Chapter 3: ECE 3620: Laplace Transforms: Chapter 3: 3.1-3.4 Prof. K. Chandra ECE, UMASS Lowell September 21, 2016 1 Analysis of LTI Systems in the Frequency Domain Thus far we have understood the relationship between

More information

ECE 301 Division 1, Fall 2006 Instructor: Mimi Boutin Final Examination

ECE 301 Division 1, Fall 2006 Instructor: Mimi Boutin Final Examination ECE 30 Division, all 2006 Instructor: Mimi Boutin inal Examination Instructions:. Wait for the BEGIN signal before opening this booklet. In the meantime, read the instructions below and fill out the requested

More information

Representing a Signal

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

More information

Raktim Bhattacharya. . AERO 632: Design of Advance Flight Control System. Norms for Signals and Systems

Raktim Bhattacharya. . AERO 632: Design of Advance Flight Control System. Norms for Signals and Systems . AERO 632: Design of Advance Flight Control System Norms for Signals and. Raktim Bhattacharya Laboratory For Uncertainty Quantification Aerospace Engineering, Texas A&M University. Norms for Signals ...

More information

Fourier Series and Fourier Transforms

Fourier Series and Fourier Transforms Fourier Series and Fourier Transforms EECS2 (6.082), MIT Fall 2006 Lectures 2 and 3 Fourier Series From your differential equations course, 18.03, you know Fourier s expression representing a T -periodic

More information

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

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

More information

16.584: Random (Stochastic) Processes

16.584: Random (Stochastic) Processes 1 16.584: Random (Stochastic) Processes X(t): X : RV : Continuous function of the independent variable t (time, space etc.) Random process : Collection of X(t, ζ) : Indexed on another independent variable

More information

Convolution. Define a mathematical operation on discrete-time signals called convolution, represented by *. Given two discrete-time signals x 1, x 2,

Convolution. Define a mathematical operation on discrete-time signals called convolution, represented by *. Given two discrete-time signals x 1, x 2, Filters Filters So far: Sound signals, connection to Fourier Series, Introduction to Fourier Series and Transforms, Introduction to the FFT Today Filters Filters: Keep part of the signal we are interested

More information

16.362: Signals and Systems: 1.0

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

More information

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

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

More information

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

Properties of LTI Systems

Properties of LTI Systems Properties of LTI Systems Properties of Continuous Time LTI Systems Systems with or without memory: A system is memory less if its output at any time depends only on the value of the input at that same

More information

Discrete Time Fourier Transform

Discrete Time Fourier Transform Discrete Time Fourier Transform Recall that we wrote the sampled signal x s (t) = x(kt)δ(t kt). We calculate its Fourier Transform. We do the following: Ex. Find the Continuous Time Fourier Transform of

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

Chap 4. Sampling of Continuous-Time Signals

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

More information

1 otherwise. Note that the area of the pulse is one. The Dirac delta function (a.k.a. the impulse) can be defined using the pulse as follows:

1 otherwise. Note that the area of the pulse is one. The Dirac delta function (a.k.a. the impulse) can be defined using the pulse as follows: The Dirac delta function There is a function called the pulse: { if t > Π(t) = 2 otherwise. Note that the area of the pulse is one. The Dirac delta function (a.k.a. the impulse) can be defined using the

More information

2.161 Signal Processing: Continuous and Discrete

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

More information

GATE EE Topic wise Questions SIGNALS & SYSTEMS

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

More information

Lecture 15: Time and Frequency Joint Perspective

Lecture 15: Time and Frequency Joint Perspective WAVELETS AND MULTIRATE DIGITAL SIGNAL PROCESSING Lecture 15: Time and Frequency Joint Perspective Prof.V.M.Gadre, EE, IIT Bombay Introduction In lecture 14, we studied steps required to design conjugate

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

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

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

More information

The Johns Hopkins University Department of Electrical and Computer Engineering Introduction to Linear Systems Fall 2002.

The Johns Hopkins University Department of Electrical and Computer Engineering Introduction to Linear Systems Fall 2002. The Johns Hopkins University Department of Electrical and Computer Engineering 505.460 Introduction to Linear Systems Fall 2002 Final exam Name: You are allowed to use: 1. Table 3.1 (page 206) & Table

More information

e st f (t) dt = e st tf(t) dt = L {t f(t)} s

e st f (t) dt = e st tf(t) dt = L {t f(t)} s Additional operational properties How to find the Laplace transform of a function f (t) that is multiplied by a monomial t n, the transform of a special type of integral, and the transform of a periodic

More information

Review of Fourier Transform

Review of Fourier Transform Review of Fourier Transform Fourier series works for periodic signals only. What s about aperiodic signals? This is very large & important class of signals Aperiodic signal can be considered as periodic

More information

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

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

More information

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

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

More information

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

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

More information

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

13. Power Spectrum. For a deterministic signal x(t), the spectrum is well defined: If represents its Fourier transform, i.e., if.

13. Power Spectrum. For a deterministic signal x(t), the spectrum is well defined: If represents its Fourier transform, i.e., if. For a deterministic signal x(t), the spectrum is well defined: If represents its Fourier transform, i.e., if jt X ( ) = xte ( ) dt, (3-) then X ( ) represents its energy spectrum. his follows from Parseval

More information

Chapter 6 THE SAMPLING PROCESS 6.1 Introduction 6.2 Fourier Transform Revisited

Chapter 6 THE SAMPLING PROCESS 6.1 Introduction 6.2 Fourier Transform Revisited Chapter 6 THE SAMPLING PROCESS 6.1 Introduction 6.2 Fourier Transform Revisited Copyright c 2005 Andreas Antoniou Victoria, BC, Canada Email: aantoniou@ieee.org July 14, 2018 Frame # 1 Slide # 1 A. Antoniou

More information

X. Chen More on Sampling

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

More information

Linear Filters. L[e iωt ] = 2π ĥ(ω)eiωt. Proof: Let L[e iωt ] = ẽ ω (t). Because L is time-invariant, we have that. L[e iω(t a) ] = ẽ ω (t a).

Linear Filters. L[e iωt ] = 2π ĥ(ω)eiωt. Proof: Let L[e iωt ] = ẽ ω (t). Because L is time-invariant, we have that. L[e iω(t a) ] = ẽ ω (t a). Linear Filters 1. Convolutions and filters. A filter is a black box that takes an input signal, processes it, and then returns an output signal that in some way modifies the input. For example, if the

More information

2.161 Signal Processing: Continuous and Discrete Fall 2008

2.161 Signal Processing: Continuous and Discrete Fall 2008 MIT OpenCourseWare http://ocw.mit.edu 2.161 Signal Processing: Continuous and Discrete Fall 2008 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms. Massachusetts

More information

A system that is both linear and time-invariant is called linear time-invariant (LTI).

A system that is both linear and time-invariant is called linear time-invariant (LTI). The Cooper Union Department of Electrical Engineering ECE111 Signal Processing & Systems Analysis Lecture Notes: Time, Frequency & Transform Domains February 28, 2012 Signals & Systems Signals are mapped

More information

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

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

More information

Signals and Systems I Have Known and Loved. Andrew W. Eckford

Signals and Systems I Have Known and Loved. Andrew W. Eckford Signals and Systems I Have Known and Loved Andrew W. Eckford Department of Electrical Engineering and Computer Science York University, oronto, Ontario, Canada Version: September 2, 216 Copyright c 215

More information

ELEMENTS OF PROBABILITY THEORY

ELEMENTS OF PROBABILITY THEORY ELEMENTS OF PROBABILITY THEORY Elements of Probability Theory A collection of subsets of a set Ω is called a σ algebra if it contains Ω and is closed under the operations of taking complements and countable

More information

SIGNAL PROCESSING. B14 Option 4 lectures. Stephen Roberts

SIGNAL PROCESSING. B14 Option 4 lectures. Stephen Roberts SIGNAL PROCESSING B14 Option 4 lectures Stephen Roberts Recommended texts Lynn. An introduction to the analysis and processing of signals. Macmillan. Oppenhein & Shafer. Digital signal processing. Prentice

More information

Representation of Signals and Systems. Lecturer: David Shiung

Representation of Signals and Systems. Lecturer: David Shiung Representation of Signals and Systems Lecturer: David Shiung 1 Abstract (1/2) Fourier analysis Properties of the Fourier transform Dirac delta function Fourier transform of periodic signals Fourier-transform

More information

2A1H Time-Frequency Analysis II

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

More information

Fourier Analysis and Power Spectral Density

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

More information

Volterra/Wiener Representation of Non-Linear Systems

Volterra/Wiener Representation of Non-Linear Systems Berkeley Volterra/Wiener Representation of Non-Linear Systems Prof. Ali M. U.C. Berkeley Copyright c 2014 by Ali M. Linear Input/Output Representation A linear (LTI) system is completely characterized

More information

Lecture 7: Laplace Transform and Its Applications Dr.-Ing. Sudchai Boonto

Lecture 7: Laplace Transform and Its Applications Dr.-Ing. Sudchai Boonto Dr-Ing Sudchai Boonto Department of Control System and Instrumentation Engineering King Mongkut s Unniversity of Technology Thonburi Thailand Outline Motivation The Laplace Transform The Laplace Transform

More information

Frequency Response and Continuous-time Fourier Series

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

More information