butter butter Purpose Syntax Description Digital Domain Analog Domain

Size: px
Start display at page:

Download "butter butter Purpose Syntax Description Digital Domain Analog Domain"

Transcription

1 butter butter 7butter Butterworth analog and digital filter design [b,a] = butter(n,wn) [b,a] = butter(n,wn,'ftype') [b,a] = butter(n,wn,'s') [b,a] = butter(n,wn,'ftype','s') [z,p,k] = butter(...) [A,B,C,D] = butter(...) butter designs lowpass, bandpass, highpass, and bandstop digital and analog Butterworth filters. Butterworth filters are characterized by a magnitude response that is maximally flat in the passband and monotonic overall. Butterworth filters sacrifice rolloff steepness for monotonicity in the pass- and stopbands. Unless the smoothness of the Butterworth filter is needed, an elliptic or Chebyshev filter can generally provide steeper rolloff characteristics with a lower filter order. Digital Domain [b,a] = butter(n,wn) designs an order n lowpass digital Butterworth filter with normalized cutoff frequency Wn. It returns the filter coefficients in length n+1 row vectors b and a, with coefficients in descending powers of z. H( z) B( z) b( 1) + b( 2)z ! + b( n + 1)z = = n A( z) 1 + a( 2)z 1 +! + a( n + 1)z n Cutoff frequency is that frequency where the magnitude response of the filter is 1 2. For butter, the normalized cutoff frequency Wn must be a number between 0 and 1, where 1 corresponds to the Nyquist frequency, π radians per sample. If Wn is a two-element vector, Wn = [w1 w2], butter returns an order 2*n digital bandpass filter with passband w1 < ω < w2. [b,a] = butter(n,wn,'ftype') designs a highpass, lowpass, or bandstop filter, where the string 'ftype' is one of the following. 'high' for a highpass digital filter with normalized cutoff frequency Wn 'low' for a lowpass digital filter with normalized cutoff frequency Wn 'stop' for an order 2*n bandstop digital filter if Wn is a two-element vector, Wn = [w1 w2]. The stopband is w1 < ω < w2. With different numbers of output arguments, butter directly obtains other realizations of the filter. To obtain zero-pole-gain form, use three output arguments as shown below: [z,p,k] = butter(n,wn) or [z,p,k] = butter(n,wn,'ftype') returns the zeros and poles in length n column vectors z and p, and the gain in the scalar k. To obtain state-space form, use four output arguments as shown below: [A,B,C,D] = butter(n,wn) or [A,B,C,D] = butter(n,wn,'ftype') where A, B, C, and D are x[ n + 1] = Ax[ n] + Bu[ n] y[ n] = Cx[ n] + Du[ n] and u is the input, x is the state vector, and y is the output. Analog Domain [b,a] = butter(n,wn,'s') designs an order n lowpass analog Butterworth filter with angular cutoff frequency Wn rad/s. It returns the filter coefficients in the length n+1 row vectors b and a, in descending powers of s, derived from this transfer function: B( s) b( 1)s H( s) n + b( 2)s n 1 +! + b ( n + 1 ) = = A( s) s n + a( 2)s n 1 +! + a ( n + 1 ) butter s angular cutoff frequency Wn must be greater than 0 rad/s. If Wn is a two-element vector with w1 < w2, butter(n,wn,'s') returns an order 2*n bandpass analog filter with passband w1 < ω < w2. [b,a] = butter(n,wn,'ftype','s') designs a highpass, lowpass, or bandstop filter

2 conv ellip 2conv Convolution and polynomial multiplication 7ellip Elliptic (Cauer) filter design Definition w = conv(u,v) w = conv(u,v) convolves vectors u and v. Algebraically, convolution is the same operation as multiplying the polynomials whose coefficients are the elements of u and v. Let m = length(u) and n = length(v). Then w is the vector of length m+n-1 whose kth element is The sum is over all the values of j which lead to legal subscripts for u(j) and v(k+1-j), specifically j = max(1,k+1-n): min(k,m). When m = n, this gives w(1) = u(1)*v(1) w(2) = u(1)*v(2)+u(2)*v(1) w(3) = u(1)*v(3)+u(2)*v(2)+u(3)*v(1)... w(n) = u(1)*v(n)+u(2)*v(n-1)+... +u(n)*v(1)... w(2*n-1) = u(n)*v(n) The convolution theorem says, roughly, that convolving two sequences is the same as multiplying their Fourier transforms. In order to make this precise, it is necessary to pad the two vectors with zeros and ignore roundoff error. Thus, if and! w( k) # u( j)v( k " 1! j) j X = fft([x zeros(1,length(y)-1)]) Y = fft([y zeros(1,length(x)-1)]) then conv(x,y) = ifft(x.*y) [b,a] = ellip(n,rp,rs,wp) [b,a] = ellip(n,rp,rs,wp,'ftype') [b,a] = ellip(n,rp,rs,wp,'s') [b,a] = ellip(n,rp,rs,wp,'ftype','s') [z,p,k] = ellip(...) [A,B,C,D] = ellip(...) ellip designs lowpass, bandpass, highpass, and bandstop digital and analog elliptic filters. Elliptic filters offer steeper rolloff characteristics than Butterworth or Chebyshev filters, but are equiripple in both the pass- and stopbands. In general, elliptic filters meet given performance specifications with the lowest order of any filter type. Digital Domain [b,a] = ellip(n,rp,rs,wp) designs an order n lowpass digital elliptic filter with normalized passband edge frequency Wp, Rp db of ripple in the passband, and a stopband Rs db down from the peak value in the passband. It returns the filter coefficients in the length n+1 row vectors b and a, with coefficients in descending powers of z. B( z) H( z) = = b( 1) + b( 2)z 1 +! + b( n + 1)z n A( z) 1 + a( 2)z 1 +! + a( n + 1)z n The normalized passband edge frequency is the edge of the passband, at which the magnitude response of the filter is -Rp db. For ellip, the normalized cutoff frequency Wp is a number between 0 and 1, where 1 corresponds to half the sampling frequency (Nyquist frequency). Smaller values of passband ripple Rp and larger values of stopband attenuation Rs both lead to wider transition widths (shallower rolloff characteristics). If Wp is a two-element vector, Wp = [w1 w2], ellip returns an order 2*n bandpass filter with passband w1 < ω < w2. See Also conv2, convn, deconv, filter convmtx and xcorr in the Signal Processing Toolbox

3 ellip filter [b,a] = ellip(n,rp,rs,wp,'ftype') designs a highpass, lowpass, or bandstop filter, where the string 'ftype' is one of the following. 'high' for a highpass digital filter with normalized passband edge frequency Wp 'low' for a lowpass digital filter with normalized passband edge frequency Wp 'stop' for an order 2*n bandstop digital filter if Wp is a two-element vector, Wp = [w1 w2]. The stopband is w1 < ω < w2. With different numbers of output arguments, ellip directly obtains other realizations of the filter. To obtain zero-pole-gain form, use three output arguments as shown below. [z,p,k] = ellip(n,rp,rs,wp) or [z,p,k] = ellip(n,rp,rs,wp,'ftype') returns the zeros and poles in length n column vectors z and p and the gain in the scalar k. To obtain state-space form, use four output arguments as shown below: [A,B,C,D] = ellip(n,rp,rs,wp) or [A,B,C,D] = ellip(n,rp,rs,wp,'ftype') where A, B, C, and D are x[ n + 1] = Ax[ n] + Bu[ n] y[ n] = Cx[ n] + Du[ n] and u is the input, x is the state vector, and y is the output. Analog Domain [b,a] = ellip(n,rp,rs,wp,'s') designs an order n lowpass analog elliptic filter with angular passband edge frequency Wp rad/s and returns the filter coefficients in the length n+1 row vectors b and a, in descending powers of s, derived from this transfer function: H( s) B ( s) b( 1)s = = n + b( 2)s n 1 +! + b( n + 1) A( s) s n + a( 2)s n 1 +! + a( n + 1) Example 2filter Filter data with an infinite impulse response (IIR) or finite impulse response (FIR) filter y = filter(b,a,x) [y,zf] = filter(b,a,x) [y,zf] = filter(b,a,x,zi) y = filter(b,a,x,zi,dim) [...] = filter(b,a,x,[],dim) The filter function filters a data sequence using a digital filter which works for both real and complex inputs. The filter is a direct form II transposed implementation of the standard difference equation (see ). y = filter(b,a,x) filters the data in vector X with the filter described by numerator coefficient vector b and denominator coefficient vector a. If a(1) is not equal to 1, filter normalizes the filter coefficients by a(1). If a(1) equals 0, filter returns an error. If X is a matrix, filter operates on the columns of X. If X is a multidimensional array, filter operates on the first nonsingleton dimension. [y,zf] = filter(b,a,x) returns the final conditions, zf, of the filter delays. If X is a row or column vector, output zf is a column vector of max(length(a),length(b))-1. If X is a matrix, zf is an array of such vectors, one for each column of X, and similarly for multidimensional arrays. [y,zf] = filter(b,a,x,zi) accepts initial conditions, zi, and returns the final conditions, zf, of the filter delays. Input zi is a vector of length max(length(a),length(b))-1, or an array with the leading dimension of size max(length(a),length(b))-1 and with remaining dimensions matching those of X. y = filter(b,a,x,zi,dim) and [...] = filter(b,a,x,[],dim) operate across the dimension dim. You can use filter to find a running average without using a for loop. This example finds the running average of a 16-element vector, using a window size of 5. data = [1:0.2:4]';

4 filter filter windowsize = 5; filter(ones(1,windowsize)/windowsize,1,data) The operation of filter at sample m is given by the time domain difference equations ans = See Also y( m) # b( 1)x( m) " z 1 ( m! 1) z 1 ( m) # b( 2)x( m) " z 2 ( m! 1)! a( 2)y( m). =.. z n! 2 ( m) # b( n! 1)x( m) " z n! 1 ( m! 1)! a( n! 1)y( m) z n! 1 ( m) # b( n)x( m)! a( n)y( m) The input-output description of this filtering operation in the z -transform domain is a rational transfer function, b( 1) " b( 2)z Y( z)! 1 " " b( nb " 1)z # $$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$$X! nb 1 " a( 2)z! 1 " " a( na " 1)z! na ( z ) filter2 filtfilt, filtic in the Signal Processing Toolbox The filter function is implemented as a direct form II transposed structure, References [1] Oppenheim, A. V. and R.W. Schafer. Discrete-Time Signal Processing, Englewood Cliffs, NJ: Prentice-Hall, 1989, pp x(m)... b(n) b(3) b(2) b(1)! Z 1 Z n 1 (m) a(n)...! Z 1! Z 1 Z 2 (m) Z 1 (m) a(3) a(2)! y(m)... or y(n) = b(1)*x(n) + b(2)*x(n-1) b(nb+1)*x(n-nb) - a(2)*y(n-1) a(na+1)*y(n-na) where n-1 is the filter order, and which handles both FIR and IIR filters [1]

5 freqz poly 7freqz Frequency response of digital filter 2poly Polynomial with specified roots [h,w]= freqz(b,a,l) h = freqz(b,a,w) [h,w] = freqz(b,a,l,'whole') [h,f] = freqz(b,a,l,fs) h = freqz(b,a,f,fs) [h,f] = freqz(b,a,l,'whole',fs) freqz(b,a,...) freqz(hd) [h,w] = freqz(b,a,l) returns the frequency response vector h and the corresponding angular frequency vector w for the digital filter whose transfer function is determined by the (real or complex) numerator and denominator polynomials represented in the vectors b and a, respectively. The vectors h and w are both of length l. The angular frequency vector w has values ranging from 0 to π radians per sample. When you don t specify the integer l, or you specify it as the empty vector [], the frequency response is calculated using the default value of 512 samples. Remarks p = poly(a) p = poly(r) p = poly(a) where A is an n-by-n matrix returns an n+1 element row vector whose elements are the coefficients of the characteristic polynomial, det( sl! A)! The coefficients are ordered in descending powers: if a vector c has n+1 components, the polynomial it represents is c 1 s n " " c n s " c n " 1 p = poly(r) where r is a vector returns a row vector whose elements are the coefficients of the polynomial whose roots are the elements of r. Note the relationship of this command to r = roots(p) which returns a column vector whose elements are the roots of the polynomial specified by the coefficients row vector p. For vectors, roots and poly are inverse functions of each other, up to ordering, scaling, and roundoff error. h = freqz(b,a,w) returns the frequency response vector h calculated at the frequencies (in radians per sample) supplied by the vector w. The vector w can have any length. Examples MATLAB displays polynomials as row vectors containing the coefficients ordered by descending powers. The characteristic equation of the matrix A = [h,w] = freqz(b,a,l,'whole') uses n sample points around the entire unit circle to calculate the frequency response. The frequency vector w has length l and has values ranging from 0 to 2π radians per sample [h,f] = freqz(b,a,l,fs) returns the frequency response vector h and the corresponding frequency vector f for the digital filter whose transfer function is determined by the (real or complex) numerator and denominator polynomials represented in the vectors b and a, respectively. The vectors h and f are both of length l. For this syntax, the frequency response is calculated using the sampling frequency specified by the scalar fs (in hertz). The frequency vector f is calculated in units of hertz (Hz). The frequency vector f has values ranging from 0 to fs/2 Hz. is returned in a row vector by poly: p = poly(a) p = The roots of this polynomial (eigenvalues of matrix A) are returned in a column vector by roots: r = roots(p)

6 poly polyval r = 2polyval Polynomial evaluation See Also The algorithms employed for poly and roots illustrate an interesting aspect of the modern approach to eigenvalue computation. poly(a) generates the characteristic polynomial of A, and roots(poly(a)) finds the roots of that polynomial, which are the eigenvalues of A. But both poly and roots use eig, which is based on similarity transformations. The classical approach, which characterizes eigenvalues as roots of the characteristic polynomial, is actually reversed. If A is an n-by-n matrix, poly(a) produces the coefficients c(1) through c(n+1), with c(1) = 1, in det (!I! A) # c 1! n " " c n! " c n " 1 The algorithm is z = eig(a); c = zeros(n+1,1); c(1) = 1; for j = 1:n c(2:j+1) = c(2:j+1)-z(j)*c(1:j); end This recursion is easily derived by expanding the product. (!!! 1 )(!!! 2 ) (!!! n ) It is possible to prove that poly(a) produces the coefficients in the characteristic polynomial of a matrix within roundoff error of A. This is true even if the eigenvalues of A are badly conditioned. The traditional algorithms for obtaining the characteristic polynomial, which do not use the eigenvalues, do not have such satisfactory numerical properties. conv, polyval, residue, roots Remarks y = polyval(p,x) y = polyval(p,x,[],mu) [y,delta] = polyval(p,x,s) [y,delta] = polyval(p,x,s,mu) y = polyval(p,x) returns the value of a polynomial of degree n evaluated at x. The input argument p is a vector of length n+1 whose elements are the coefficients in descending powers of the polynomial to be evaluated. y # p 1 x n " p 2 x n! 1 " " p x " p n n " 1 x can be a matrix or a vector. In either case, polyval evaluates p at each element of x. y = polyval(p,x,[],mu) uses x $ # ( x! µ 1 ) µ 2 in place of x. In this equation, µ 1 # %&'() x* and µ 2 # +,-) x*. The centering and scaling parameters mu = [ µ 1, µ 2 ] are optional output computed by polyfit. [y,delta] = polyval(p,x,s) and [y,delta] = polyval(p,x,s,mu) use the optional output structure S generated by polyfit to generate error estimates, y±delta. If the errors in the data input to polyfit are independent normal with constant variance, y±delta contains at least 50% of the predictions. The polyvalm(p,x) function, with x a matrix, evaluates the polynomial in a matrix sense. See polyvalm for more information. Examples The polynomial p( x) # 3x 2 " 2x " 1 is evaluated at x!= 5, 7, and 9 with p = [3 2 1]; polyval(p,[5 7 9]) which results in ans = For another example, see polyfit

7 residue residue 2residue Convert between partial fraction expansion and polynomial coefficients [r,p,k] = residue(b,a) [b,a] = residue(r,p,k) The residue function converts a quotient of polynomials to pole-residue representation, and back again. Arguments b,a r p k Vectors that specify the coefficients of the polynomials in descending powers of s Column vector of residues Column vector of poles Row vector of direct terms Definition [r,p,k] = residue(b,a) finds the residues, poles, and direct term of a partial fraction expansion of the ratio of two polynomials, b( s) and a( s), of the form b( s) b!!!!!!!!!! 1 s m # b 2 s m " 1 # b 3 s m " 2 # # b m # 1 $!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! a( s) a 1 s n # a 2 s n " 1 # a 3 s n " 2 # # a n # 1 where b j and a j are the jth elements of the input vectors b and a. [b,a] = residue(r,p,k) converts the partial fraction expansion back to the polynomials with coefficients in b and a. If there are no multiple roots, then Limitations It first obtains the poles with roots. Next, if the fraction is nonproper, the direct term k is found using deconv, which performs polynomial long division. Finally, the residues are determined by evaluating the polynomial with individual roots removed. For repeated roots, resi2 computes the residues at the repeated root locations. Numerically, the partial fraction expansion of a ratio of polynomials represents an ill-posed problem. If the denominator polynomial, a( s), is near a polynomial with multiple roots, then small changes in the data, including roundoff errors, can make arbitrarily large changes in the resulting poles and residues. Problem formulations making use of state-space or zero-pole representations are preferable. b( s) r!!!!!!!!!! 1 r!!!!!!!!!!!!!!!!!!!!!!!!!!!! 2 r n $ # # #!!!!!!!!!!!!!! # k( s) a( s) s " p 1 s " p 2 s " p n The number of poles n is n = length(a)-1 = length(r) = length(p) The direct term coefficient vector is empty if length(b) < length(a); otherwise Examples If the ratio of two polynomials is expressed as then b( s) 5s 3 # 3s 2 " 2s # 7!!!!!!!!!! $!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! a( s) " 4s 3 # 8s # 3 b = [ ] a = [ ] length(k) = length(b)-length(a)+1 If p(j) =... = p(j+m-1) is a pole of multiplicity m, then the expansion includes terms of the form r j r!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! j # 1 s " p j ( s " p j ) 2 r j # m " 1 # # #!!!!!!!!!!!!!!!!!!!!!! ( s " p j ) m and you can calculate the partial fraction expansion as [r, p, k] = residue(b,a) r =

8 residue roots p = k = Now, convert the partial fraction expansion back to polynomial coefficients. [b,a] = residue(r,p,k) 2roots Polynomial roots r = roots(c) r = roots(c) returns a column vector whose elements are the roots of the polynomial c. Row vector c contains the coefficients of a polynomial, ordered in descending powers. If c has n+1 components, the polynomial it represents is c 1 s n!! c n s! c n! 1. See Also References b = a = The result can be expressed as b( s) " 1.25s 3 " 0.75s 2 # 0.50s " 1.75!!!!!!!!!! $!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!!! a( s) s 3 " 2.00s " 0.75 Note that the result is normalized for the leading coefficient in the denominator. deconv, poly, roots [1] Oppenheim, A.V. and R.W. Schafer, Digital Signal Processing, Prentice-Hall, 1975, p. 56. Remarks Note the relationship of this function to p = poly(r), which returns a row vector whose elements are the coefficients of the polynomial. For vectors, roots and poly are inverse functions of each other, up to ordering, scaling, and roundoff error. Examples The polynomial s 3 " 6s 2 " 72s " 27 is represented in MATLAB as p = [ ] The roots of this polynomial are returned in a column vector by r = roots(p) r = The algorithm simply involves computing the eigenvalues of the companion matrix: A = diag(ones(n-1,1),-1); A(1,:) = -c(2:n+1)./c(1); eig(a) It is possible to prove that the results produced are the exact eigenvalues of a matrix within roundoff error of the companion matrix A, but this does not mean that they are the exact roots of a polynomial with coefficients within roundoff error of those in c

9 zplane zplane 7zplane Zero-pole plot zplane(z,p) zplane(b,a) zplane(hd) [hz,hp,ht] = zplane(z,p) Examples For data sampled at 1000 Hz, plot the poles and zeros of a 4th-order elliptic lowpass digital filter with cutoff frequency of 200 Hz, 3 db of ripple in the passband, and 30 db of attenuation in the stopband: [z,p,k] = ellip(4,3,30,200/500); zplane(z,p); title('4th-order Elliptic Lowpass Digital Filter'); This function displays the poles and zeros of discrete-time systems. 4th Order Elliptic Lowpass Digital Filter zplane(z,p) plots the zeros specified in column vector z and the poles specified in column vector p in the current figure window. The symbol 'o' represents a zero and the symbol 'x' represents a pole. The plot includes the unit circle for reference. If z and p are arrays, zplane plots the poles and zeros in the columns of z and p in different colors. You can override the automatic scaling of zplane using or axis([xmin xmax ymin ymax]) Imaginary Part set(gca,'ylim',[ymin ymax]) 0.8 or set(gca,'xlim',[xmin xmax]) Real Part after calling zplane. This is useful in the case where one or a few of the zeros or poles have such a large magnitude that the others are grouped tightly around the origin and are hard to distinguish. zplane(b,a) where b and a are row vectors, first uses roots to find the zeros and poles of the transfer function represented by numerator coefficients b and denominator coefficients a. To generate the same plot with a transfer function representation of the filter, use: [b,a] = ellip(4,3,30,200/500); zplane(b,a) % Transfer function To generate the same plot using a dfilt object and displaying the result in the Filter Visualization Tool (fvtool) use: zplane(hd) finds the zeros and poles of the transfer function represented by the dfilt filter object Hd. The pole-zero plot is displayed in fvtool. [hz,hp,ht] = zplane(z,p) returns vectors of handles to the zero lines, hz, and the pole lines, hp. ht is a vector of handles to the axes/unit circle line and to text objects, which are present when there are multiple zeros or poles. If there are no zeros or no poles, hz or hp is the empty matrix []. [b,a] = ellip(4,3,30,200/500); Hd=dfilt.df1(b,a); zplane(hd)

SIGNALS AND SYSTEMS LABORATORY 4: Polynomials, Laplace Transforms and Analog Filters in MATLAB

SIGNALS AND SYSTEMS LABORATORY 4: Polynomials, Laplace Transforms and Analog Filters in MATLAB INTRODUCTION SIGNALS AND SYSTEMS LABORATORY 4: Polynomials, Laplace Transforms and Analog Filters in MATLAB Laplace transform pairs are very useful tools for solving ordinary differential equations. Most

More information

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER

INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters 4. THE BUTTERWORTH ANALOG FILTER INFINITE-IMPULSE RESPONSE DIGITAL FILTERS Classical analog filters and their conversion to digital filters. INTRODUCTION 2. IIR FILTER DESIGN 3. ANALOG FILTERS 4. THE BUTTERWORTH ANALOG FILTER 5. THE CHEBYSHEV-I

More information

APPLIED SIGNAL PROCESSING

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

More information

3. Array and Matrix Operations

3. Array and Matrix Operations 3. Array and Matrix Operations Almost anything you learned about in your linear algebra classmatlab has a command to do. Here is a brief summary of the most useful ones for physics. In MATLAB matrices

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 05 IIR Design 14/03/04 http://www.ee.unlv.edu/~b1morris/ee482/

More information

DIGITAL SIGNAL PROCESSING UNIT III INFINITE IMPULSE RESPONSE DIGITAL FILTERS. 3.6 Design of Digital Filter using Digital to Digital

DIGITAL SIGNAL PROCESSING UNIT III INFINITE IMPULSE RESPONSE DIGITAL FILTERS. 3.6 Design of Digital Filter using Digital to Digital DIGITAL SIGNAL PROCESSING UNIT III INFINITE IMPULSE RESPONSE DIGITAL FILTERS Contents: 3.1 Introduction IIR Filters 3.2 Transformation Function Derivation 3.3 Review of Analog IIR Filters 3.3.1 Butterworth

More information

Filter Analysis and Design

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

More information

INFE 5201 SIGNALS AND SYSTEMS

INFE 5201 SIGNALS AND SYSTEMS INFE 50 SIGNALS AND SYSTEMS Assignment : Introduction to MATLAB Name, Class&Student ID Aim. To give student an introduction to basic MATLAB concepts. You are required to produce basic program, learn basic

More information

Discrete-Time Systems

Discrete-Time Systems FIR Filters With this chapter we turn to systems as opposed to signals. The systems discussed in this chapter are finite impulse response (FIR) digital filters. The term digital filter arises because these

More information

w n = c k v n k (1.226) w n = c k v n k + d k w n k (1.227) Clearly non-recursive filters are a special case of recursive filters where M=0.

w n = c k v n k (1.226) w n = c k v n k + d k w n k (1.227) Clearly non-recursive filters are a special case of recursive filters where M=0. Random Data 79 1.13 Digital Filters There are two fundamental types of digital filters Non-recursive N w n = c k v n k (1.226) k= N and recursive N M w n = c k v n k + d k w n k (1.227) k= N k=1 Clearly

More information

Chapter 7: IIR Filter Design Techniques

Chapter 7: IIR Filter Design Techniques IUST-EE Chapter 7: IIR Filter Design Techniques Contents Performance Specifications Pole-Zero Placement Method Impulse Invariant Method Bilinear Transformation Classical Analog Filters DSP-Shokouhi Advantages

More information

Digital Signal Processing

Digital Signal Processing COMP ENG 4TL4: Digital Signal Processing Notes for Lecture #24 Tuesday, November 4, 2003 6.8 IIR Filter Design Properties of IIR Filters: IIR filters may be unstable Causal IIR filters with rational system

More information

Digital Signal Processing Lecture 8 - Filter Design - IIR

Digital Signal Processing Lecture 8 - Filter Design - IIR Digital Signal Processing - Filter Design - IIR Electrical Engineering and Computer Science University of Tennessee, Knoxville October 20, 2015 Overview 1 2 3 4 5 6 Roadmap Discrete-time signals and systems

More information

On the Frequency-Domain Properties of Savitzky-Golay Filters

On the Frequency-Domain Properties of Savitzky-Golay Filters On the Frequency-Domain Properties of Savitzky-Golay Filters Ronald W Schafer HP Laboratories HPL-2-9 Keyword(s): Savitzky-Golay filter, least-squares polynomial approximation, smoothing Abstract: This

More information

Signal Processing. Young Won Lim 2/20/18

Signal Processing. Young Won Lim 2/20/18 Copyright (c) 2016 2018 Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version 1.2 or any later version published

More information

ECE 410 DIGITAL SIGNAL PROCESSING D. Munson University of Illinois Chapter 12

ECE 410 DIGITAL SIGNAL PROCESSING D. Munson University of Illinois Chapter 12 . ECE 40 DIGITAL SIGNAL PROCESSING D. Munson University of Illinois Chapter IIR Filter Design ) Based on Analog Prototype a) Impulse invariant design b) Bilinear transformation ( ) ~ widely used ) Computer-Aided

More information

Responses of Digital Filters Chapter Intended Learning Outcomes:

Responses of Digital Filters Chapter Intended Learning Outcomes: Responses of Digital Filters Chapter Intended Learning Outcomes: (i) Understanding the relationships between impulse response, frequency response, difference equation and transfer function in characterizing

More information

Filters and Tuned Amplifiers

Filters and Tuned Amplifiers Filters and Tuned Amplifiers Essential building block in many systems, particularly in communication and instrumentation systems Typically implemented in one of three technologies: passive LC filters,

More information

Butterworth Filter Properties

Butterworth Filter Properties OpenStax-CNX module: m693 Butterworth Filter Properties C. Sidney Burrus This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 3. This section develops the properties

More information

Discrete-time first-order systems

Discrete-time first-order systems Discrete-time first-order systems 1 Start with the continuous-time system ẏ(t) =ay(t)+bu(t), y(0) Zero-order hold input u(t) =u(nt ), nt apple t

More information

EE Experiment 11 The Laplace Transform and Control System Characteristics

EE Experiment 11 The Laplace Transform and Control System Characteristics EE216:11 1 EE 216 - Experiment 11 The Laplace Transform and Control System Characteristics Objectives: To illustrate computer usage in determining inverse Laplace transforms. Also to determine useful signal

More information

LINEAR-PHASE FIR FILTERS DESIGN

LINEAR-PHASE FIR FILTERS DESIGN LINEAR-PHASE FIR FILTERS DESIGN Prof. Siripong Potisuk inimum-phase Filters A digital filter is a minimum-phase filter if and only if all of its zeros lie inside or on the unit circle; otherwise, it is

More information

PS403 - Digital Signal processing

PS403 - Digital Signal processing PS403 - Digital Signal processing 6. DSP - Recursive (IIR) Digital Filters Key Text: Digital Signal Processing with Computer Applications (2 nd Ed.) Paul A Lynn and Wolfgang Fuerst, (Publisher: John Wiley

More information

Chapter 7: Filter Design 7.1 Practical Filter Terminology

Chapter 7: Filter Design 7.1 Practical Filter Terminology hapter 7: Filter Design 7. Practical Filter Terminology Analog and digital filters and their designs constitute one of the major emphasis areas in signal processing and communication systems. This is due

More information

Filter structures ELEC-E5410

Filter structures ELEC-E5410 Filter structures ELEC-E5410 Contents FIR filter basics Ideal impulse responses Polyphase decomposition Fractional delay by polyphase structure Nyquist filters Half-band filters Gibbs phenomenon Discrete-time

More information

Design IIR Butterworth Filters Using 12 Lines of Code

Design IIR Butterworth Filters Using 12 Lines of Code db Design IIR Butterworth Filters Using 12 Lines of Code While there are plenty of canned functions to design Butterworth IIR filters [1], it s instructive and not that complicated to design them from

More information

Cast of Characters. Some Symbols, Functions, and Variables Used in the Book

Cast of Characters. Some Symbols, Functions, and Variables Used in the Book Page 1 of 6 Cast of Characters Some s, Functions, and Variables Used in the Book Digital Signal Processing and the Microcontroller by Dale Grover and John R. Deller ISBN 0-13-081348-6 Prentice Hall, 1998

More information

Stability Condition in Terms of the Pole Locations

Stability Condition in Terms of the Pole Locations Stability Condition in Terms of the Pole Locations A causal LTI digital filter is BIBO stable if and only if its impulse response h[n] is absolutely summable, i.e., 1 = S h [ n] < n= We now develop a stability

More information

Time Series Analysis: 4. Linear filters. P. F. Góra

Time Series Analysis: 4. Linear filters. P. F. Góra Time Series Analysis: 4. Linear filters P. F. Góra http://th-www.if.uj.edu.pl/zfs/gora/ 2012 Linear filters in the Fourier domain Filtering: Multiplying the transform by a transfer function. g n DFT G

More information

Quadrature-Mirror Filter Bank

Quadrature-Mirror Filter Bank Quadrature-Mirror Filter Bank In many applications, a discrete-time signal x[n] is split into a number of subband signals { v k [ n]} by means of an analysis filter bank The subband signals are then processed

More information

UNIT - III PART A. 2. Mention any two techniques for digitizing the transfer function of an analog filter?

UNIT - III PART A. 2. Mention any two techniques for digitizing the transfer function of an analog filter? UNIT - III PART A. Mention the important features of the IIR filters? i) The physically realizable IIR filters does not have linear phase. ii) The IIR filter specification includes the desired characteristics

More information

MITOCW watch?v=jtj3v Rx7E

MITOCW watch?v=jtj3v Rx7E MITOCW watch?v=jtj3v Rx7E The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for free. To

More information

Digital Signal Processing 2/ Advanced Digital Signal Processing, Audio/Video Signal Processing Lecture 10, Frequency Warping, Example

Digital Signal Processing 2/ Advanced Digital Signal Processing, Audio/Video Signal Processing Lecture 10, Frequency Warping, Example Digital Signal Processing 2/ Advanced Digital Signal Processing, Audio/Video Signal Processing Lecture 10, Gerald Schuller, TU Ilmenau Frequency Warping, Example Example: Design a warped low pass filter

More information

Design of IIR filters

Design of IIR filters Design of IIR filters Standard methods of design of digital infinite impulse response (IIR) filters usually consist of three steps, namely: 1 design of a continuous-time (CT) prototype low-pass filter;

More information

Signal Processing. Young Won Lim 2/22/18

Signal Processing. Young Won Lim 2/22/18 Copyright (c) 2016 2018 Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version 1.2 or any later version published

More information

Time Series Analysis: 4. Digital Linear Filters. P. F. Góra

Time Series Analysis: 4. Digital Linear Filters. P. F. Góra Time Series Analysis: 4. Digital Linear Filters P. F. Góra http://th-www.if.uj.edu.pl/zfs/gora/ 2018 Linear filters Filtering in Fourier domain is very easy: multiply the DFT of the input by a transfer

More information

Digital Signal Processing:

Digital Signal Processing: Digital Signal Processing: Mathematical and algorithmic manipulation of discretized and quantized or naturally digital signals in order to extract the most relevant and pertinent information that is carried

More information

EE 521: Instrumentation and Measurements

EE 521: Instrumentation and Measurements Aly El-Osery Electrical Engineering Department, New Mexico Tech Socorro, New Mexico, USA November 1, 2009 1 / 27 1 The z-transform 2 Linear Time-Invariant System 3 Filter Design IIR Filters FIR Filters

More information

Computer-Aided Design of Digital Filters. Digital Filters. Digital Filters. Digital Filters. Design of Equiripple Linear-Phase FIR Filters

Computer-Aided Design of Digital Filters. Digital Filters. Digital Filters. Digital Filters. Design of Equiripple Linear-Phase FIR Filters Computer-Aided Design of Digital Filters The FIR filter design techniques discussed so far can be easily implemented on a computer In addition, there are a number of FIR filter design algorithms that rely

More information

ELEG 305: Digital Signal Processing

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

More information

Like bilateral Laplace transforms, ROC must be used to determine a unique inverse z-transform.

Like bilateral Laplace transforms, ROC must be used to determine a unique inverse z-transform. Inversion of the z-transform Focus on rational z-transform of z 1. Apply partial fraction expansion. Like bilateral Laplace transforms, ROC must be used to determine a unique inverse z-transform. Let X(z)

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

Analog and Digital Filter Design

Analog and Digital Filter Design Analog and Digital Filter Design by Jens Hee http://jenshee.dk October 208 Change log 28. september 208. Document started.. october 208. Figures added. 6. october 208. Bilinear transform chapter extended.

More information

Discrete Time Systems

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

More information

Digital Control & Digital Filters. Lectures 21 & 22

Digital Control & Digital Filters. Lectures 21 & 22 Digital Controls & Digital Filters Lectures 2 & 22, Professor Department of Electrical and Computer Engineering Colorado State University Spring 205 Review of Analog Filters-Cont. Types of Analog Filters:

More information

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

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

More information

Exercises in Digital Signal Processing

Exercises in Digital Signal Processing Exercises in Digital Signal Processing Ivan W. Selesnick September, 5 Contents The Discrete Fourier Transform The Fast Fourier Transform 8 3 Filters and Review 4 Linear-Phase FIR Digital Filters 5 5 Windows

More information

IIR digital filter design for low pass filter based on impulse invariance and bilinear transformation methods using butterworth analog filter

IIR digital filter design for low pass filter based on impulse invariance and bilinear transformation methods using butterworth analog filter IIR digital filter design for low pass filter based on impulse invariance and bilinear transformation methods using butterworth analog filter Nasser M. Abbasi May 5, 0 compiled on hursday January, 07 at

More information

Electronic Circuits EE359A

Electronic Circuits EE359A Electronic Circuits EE359A Bruce McNair B26 bmcnair@stevens.edu 21-216-5549 Lecture 22 578 Second order LCR resonator-poles V o I 1 1 = = Y 1 1 + sc + sl R s = C 2 s 1 s + + CR LC s = C 2 sω 2 s + + ω

More information

DIGITAL SIGNAL PROCESSING. Chapter 6 IIR Filter Design

DIGITAL SIGNAL PROCESSING. Chapter 6 IIR Filter Design DIGITAL SIGNAL PROCESSING Chapter 6 IIR Filter Design OER Digital Signal Processing by Dr. Norizam Sulaiman work is under licensed Creative Commons Attribution-NonCommercial-NoDerivatives 4.0 International

More information

DSP-CIS. Chapter-4: FIR & IIR Filter Design. Marc Moonen

DSP-CIS. Chapter-4: FIR & IIR Filter Design. Marc Moonen DSP-CIS Chapter-4: FIR & IIR Filter Design Marc Moonen Dept. E.E./ESAT-STADIUS, KU Leuven marc.moonen@esat.kuleuven.be www.esat.kuleuven.be/stadius/ PART-II : Filter Design/Realization Step-1 : Define

More information

Transform analysis of LTI systems Oppenheim and Schafer, Second edition pp For LTI systems we can write

Transform analysis of LTI systems Oppenheim and Schafer, Second edition pp For LTI systems we can write Transform analysis of LTI systems Oppenheim and Schafer, Second edition pp. 4 9. For LTI systems we can write yœn D xœn hœn D X kd xœkhœn Alternatively, this relationship can be expressed in the z-transform

More information

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

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

More information

An Iir-Filter Example: A Butterworth Filter

An Iir-Filter Example: A Butterworth Filter An Iir-Filter Example: A Butterworth Filter Josef Goette Bern University of Applied Sciences, Biel Institute of Human Centered Engineering - microlab JosefGoette@bfhch February 7, 2017 Contents 1 Introduction

More information

Lecture 7 Discrete Systems

Lecture 7 Discrete Systems Lecture 7 Discrete Systems EE 52: Instrumentation and Measurements Lecture Notes Update on November, 29 Aly El-Osery, Electrical Engineering Dept., New Mexico Tech 7. Contents The z-transform 2 Linear

More information

DHANALAKSHMI COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING EC2314- DIGITAL SIGNAL PROCESSING UNIT I INTRODUCTION PART A

DHANALAKSHMI COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING EC2314- DIGITAL SIGNAL PROCESSING UNIT I INTRODUCTION PART A DHANALAKSHMI COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING EC2314- DIGITAL SIGNAL PROCESSING UNIT I INTRODUCTION PART A Classification of systems : Continuous and Discrete

More information

How to manipulate Frequencies in Discrete-time Domain? Two Main Approaches

How to manipulate Frequencies in Discrete-time Domain? Two Main Approaches How to manipulate Frequencies in Discrete-time Domain? Two Main Approaches Difference Equations (an LTI system) x[n]: input, y[n]: output That is, building a system that maes use of the current and previous

More information

UNIVERSITY OF OSLO. Faculty of mathematics and natural sciences. Forslag til fasit, versjon-01: Problem 1 Signals and systems.

UNIVERSITY OF OSLO. Faculty of mathematics and natural sciences. Forslag til fasit, versjon-01: Problem 1 Signals and systems. UNIVERSITY OF OSLO Faculty of mathematics and natural sciences Examination in INF3470/4470 Digital signal processing Day of examination: December 1th, 016 Examination hours: 14:30 18.30 This problem set

More information

EECE 301 Signals & Systems Prof. Mark Fowler

EECE 301 Signals & Systems Prof. Mark Fowler EECE 3 Signals & Systems Prof. ark Fowler Note Set #28 D-T Systems: DT Filters Ideal & Practical /4 Ideal D-T Filters Just as in the CT case we can specify filters. We looked at the ideal filter for the

More information

Maximally Flat Lowpass Digital Differentiators

Maximally Flat Lowpass Digital Differentiators Maximally Flat Lowpass Digital Differentiators Ivan W. Selesnick August 3, 00 Electrical Engineering, Polytechnic University 6 Metrotech Center, Brooklyn, NY 0 selesi@taco.poly.edu tel: 78 60-36 fax: 78

More information

LABORATORY 3 FINITE IMPULSE RESPONSE FILTERS

LABORATORY 3 FINITE IMPULSE RESPONSE FILTERS LABORATORY 3 FINITE IMPULSE RESPONSE FILTERS 3.. Introduction A digital filter is a discrete system, used with the purpose of changing the amplitude and/or phase spectrum of a signal. The systems (filters)

More information

The Approximation Problem

The Approximation Problem EE 508 Lecture 3 The Approximation Problem Classical Approximating Functions - Thompson and Bessel Approximations Review from Last Time Elliptic Filters Can be thought of as an extension of the CC approach

More information

Digital Signal Processing Lecture 9 - Design of Digital Filters - FIR

Digital Signal Processing Lecture 9 - Design of Digital Filters - FIR Digital Signal Processing - Design of Digital Filters - FIR Electrical Engineering and Computer Science University of Tennessee, Knoxville November 3, 2015 Overview 1 2 3 4 Roadmap Introduction Discrete-time

More information

Multirate Digital Signal Processing

Multirate Digital Signal Processing Multirate Digital Signal Processing Basic Sampling Rate Alteration Devices Up-sampler - Used to increase the sampling rate by an integer factor Down-sampler - Used to decrease the sampling rate by an integer

More information

UNIVERSITI SAINS MALAYSIA. EEE 512/4 Advanced Digital Signal and Image Processing

UNIVERSITI SAINS MALAYSIA. EEE 512/4 Advanced Digital Signal and Image Processing -1- [EEE 512/4] UNIVERSITI SAINS MALAYSIA First Semester Examination 2013/2014 Academic Session December 2013 / January 2014 EEE 512/4 Advanced Digital Signal and Image Processing Duration : 3 hours Please

More information

Digital Signal Processing

Digital Signal Processing COMP ENG 4TL4: Digital Signal Processing Notes for Lecture #21 Friday, October 24, 2003 Types of causal FIR (generalized) linear-phase filters: Type I: Symmetric impulse response: with order M an even

More information

Basic Design Approaches

Basic Design Approaches (Classic) IIR filter design: Basic Design Approaches. Convert the digital filter specifications into an analog prototype lowpass filter specifications. Determine the analog lowpass filter transfer function

More information

Tunable IIR Digital Filters

Tunable IIR Digital Filters Tunable IIR Digital Filters We have described earlier two st-order and two nd-order IIR digital transfer functions with tunable frequency response characteristics We shall show now that these transfer

More information

Lab 3 & 4. LTI Systems, the Z-Transform, and an Introduction

Lab 3 & 4. LTI Systems, the Z-Transform, and an Introduction E E 2 7 5 Lab January 28, 2015 Lab 3 & 4. LTI Systems, the Z-Transform, and an Introduction to Filtering Discrete Linear Time Invariant Systems - Short Review x[n] h[n] y[n] A system is: linear if y[n]

More information

Fourier Series Representation of

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

More information

E : Lecture 1 Introduction

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

More information

Filter Design Problem

Filter Design Problem Filter Design Problem Design of frequency-selective filters usually starts with a specification of their frequency response function. Practical filters have passband and stopband ripples, while exhibiting

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

MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11

MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11 MATLAB and Mathematical Introduction Will be discussed in class on 1/24/11 GEOP 523; Theoretical Seismology January 17, 2011 Much of our work in this class will be done using MATLAB. The goal of this exercise

More information

ECE 203 LAB 1 MATLAB CONTROLS AND SIMULINK

ECE 203 LAB 1 MATLAB CONTROLS AND SIMULINK Version 1.1 1 of BEFORE YOU BEGIN PREREQUISITE LABS ECE 01 and 0 Labs EXPECTED KNOWLEDGE ECE 03 LAB 1 MATLAB CONTROLS AND SIMULINK Linear systems Transfer functions Step and impulse responses (at the level

More information

Lectures: Lumped element filters (also applies to low frequency filters) Stub Filters Stepped Impedance Filters Coupled Line Filters

Lectures: Lumped element filters (also applies to low frequency filters) Stub Filters Stepped Impedance Filters Coupled Line Filters ECE 580/680 Microwave Filter Design Lectures: Lumped element filters (also applies to low frequency filters) Stub Filters Stepped Impedance Filters Coupled Line Filters Lumped Element Filters Text Section

More information

INF3440/INF4440. Design of digital filters

INF3440/INF4440. Design of digital filters Last week lecture Today s lecture: Chapter 8.1-8.3, 8.4.2, 8.5.3 INF3440/INF4440. Design of digital filters October 2004 Last week lecture Today s lecture: Chapter 8.1-8.3, 8.4.2, 8.5.3 Last lectures:

More information

Signal Processing. Young Won Lim 3/3/18

Signal Processing. Young Won Lim 3/3/18 Copyright (c) 2016 2018 Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version 1.2 or any later version published

More information

We have shown earlier that the 1st-order lowpass transfer function

We have shown earlier that the 1st-order lowpass transfer function Tunable IIR Digital Filters We have described earlier two st-order and two nd-order IIR digital transfer functions with tunable frequency response characteristics We shall show now that these transfer

More information

Let H(z) = P(z)/Q(z) be the system function of a rational form. Let us represent both P(z) and Q(z) as polynomials of z (not z -1 )

Let H(z) = P(z)/Q(z) be the system function of a rational form. Let us represent both P(z) and Q(z) as polynomials of z (not z -1 ) Review: Poles and Zeros of Fractional Form Let H() = P()/Q() be the system function of a rational form. Let us represent both P() and Q() as polynomials of (not - ) Then Poles: the roots of Q()=0 Zeros:

More information

DISCRETE-TIME SIGNAL PROCESSING

DISCRETE-TIME SIGNAL PROCESSING THIRD EDITION DISCRETE-TIME SIGNAL PROCESSING ALAN V. OPPENHEIM MASSACHUSETTS INSTITUTE OF TECHNOLOGY RONALD W. SCHÄFER HEWLETT-PACKARD LABORATORIES Upper Saddle River Boston Columbus San Francisco New

More information

Time series analysis in neuroscience. Lecture 6. FIR and IIR filters

Time series analysis in neuroscience. Lecture 6. FIR and IIR filters Time series analysis in neuroscience Lecture 6. FIR and IIR filters Alexander Zhigalov / Dept. of CS, University of Helsinki and Dept. of NBE, Aalto University Time series analysis in neuroscience 2 Outline

More information

Signal Processing. Young Won Lim 2/24/18

Signal Processing. Young Won Lim 2/24/18 Copyright (c) 2016 2018 Young W. Lim. Permission is granted to copy, distribute and/or modify this document under the terms of the GNU Free Documentation License, Version 1.2 or any later version published

More information

Optimum Ordering and Pole-Zero Pairing of the Cascade Form IIR. Digital Filter

Optimum Ordering and Pole-Zero Pairing of the Cascade Form IIR. Digital Filter Optimum Ordering and Pole-Zero Pairing of the Cascade Form IIR Digital Filter There are many possible cascade realiations of a higher order IIR transfer function obtained by different pole-ero pairings

More information

Electronic Circuits EE359A

Electronic Circuits EE359A Electronic Circuits EE359A Bruce McNair B26 bmcnair@stevens.edu 21-216-5549 Lecture 22 569 Second order section Ts () = s as + as+ a 2 2 1 ω + s+ ω Q 2 2 ω 1 p, p = ± 1 Q 4 Q 1 2 2 57 Second order section

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

REAL TIME DIGITAL SIGNAL PROCESSING

REAL TIME DIGITAL SIGNAL PROCESSING REAL TIME DIGITAL SIGNAL PROCESSING www.electron.frba.utn.edu.ar/dplab Digital Filters FIR and IIR. Design parameters. Implementation types. Constraints. Filters: General classification Filters: General

More information

UNIVERSITY OF OSLO. Please make sure that your copy of the problem set is complete before you attempt to answer anything.

UNIVERSITY OF OSLO. Please make sure that your copy of the problem set is complete before you attempt to answer anything. UNIVERSITY OF OSLO Faculty of mathematics and natural sciences Examination in INF3470/4470 Digital signal processing Day of examination: December 9th, 011 Examination hours: 14.30 18.30 This problem set

More information

Laplace Transform Analysis of Signals and Systems

Laplace Transform Analysis of Signals and Systems Laplace Transform Analysis of Signals and Systems Transfer Functions Transfer functions of CT systems can be found from analysis of Differential Equations Block Diagrams Circuit Diagrams 5/10/04 M. J.

More information

EE -213 BASIC CIRCUIT ANALYSIS LAB MANUAL

EE -213 BASIC CIRCUIT ANALYSIS LAB MANUAL EE -213 BASIC CIRCUIT ANALYSIS LAB MANUAL EE 213 Spring 2008 LABORATORY #1 INTRODUCTION TO MATLAB INTRODUCTION The purpose of this laboratory is to introduce you to Matlab and to illustrate some of its

More information

Digital Signal Processing IIR Filter Design via Bilinear Transform

Digital Signal Processing IIR Filter Design via Bilinear Transform Digital Signal Processing IIR Filter Design via Bilinear Transform D. Richard Brown III D. Richard Brown III 1 / 12 Basic Procedure We assume here that we ve already decided to use an IIR filter. The basic

More information

Lecture 4: Matrices. Math 98, Spring Math 98, Spring 2018 Lecture 4: Matrices 1 / 20

Lecture 4: Matrices. Math 98, Spring Math 98, Spring 2018 Lecture 4: Matrices 1 / 20 Lecture 4: Matrices Math 98, Spring 2018 Math 98, Spring 2018 Lecture 4: Matrices 1 / 20 Reminders Instructor: Eric Hallman Login:!cmfmath98 Password: c@1analog Class Website: https://math.berkeley.edu/~ehallman/98-fa18/

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

IT DIGITAL SIGNAL PROCESSING (2013 regulation) UNIT-1 SIGNALS AND SYSTEMS PART-A

IT DIGITAL SIGNAL PROCESSING (2013 regulation) UNIT-1 SIGNALS AND SYSTEMS PART-A DEPARTMENT OF ELECTRONICS AND COMMUNICATION ENGINEERING IT6502 - DIGITAL SIGNAL PROCESSING (2013 regulation) UNIT-1 SIGNALS AND SYSTEMS PART-A 1. What is a continuous and discrete time signal? Continuous

More information

LAB MANUAL. Department of Electrical & Electronics Engineering. University Institute of Engineering and Technology, Panjab University, Chandigarh

LAB MANUAL. Department of Electrical & Electronics Engineering. University Institute of Engineering and Technology, Panjab University, Chandigarh Department of Electrical & Electronics Engineering LAB MANUAL SUBJECT: DIGITAL SIGNAL PROCESSING Lab [EE752] B.E/B.E MBA Third Year VI Semester (Branch: EEE) University Institute of Engineering and Technology,

More information

Lecture 19 IIR Filters

Lecture 19 IIR Filters Lecture 19 IIR Filters Fundamentals of Digital Signal Processing Spring, 2012 Wei-Ta Chu 2012/5/10 1 General IIR Difference Equation IIR system: infinite-impulse response system The most general class

More information

1 Introduction & Objective. 2 Warm-up. Lab P-16: PeZ - The z, n, and O! Domains

1 Introduction & Objective. 2 Warm-up. Lab P-16: PeZ - The z, n, and O! Domains DSP First, 2e Signal Processing First Lab P-6: PeZ - The z, n, and O! Domains The lab report/verification will be done by filling in the last page of this handout which addresses a list of observations

More information

CMPT 889: Lecture 5 Filters

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

More information

Ch. 7: Z-transform Reading

Ch. 7: Z-transform Reading c J. Fessler, June 9, 3, 6:3 (student version) 7. Ch. 7: Z-transform Definition Properties linearity / superposition time shift convolution: y[n] =h[n] x[n] Y (z) =H(z) X(z) Inverse z-transform by coefficient

More information

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

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

More information