DSP MANUAL 01-10-2024-25
DSP MANUAL 01-10-2024-25
Department Vision
Department Mission
Module – 5
Realization of IIR & FIR Filters: Direct form I and Direct form II realization of an IIR filter, Cascade
realization of an IIR filter, Parallel realization of an IIR filter, Direct form I realization of FIR filter,
Lattice realization of FIR filter.
Practical component of IPCC
Experiments to be executed using MATLAB/SCILAB/OCTAVE
1.Verification of Sampling theorem
2.Implementation of DFT using built-in function FFT and user defined function.
3.To perform Circular convolution of two given signals.
4.To perform Auto and Cross Correlation of two given signals
5.To find impulse response of a system
6. IIR filter implementation
7.FIR filter implementation
8. DSP kit experiments for performing linear and circular convolution
9.DSP kit experiment to compute DFT of given signal.
10. DSP kit experiment to find impulse response of a system.
11 DSP kit experiment to add and cancel the noise
Textbooks:
1. Proakis & Monalakis, “Digital signal processing Principles Algorithms & Applications”,
4th Edition, Pearson Education, New Delhi,2007.
References:
1. Sanjit K Mitra, “Digital Signal Processing, A Computer Based Approach”, 4 th Edition, McGraw
Hill Education, 2013.
2. Oppenheim & Schaffer, “Discrete Time Signal Processing”, PHI,2003.
3. D. Ganesh Rao and Vineeth P, “Digital Signal Processing” Gejji, Cengage India Private Limited,
2017.
Web links/e-resources:
https://onlinecourses.nptel.ac.in/noc21_ee20/
MATLAB
Although MATLAB is intended primarily for numerical computing, an optional toolbox uses
the MuPAD symbolic engine, allowing access to symbolic computing abilities. An additional
package, Simulink, adds graphical multi-domain simulation and model-based
design for dynamic and embedded systems.
As of 2017, MATLAB has roughly one million users across industry and academia. MATLAB
users come from various backgrounds of engineering, science, and economics. There are
various toolboxes in MATLAB like signal processing toolbox, image processing toolbox,
neural network toolbox, statistics toolbox, financial toolbox, Bioinformatics toolboxes.
The Matlab screen has 4 important windows along with Editor (where programs can be
written and stored). These are Command window where we type commands and
outputs/error messages are seen, Command history window where past commands are
remembered (we can re-run any command by clicking on the commands), Workspace
window which stores all the variables used and Current Directory window shows the files
in current directory.
In this semester students are required to register in Math works website using their official
email ID and download the MATLAB software from the following link.
https://www.mathworks.com/academia/tah-portal/bms-institute-of-technology-
31463638.html
The installation might take minimum of 15-20 GB of your internet data as well as
same amount of system memory.
EXPERIMENT NO 1
Verification of Sampling Theorem
Theory:
● Sampling is a process of converting a continuous time signal (analog signal)
x(t) into a discrete time signal x[n], which is represented as a sequence of
numbers. (A/D converter)
● Converting back x[n] into analog (resulting in x (t ) is the process of
reconstruction. (D/A converter)
● Techniques for reconstruction-(i) ZOH (zero order hold) interpolation results
in a staircase waveform, is implemented by MATLAB plotting function
stairs (n, x), (ii) FOH (first order hold) where the adjacent samples are joined
by straight lines is implemented by MATLAB plotting function plot (n,
x),(iii) spline interpolation, etc.
● For x (t ) to be exactly the same as x(t), sampling theorem in the generation
of x(n) from x(t) is used. The sampling frequency fs determines the spacing
between samples.
● Aliasing-A high frequency signal is converted to a lower frequency, results
due to under sampling. Though it is undesirable in ADCs, it finds practical
applications in stroboscope and sampling oscilloscopes.
Algorithm:
1. Input the desired frequency fmax (for which sampling theorem is to be
verified).
2. Generate an analog signal xt of frequency fmax for comparison.
3. Generate over sampled, Nyquist & Under sampled discrete time signals.
4. Plot the waveforms and hence prove sampling theorem.
MATLAB Implementation:
MATLAB Program:
tfinal=0.05;
t=0:0.00005: tfinal;
fmax=input('Enter analog frequency');
xn1=sin(2*pi*n1*fmax);
%plot the analog & sampled signals
subplot(3,1,1);
plot(t,xt,'b',n1,xn1,'r*-');
title('Under sampling plot');
%Condition forNyquistplot
fs2=2*fmax;
n2=0:1/fs2:tfinal;
xn2=sin(2*pi*fmax*n2);
subplot(3,1,2);
plot(t,xt,'b',n2,xn2,'r*-');
title('Nyquist plot');
%Condition for Oversampling
fs3=10*fmax;
n3=0:1/fs3:tfinal;
xn3=sin(2*pi*fmax*n3);
subplot(3,1,3);
plot(t,xt,'b',n3,xn3,'r*-');
title('Oversampling plot');
xlabel('time');
ylabel('amplitude');
legend('analog','discrete')
Result:
Enter analog frequency 200
Output Waveforms
Plots of a sampled sine wave of 200Hz
Students are expected to use interp1q () function to connect the samples in the
sampled signal.
Inference:
1. From the under-sampling plot observe the aliasing effect. The analog signal
is of 200Hz (T=0.005s). The reconstructed (from under sampled plot) is of a
lower frequency. The alias frequency is computed as fmax-fs1 = 200-1.3*200
= 200-260= -60Hz
This is verified from the plot. The minus sign results in a 180˚ phase
shift.
(For example: 3kHz& 6kHz sampled at 5kHz result in aliases of -2kHz (3k-
5k) & 1kHz (6k-5k) respectively)
2. Sampling at the Nyquist rate results in samples sin(πn) which are identically
zero, i.e., we are sampling at the zero crossing points and hence the signal
VIVA Questions
1. Define plot, stem, and subplot in MATLAB.
2. List all the functions used in the above program.
3. Briefly explain sampling theorem.
4. What is aliasing?
EXPERIMENT NO 2
Computation of N point DFT of a Given Sequence and to Plot Magnitude
and Phase Spectrum.
MATLAB Implementation:
MATLAB has an inbuilt function ‘FFT’ which computes the Discrete Fourier
transform.
FFT(X) is the discrete Fourier transform (DFT) of vector X. For length N input
vector x, the DFT is a length N vector X, with elements N. FFT(X,N) is the N-point
FFT, padded with zeros if X has less than N points and truncated if it has more.
The magnitude spectrum is computed using the function ABS Absolute value.
ABS(X) is the absolute value of the elements of X. When X is complex, ABS(X)
is the complex modulus (magnitude) of the elements of X.
The phase spectrum is computed using the function ANGLE Phase angle.
ANGLE (H) returns the phase angles, in radians, of a matrix with complex
elements.
Matlab Program:
N-point FFT and IFFT of a given sequence
clc;
clear all;
close all;
x=input ('Enter the sequence x (n)');
N=length(x);
y=fft(x,N);
disp(y);
mag=abs(y);
phase=angle(y);
subplot(2,2,1);
stem(x);
grid on;
title('Input Data Sequence x(n)');
subplot(2,2,3);
stem(mag);
grid on;
title('Magnitude Plot');
subplot(2,2,2);
stem(phase);
grid on;
title('Phase plot');
z=ifft(y,N);
mag1=real(z);
subplot(2,2,4);
stem(mag1);
grid on;
title('Signal Sequence constituted from Spectrum');
Result:
Enter the sequence x(n) [0.5 0.5 0.5 0.5 0 0.5 0.5 0.5]
3.5000 0.5000 -0.5000 0.5000 -0.5000 0.5000 -0.5000 0.5000
Output waveform
Input Data Phase
0 Sequence x(n) 4 plot
.0 3
.0 2
.0 1
.0 00
0 2 4 6 8 2 4 6 8
Magnitude Signal Sequence constituted from
4 0
Spectrum
Plot
3 .0
2 .0
1 .0
00 .0
2 4 6 8 0 2 4 6 8
ph=angle(y);
subplot(2,1,1)
stem(amp);
xlabel (‘MAGNITUDE’);
ylabel (‘K’);
title (‘magnitude plot’);
stem (ph*180/pi);
xlabel(‘phase’);
ylabel(‘K’);
title(‘phase plot’);
clc:
xk=input(‘enter the sequence x(k)’);
N=input(‘enter the number of points of computation’);
y=idft(xk,N);
disp(y);
amp=abs(y);
ph=angle(y);
subplot(2,1,1)
stem(amp);
xlabel(‘MAGNITUDE’);
ylabel(‘K’);
title(‘magnitude plot’);
stem(ph*180/pi);
xlabel(‘phase’);
ylabel(‘K’);
title(‘phase plot’);
WNnk=WN.^(-nk);
xn=(xk*WNnk)/N;
Result:
Enter the sequence Xk=[4, 1-2.4142i ,0,1-0.4142i,0, 1.0000+0.4142i ,
0,1+2.4142i]
x(n)=[1 1 1 1 0 0 0 0]
Inputs -
Run1: Give 4 point sequence and find 4 point DFT
Run2: Give 8 point sequence and find 8 point DFT
Run 3: Give a Sinusoidal Signal with a frequency 250 Hz with fs = 8 KHz
and sample it for 64 points and perform 64 point DFT on it.
Run 4: Give a Sinusoidal Signal with a frequency 250 Hz and 500 Hz with fs
= 8 KHz and sample it for 64 point and perform 64 point DFT on it.
Open ended Experiments :
VIVA Questions:
1. Explain DFT
2. What are the methods of finding DFT
3. Explain differences between DFT and FFT
4. Explain how functions can be declared in MATLB.
5. Explain MATLAB function fft(x)
6. How can user create a MATLAB function
EXPERIMENT NO 3
A. Circular Convolution of Two Given Sequences
Steps for circular convolution are the same as the usual convolution, except all
index calculations are done "mod N" = "on the wheel".
o Plot f [m] and h [−m] as shown in Fig. 4.1. (use f(m)
instead of x(k))
o Multiply the two sequences
o Add to get y[m]
o "Spin" h[−m] n times Anti Clockwise (counter-
clockwise) to get h[n-m].
x[n] and h[n] can be both finite or infinite duration sequences. If infinite sequences,
they should be periodic, and the N is chosen to be at least equal to the period. If
they are finite sequences N is chosen as >= to max(xlength, hlength). Whereas in
linear convolution N>= xlength+hlength-1.
● Say x[n]={-2,3,1,1} and N = 5, then the x[-1] and x[-2] samples are plotted
at x[N-1] = x[-4] and x[N-2] =x[-3] places. Now x[n] is entered as x[n] = {1,
1, 0,-2,3}.
MATLAB Implementation:
MATLAB recognizes index 1 to be positive maximum. Index 0 is not
recognized. Hence in the below program wherever y, x and h sequences are
accessed, the index is added with +1. The modulo index calculation for circular
convolution is carried out using the function - MOD Modulus (signed remainder
after division). MOD( x, y) is x - y.*floor(x./y) if y ~= 0. By convention, MOD(x,0)
is x. The input x and y must be real arrays of the same size, or real scalars. MOD( x,
y) has the same sign as y while REM( x, y) has the same sign as x. MOD( x, y) and
REM( x, y) are equal if x and y have the same sign, but differ by y if x and y have
different signs.
MATLAB Program:
Program to find circular convolution of two sequences by padding
zeroes
clc;
clear all;
close all;
g=input('Enter the first sequence');
h=input('Enter the second sequence');
N1=length(g);
N2=length(h);
N=max(N1,N2);
N3=N1-N2;
if(N3>=0)
h=[h,zeros(1,N3)];
else
g=[g,zeros(1,-N3)];
end
for n=0:N-1
y(n+1)=0;
for k=0:N-1
i=mod((n-k),N); %calculation of x index
if i<0
i=i+N;
end %end of ‘if’
y(n+1)=y(n+1)+h(k+1)*g(i+1);
end %end of inner ‘for loop’
end %end of inner ‘for loop’
disp('The resultant signal is');y
figure(1);
subplot(3,1,1);
stem(g);
title('The first sequence is');
grid on;
subplot(3,1,2);
stem(h);
title('The second sequence is');
grid on;
subplot(3,1,3);
stem(y);
title('The circularly convolved sequence is');
grid on;
Result:
Enter the first sequence [1 1 1 1]
Enter the second sequence [1 2 3 4]
The resultant signal is
y =10 10 10 10
Output Waveform
VIVA Questions :
1. Write A Program to find the circular convolution of two sequences using
Matrix Method
2. Explain how circular convolution can be obtained.
3. Give the different methods for performing circular convolution.
EXPERIMENT NO 4
Theory:
● Correlation is mathematical technique which indicates whether 2 signals are
related and in a precise quantitative way how much they are related. A measure
of similarity between a pair of energy signals x[n] and y[n] is given by the cross
∞
r xy [l ]= ∑ x [ n ] y [n− l]; l= 0,± 1,± 2, . ..
correlation sequence rxy [l] defined by n= − ∞ .
● The parameter ‘l’ called ‘lag’ indicates the time shift between the pair.
● Autocorrelation sequence of x[n] is given by
∞
r xx [l ]= ∑ x [ n ]x [ n− l ]; l= 0,± 1,± 2, .. .
n= − ∞
This is verified in Fig. 5.1, where the autocorrelation of the rectangular pulse
(square) has a maximum value at l=0. All other samples are of lower value. Also
the maximum value = 11 = energy of the pulse [12+12+12..].
o A time shift of a signal does not change its autocorrelation sequence. For
example, let y[n]=x[n-k]; then ryy[l] = rxx[l] i.e., the autocorrelation of x[n] and
y[n] are the same regardless of the value of the time shift k. This can be verified
with a sine and cosine sequences of same amplitude and frequency will have
identical autocorrelation functions.
For power signals the autocorrelation sequence is given by
k
1
r xx [l ]= lim
2k+
∑ x[ n] x[n− l];l= 0,± 1,± 2,...
1 n= − k
k →∞ and for periodic signals with period N it is
N− 1
1
r xx [l ]=
N
∑ x [ n ] x [n− l ]; l= 0,± 1,± 2,. ..
n= 0 and this rxx[l] is also
o Periodic with N. This is verified in Fig. 5.3 where we use the periodicity
property of the autocorrelation sequence to determine the period of the periodic
signal y[n] which is x[n] (=cos(0.25*pi*n)) corrupted by an additive uniformly
distributed random noise of amplitude in the range [-0.5 0.5]
Algorithm:
1. Input the sequence as x.
2. Use the ‘xcorr’ function to get auto correlated output r.
3. Plot the sequences.
MATLAB Implementation:
MATLAB has the inbuilt function XCORR(A), when A is a vector, is the
auto-correlation sequence. If A is of length M vector (M>1), then the xcorr function
returns the length 2*M-1 auto-correlation sequence. The zeroth lag of the
output correlation is in the middle of the sequence at element M.
XCORR(...,MAXLAG) computes the (auto/cross) correlation over the range
of lags: -MAXLAG to MAXLAG, i.e., 2*MAXLAG+1 lags. If missing, default is
MAXLAG = M-1.
[C,LAGS] = XCORR(...) returns a vector of lag indices (LAGS).
MATLAB Programs
%Computation of Autocorrelation of a rectangular Sequence
x = input ('Type in the reference sequence = ');
% Compute the correlation sequence
n = length(x)-1;
r = conv(x, fliplr(x));
disp('autocorrelation sequence r=');
disp(r);
%plot the sequences
subplot (2,1,1)
stem (x);
title ('square sequence');
subplot
(2,1,2)
k = -n: n;
stem (k, r);
title('autocorrelation output');
xlabel('Lag index');
ylabel('Amplitude');
Result:
Autocorrelation sequence r = 1.0000 2.0000 3.0000 4.0000 5.0000
6.0000 7.0000 8.0000 9.0000 10.0000 11.0000 10.0000 9.0000
8.0000 7.0000 6.0000 5.0000 4.0000 3.0000 2.0000 1.0000
VIVA Questions
1. Explain the differences between convolution and correlation
2. List the methods for performing correlation
3. Which are the Mat lab functions used to perform correlation
4. Explain the following functions
a. rand(1,N)-0.5
b. fliplr(Y)
c. xcorr(Y)
r xx [l ]≤ √
r xx [ 0 ]r yy [0 ]= √
εx εy
2) The cross correlation of two sequences x[n] and y[n]=x[n-k] shows a peak
at the value of k. Hence cross correlation is employed to compute the exact
value of the delay k between the 2 signals. Used in radar and sonar
applications, where the received signal reflected from the target is the
delayed version of the transmitted signal (measure delay to determine the
distance of the target).
3) The ordering of the subscripts xy specifies that x[n] is the reference
sequence that remains fixed in time, whereas the sequence y[n] is shifted
r yx [l ]= r xy [− l]
w.r.t x[n]. If y[n] is the reference sequence then . Hence ryx[l]
is obtained by time reversing the sequence rxy[l].
Algorithm:
1. Input the sequence as x and y.
2. Use the ‘xcorr’ function to get cross correlated output r.
3. Plot the sequences.
MATLAB Implementation:
MATLAB has the inbuilt function XCORR: Say C = XCORR(A,B), where A and
B are length M vectors (M>1), returns the length 2*M-1 cross-correlation sequence
C. If A and B are of different length, the shortest one is zero-padded. Using
convolution to implement correlation, the instruction is FLIPLR Flip matrix in
left/right direction. FLIPLR(X) returns X with row preserved and columns flipped
in the left/right direction. X = 1 2 3 becomes 3 2 1.
MATLAB Programs
% Computation of Cross-correlation Sequence using folded sequence and
convolution
Result:
Type in the reference sequence = [1 3 -2 1 2 -1 4 4 2]
Type in the second sequence = [2 -1 4 1 -2 3]
Cross correlation output is =
3 7 -11 14 13 -15 28 6 -2 21 12 12 6 4
Output Waveforms
Inference:
Strong peak of 15 at lag = -2 implies the delay between xi and x2 is 2.
Also peak =15=energy of xi (1+22+32+ (-1)2) implies that both xi and x2 are
strongly correlated.
%consider the below sequences
xr=[1,2,3,-1];
x2=[3,-1,1,2];
xcorr(xr,x2) ans ={2,5,7,2,2,10,-3}
xcorr(x2,xr) ans ={-3,10,2,2,7,5,2}
Inference:
Strong peak of 10 at lag = 2 implies the delay between xr and x2 is 2, but since
10<15, it implies that xr and x2 are uncorrelated slightly (may be due to noise, etc).
r yx [l ]= r xy [− l]
is verified.
EXPERIMENT NO 5
Solving a Given Difference Equation
Theory:
● A difference equation with constant coefficients describes a LTI system. For
example the difference equation y[n] + 0.8y[n-2] + 0.6y[n-3] = x[n] +
0.7x[n-1] + 0.5x[n-2] describes a LTI system of order 3. The coefficients
0.8, 0.7, etc. are all constant i.e., they are not functions of time (n). The
difference equation y[n]+0.3ny[n-1]=x[n] describes a time varying system
as the coefficient 0.3n is not constant.
● The difference equation can be solved to obtain y[n], the output for a given
input x[n] by rearranging as y[n] = x[n] + 0.7x [n-1]+0.5x[n-2]- 0.8y[n-2]-
0.6y[n-3] and solving.
● The output depends on the input x[n]
o With x[n]= δ[n], an impulse, the computed output y[n] is the impulse
response.
o If x[n]=u[n], a step response is obtained.
o If x[n] = cos(wn) is a sinusoidal sequence, a steady state response is
obtained (wherein y[n] is of the same frequency as x[n], with only an
amplitude gain and phase shift-refer Fig.7.3).
o Similarly for any arbitrary sequence of x[n], the corresponding output
response y[n] is computed.
MATLAB Implementation:
MATLAB has an inbuilt function ‘filter’ to solve difference equations
numerically, given the input and difference equation coefficients (b, a).
y=filter (b,a,x)
where x is the input sequence, y is the output sequence which is of same length as
x.
Given a difference equation a0y[n]+a1y[n-1]+a2y[n-2]=b0x[n]+b2x[n-2], the
coefficients are written in a vector as b=[b0 0 b2] and a=[a0 a1 a2]. Note the zero in
b (x[n-1] term is missing).
Also remember a0, the coefficient of y[n] should always be 1.
For impulse response x[n] = {1, 0, 0, 0, ----} the number of zeros = the length of
the IIR response required (say 100 implemented by function zeros(1,99)).
For step response x[n]={1,1,1,1,----} the number of one’s = the length of the IIR
response required-1 (say 100 implemented by function ones(1,100).
Similarly for any given x[n] sequence, the response y[n] can be calculated.
Given Problem
1) Difference equation y(n) - y(n-1) + 0.9y(n-2) = x(n);
Calculate impulse response h(n) and also step response at n=0,…..,100
2) Plot the steady state response y[n] to x[n]=cos(0.05πn)u(n), given y[n]-0.8y[n-
1]=x[n]
MATLAB Program:
%To find Impulse Response
N=input ('Length of response required=');
b=[1]; %x[n] coefficient
a=[1,-1,0.9]; %y coefficients
%impulse input
h=[1,zeros(1,N-1)];
%time vector for plotting
n=0:1:N-1;
%impulse response
y=filter(b,a,h);
subplot (2,1,1);
stem(n,h);
title('impulse input');
xlabel('n');
ylabel('impulse)');
subplot(2,1,2);
stem(n,y);
title('impulse response');
xlabel('n');
ylabel('y(n)');
Result:
Length=100
Output Waveform
Output Waveform
VIVA Questions
1.Explain the Matlab function filter
2.How to find various responses using filter function
EXPERIMENT NO 6
Design and Implementation of IIR filter to meet given specifications.
Theory:
There are two methods of stating the specifications as illustrated in previous
program. In the first program, the given specifications are directly converted to
digital form and the designed filter is also implemented. In the last two programs
the butterworth and chebyshev filters are designed using bilinear transformation
(for theory verification).
Method I: Given the order N, cutoff frequency fc, sampling frequency fs and the
IIR filter type (butterworth, cheby1, cheby2).
● Step 1: Compute the digital cut-off frequency Wc (in the range -π <Wc< π, with
π corresponding to fs/2) for fc and fs in Hz. For example let fc=400Hz,
fs=8000Hz
Wc = 2*π* fc / fs = 2* π * 400/8000 = 0.1* π radians
For MATLAB the Normalized cut-off frequency is in the range 0 and 1, where
1 corresponds to fs/2 (i.e.,fmax)). Hence to use the MATLAB commands
wc = fc / (fs/2) = 400/(8000/2) = 0.1
Note: if the cut off frequency is in radians then the normalized frequency is
computed as wc = Wc / π
● Step 2: Compute the Impulse Response [b,a] coefficients of the required IIR
filter and the response type (lowpass, bandpass, etc) using the appropriate
butter, cheby1, cheby2 command. For example given a butterworth filter,
order N=2, and a high pass response, the coefficients [b,a] of the filter are
MATLAB IMPLEMENTATION
BUTTORD Butterworth filter order selection.
[N, Wn] = BUTTORD (Wp, Ws, Rp, Rs) returns the order N of the lowest order
digital Butterworth filter that loses no more than Rp dB in the passband and has at
least Rs dB of attenuation in the stopband. Wp and Ws are the passband and
stopband edge frequencies, normalized from 0 to 1 (where 1 corresponds to pi
radians/sample). For example,
Lowpass: Wp = .1, Ws = .2 Highpass: Wp = .2, Ws = .1
Bandpass: Wp = [.2 .7], Ws = [.1 .8] Bandstop: Wp = [.1 .8], Ws = [.2 .7]
BUTTORD also returns Wn, the Butterworth natural frequency (or, the "3 dB
frequency") to use with BUTTER to achieve the specifications.
[N, Wn] = BUTTORD(Wp, Ws, Rp, Rs, 's') does the computation for an analog
filter, in which case Wp and Ws are in radians/second.
When Rp is chosen as 3 dB, the Wn in BUTTER is equal to Wp in BUTTORD.
MATLAB PROGRAMS
Butterworth Filters
1.Butterworth LPF
clc;
clear all;
close all;
lp=input('Enter the passband attenuation:');
ls=input('Enter the stopband attenuation:');
wp=input('Enter the passband frequency:');
ws=input('Enter the stopband frequency:');
fs=input('Enter the sampling frequency:');
w1=2*wp/fs;
w2=2*ws/fs;
[n,wn]=buttord(w1,w2,lp,ls);disp(n);disp(wn)
[b,a]=butter(n,wn);
w=0:0.01:pi;
[h,om]=freqz(b,a,w);
m=20*log10(abs(h));
an=angle(h);
figure(1);
subplot(2,1,1);
title('Butterworth Low Pass Filter');
plot(om/pi,m);
grid on;
ylabel('Gain in db-->');
xlabel('(a)Normalised frequency-->');
subplot(2,1,2);
plot(om/pi,an);
xlabel('(b)Normalised frequency-->');
ylabel('Phase in radians-->');
grid on;
Result:
Enter the passband attenuation: 0.5
Enter the stopband attenuation: 50
Enter the passband frequency: 1200
Enter the stopband frequency: 2400
Enter the sampling frequency: 10000
Output Wave form
2 Butterworth HPF
clc;
clear all;
close all;
format long
lp=input('Enter the passband attenuation:');
ls=input('Enter the stopband attenuation:');
wp=input('Enter the passband frequency:');
ws=input('Enter the stopband frequency:');
fs=input('Enter the sampling frequency:');
w1=2*wp/fs;
w2=2*ws/fs;
[n,wn]=buttord(w1,w2,lp,ls); disp(n);disp(wn)
[b,a]=butter(n,wn,'high');
w=0:0.01:pi;
[h,om]=freqz(b,a,w);
m=20*log10(abs(h));
an=angle(h);
figure(1);
subplot(2,1,1);
title('Butterworth Low Pass Filter');
plot(om/pi,m);
grid on;
ylabel('Gain in db-->');
xlabel('(a)Normalised frequency-->');
subplot(2,1,2);
plot(om/pi,an);
xlabel('(b)Normalised frequency-->');
ylabel('Phase in radians-->');
grid on
Result:
Enter the passband attenuation: 0.5
Enter the stopband attenuation: 50
Enter the passband frequency: 1200
Enter the stopband frequency: 2400
Enter the sampling frequency: 10000
CHEBYSHEV FILTERS
1 Chebyshev LPF
clc;
close all;
clear all;
format long
rp=input('enter the passband ripple');
rs=input('enter the stopband ripple');
wp=input('enter the passband frequency');
ws=input('enter the stopband frequency');
fs=input('enter the sampling frequency');
w1=2*wp/fs;
w2=2*ws/fs;
[n,wn]=cheb1ord(w1,w2,rp,rs);
[b,a]=cheby1(n,rp,wn);
w=0:0.01:pi;
[h,om]=freqz(b,a,w);
m=20*log10(abs(h));
an=angle(h);
subplot(2,1,1);plot(om/pi,m);
ylabel('gain in db-->');
xlabel('(a) normalised frequency-->');
subplot(2,1,2);plot(om/pi,an);
xlabel('(b) normalised frequency-->');
ylabel('phase in radians-->');
Result:
enter the passband ripple 0.2
enter the stopband ripple 45
enter the passband frequency 1300
enter the stopband frequency 1500
enter the sampling frequency 10000
Output Waveform
2 Chebyshev HPF
clc;
close all;
clear all;
rp=input('enter the passband ripple');
rs=input('enter the stopband ripple');
wp=input('enter the passband frequency');
ws=input('enter the stopband frequency');
an=angle(h);
subplot(2,1,1);plot(om/pi,m);
ylabel('gain in db-->');
xlabel('(a) normalised frequency-->');
subplot(2,1,2);plot(om/pi,an);
xlabel('(b) normalised frequency-->');
ylabel('phase in radians-->');
Result:
enter the passband ripple 0.3
enter the stopband ripple 60
enter the passband frequency 1500
enter the stopband frequency 2000
enter the sampling frequency 9000
Output Waveform
VIVA Questions:
1. Define an IIR filter.
2. Compare Impulse invariance and bilinear transformations.
3. How do you convert analog filter prototype to a digital filter?
4. What are the functions used in MATLAB for designing a digital
Butterworth and Chebyshev low pass filter using BLT?
5. Draw typical responses of Chebyshev filter for order odd & even.
6. Compare FIR & IIR filters.
EXPERIMENT NO 7
Design and Implementation of FIR Filter to Meet Given Specifications
Theory:
There are two types of systems – Digital filters (perform signal filtering in time
domain) and spectrum analyzers (provide signal representation in the frequency
domain). The design of a digital filter is carried out in 3 steps- specifications,
approximations and implementation.
Method 1: Given the order N, cutoff frequency fc, sampling frequency fs and the
window.
● Step 1: Compute the digital cut-off frequency Wc (in the range -π <Wc< π,
with π corresponding to fs/2) for fc and fs in Hz. For example let fc=400Hz,
fs=8000Hz
Wc = 2*π* fc / fs = 2* π * 400/8000 = 0.1* π radians
For MATLAB the Normalized cut-off frequency is in the range 0 and 1,
where 1 corresponds to fs/2 (i.e.,fmax)). Hence to use the MATLAB
commands
wc = fc / (fs/2) = 400/(8000/2) = 0.1
Note: if the cut off frequency is in radians then the normalized frequency is
computed as wc = Wc / π
● Step 2: Compute the Impulse Response h(n) of the required FIR filter using
the given Window type and the response type (low pass, band pass, etc). For
example given a rectangular window, order N=20, and a high pass response,
the coefficients (i.e., h[n] samples) of the filter are computed using the
MATLAB inbuilt command ‘fir1’ as
h =fir1(N, wc , 'high', boxcar(N+1));
Note: In theory we would have calculated h[n]=hd[n]×w[n], where hd[n] is
the desired impulse response (low pass/ high pass, etc given by the sinc
function) and w[n] is the window coefficients. We can also plot the window
shape as stem(boxcar(N)).
Plot the frequency response of the designed filter h(n) using the freqz
function and observe the type of response (lowpass / highpass /bandpass).
Method 2:
Given the pass band (wp in radians) and Stop band edge (ws in radians)
frequencies, Pass band ripple Rp and stopband attenuation As.
● Step 1: Select the window depending on the stopband attenuation required.
Generally if As>40 dB, choose Hamming window. (Refer table )
● Step 2: Compute the order N based on the edge frequencies as
Transition bandwidth = tb=ws-wp;
N=ceil (6.6*pi/tb);
● Step 3: Compute the digital cut-off frequency Wc as
Wc=(wp+ws)/2
Now compute the normalized frequency in the range 0 to 1 for MATLAB
as
wc=Wc/pi;
Note: In step 2 if frequencies are in Hz, then obtain radian frequencies (for
computation of tb and N) aswp=2*pi*fp/fs, ws=2*pi*fstop/fs, where fp,
fstop and fs are the pass band, stop band and sampling frequencies in Hz
● Step 4: Compute the Impulse Response h(n) of the required FIR filter using
N, selected window, type of response(low/high,etc) using ‘fir1’ as in step 2
of method 1.
MATLAB IMPLEMENTATION
FIR1 Function
B = FIR1(N,Wn) designs an N'th order low pass FIR digital filter and returns the
filter coefficients in length N+1 vector B. The cut-off frequency Wn must be
between 0 <Wn< 1.0, with 1.0 corresponding to half the sample rate. The filter B
is real and has linear phase, i.e., even symmetric coefficients obeying B(k) =
B(N+2-k), k = 1,2,...,N+1.
If Wn is a two-element vector, Wn = [W1 W2], FIR1 returns an order N band pass
filter with pass band W1< W < W2. B = FIR1(N,Wn,'high') designs a high pass
filter. B = FIR1(N,Wn,'stop') is a band stop filter if Wn = [W1 W2]. If Wn is a
Matlab Program:
1 RECTANGULAR WINDOW
clc;
clear all;
close all;
lp=input('Enter the pass band ripple:');
ls=input('Enter the stop band ripple:');
fp=input('Enter the pass band frequency:');
fs=input('Enter the stop band frequency:');
f=input('Enter the sampling frequency:');
wp=2*fp/f;
ws=2*fs/f;
num=-20*log10(sqrt(lp*ls))-13;
dem=14.6*(fs-fp)/f;
n=ceil(num/dem);
n1=n+1;
if (rem(n,2)~=0)
n1=n;
n=n-1;
end
y=boxcar(n1);% or y=rect(n1);
% Low Pass Filter
b=fir1(n,wp,y);
[h,o]=freqz(b,1,256);
m=20*log10(abs(h));
subplot(2,2,1);
plot(o/pi,m);
ylabel('Gain in db-->');
xlabel('(a)Normalised Frequency-->');
grid on;
% High Pass Filter
b=fir1(n,wp,'high',y);
[h,o]=freqz(b,1,256);
m=20*log10(abs(h));
subplot(2,2,2);
plot(o/pi,m);
ylabel('Gain in db-->');
xlabel('(b)Normalised Frequency-->');
grid on;
Result
Enter the pass band ripple: 0.05
Enter the stop band ripple: 0.04
Enter the pass band frequency: 1500
Enter the stop band frequency: 2000
Enter the sampling frequency: 9000
Output waveform
2 HAMMING WINDOW
clc;
clear all;
close all;
lp=input('Enter the passband ripple:');
ls=input('Enter the stopband ripple:');
fp=input('Enter the passband frequency:');
fs=input('Enter the stopband frequency:');
f=input('Enter the sampling frequency:');
wp=2*fp/f;
ws=2*fs/f;
num=-20*log10(sqrt(lp*ls))-13;
dem=14.6*(fs-fp)/f;
n=ceil(num/dem);
n1=n+1;
if (rem(n,2)~=0)
n1=n;
n=n-1;
end
y=hamming(n1);
plot(o/pi,m);
ylabel('Gain in db-->');
xlabel('(b)Normalised Frequency-->');
grid on;
Result:
Enter the passband ripple: 0.05
Enter the stopband ripple: 0.001
Enter the passband frequency: 1200
Enter the stopband frequency: 1700
Enter the sampling frequency: 9000
Output waveform
3 BARTLET
clc;
clear all;
close all;
lp=input('Enter the passband ripple:');
ls=input('Enter the stopband ripple:');
fp=input('Enter the passband frequency:');
m=20*log10(abs(h));
subplot(2,2,2);
plot(o/pi,m);
ylabel('Gain in db-->');
xlabel('(b)Normalised Frequency-->');
grid on;
Result:
Enter the passband ripple: 0.05
Enter the stopband ripple: 0.04
Enter the passband frequency: 1500
Enter the stopband frequency: 2000
Enter the sampling frequency: 9000
Output Waveform
4 HANNING
clc;
clear all;
close all;
lp=input('Enter the passband ripple:');
ls=input('Enter the stopband ripple:');
fp=input('Enter the passband frequency:');
fs=input('Enter the stopband frequency:');
f=input('Enter the sampling frequency:');
wp=2*fp/f;
ws=2*fs/f;
num=-20*log10(sqrt(lp*ls))-13;
dem=14.6*(fs-fp)/f;
n=ceil(num/dem);
n1=n+1;
if (rem(n,2)~=0)
n1=n;
n=n-1;
end
y=hanning(n1);
% Low Pass Filter
b=fir1(n,wp,y);
[h,o]=freqz(b,1,256);
m=20*log10(abs(h));
subplot(2,2,1);
plot(o/pi,m);
ylabel('Gain in db-->');
xlabel('(a)Normalised Frequency-->');
grid on;
Result
Enter the passband ripple: 0.03
Enter the stopband ripple: 0.01
Enter the passband frequency: 1400
Enter the stopband frequency: 2000
Enter the sampling frequency: 8000
Output Waveform
6 KAISER
clc;
clearall;
closeall;
lp=input('Enter the passband ripple:');
ls=input('Enter the stopband ripple:');
fp=input('Enter the passband frequency:');
fs=input('Enter the stopband frequency:');
f=input('Enter the sampling frequency:');
beta=input('Enter the beta value:');
wp=2*fp/f;
ws=2*fs/f;
num=-20*log10(sqrt(lp*ls))-13;
dem=14.6*(fs-fp)/f;
n=ceil(num/dem);
n1=n+1;
if (rem(n,2)~=0)
n1=n;
n=n-1;
end
y=kaiser(n1,beta);
Result:
Enter the passband ripple: 0.05
Enter the stopband ripple: 0.04
Enter the passband frequency: 1500
Enter the stopband frequency: 2000
Enter the sampling frequency: 9000
Enter the beta value: 5.8
Output Waveform
VIVA Questions:
1. What is a Filter? What are its specifications?
2. Mention the types of filters.
3. Compare analog and digital filters.
4. Define a FIR filter.
5. What are the important properties of FIR filter?
6. What are the window techniques used?
7. Why the Kaiser window is important?
8. How do you calculate the length of Kaiser Window?
9. What are the functions used in designing a FIR filter in Matlab
PART II
CCS INTRODUCTION
Procedure
1. Double click on CCS icon
2. Create a new project: project 🡪 New
Type the project name (x.pjt) or (USN) & store in my projects folder
To open an existing project: project 🡪 open
3. Files to be added to the project: project 🡪 Add Files to project
a. c: \ CCStudio \ c6000 \ cgtools \ lib \ rts6700.lib
<Select type of file as: library>
b. c: \ CCStudio \ tutorial \ dsk6713 \ hello1 \ hello.cmd
< Select type of file as: Linker Command file>
4. File 🡪 New 🡪 source file 🡪 same as xx.c and compile
( Select type of file as: C/C++ file before saving) & add this C file to your
project
5. Project 🡪 Build. (obtain Build successful)
6. To execute ; File 🡪 load program (select pjtname.out file)
7. To Run : Debug 🡪 Run
8. Observe the output on the stdout window or waveforms using graph or CRO
9. To view waveforms View 🡪 Graph
changes in graph property dialog box to be made
a. Display type 🡪 Dual (to observe 2 waveforms)
EXPERIMENT NO 8
a. Linear convolution for the given sequences
C Program
# include<stdio.h>
# include<math.h>
float y[10];
main()
{
//the two sequences can be of different lengths, no need to zero pad for this
program
float h[4] = { 2,2,2,2};
float x[4] ={1,2,3,4};
intxlen=4;
inthlen=4;
int N=xlen+hlen-1;
intk,n;
for(n=0;n<N;n++) //outer loop for y[n] array
{ y[n]=0;
for(k=0;k<hlen;k++) //inner loop for computing each y[n] point
{ if (((n-k)>=0) & ((n-k)<xlen))
y[n]=y[n]+h[k]*x[n-k]; //compute output
} //end of inner for loop
printf("%f\t", y[n]);
} //end of outer for loop
} //end of main
C Program
# include<stdio.h>
# include<math.h>
float y[10]; //output sequence
main()
{ //input the two sequences, if of uneven lengths zero pad the smaller one such
that both are of same size
float x[5]={1,2,3,4,5};
float h[5]={2,1,3,4,5};
int N=5; // N=max of xlen and hlen//
intk,n,i;
for(n=0;n<N;n++) //outer loop for y[n] array
{ y[n]=0;
for(k=0;k<N;k++) //inner loop for computing each y[n] point
{ i=(n-k)%N; //compute the index modulo N
if(i<0) //if index is <0, say x[-1], then convert to x[N-1]
i=i+N;
y[n]=y[n]+h[k]*x[i]; //compute output
} //end of inner for loop
printf("%f\t",y[n]);
} //end of outer for loop
} //end of main
EXPERIMENT NO 9
Computation of N- Point DFT of a given sequence
C Program
#include <stdio.h>
#include <math.h>
main()
{float y[16]; //for 8 point DFT to store real & imaginary
float x[4]={1,3,2,5}; //input only real sequence
float w;
int n,k,k1,N=8,xlen=4;
for(k=0;k<2*N;k=k+2)
{y[k]=0; y[k+1]=0; //initialize real &image parts
k1=k/2; //actual k index
for(n=0;n<xlen;n++)
{w=-2*3.14*k1*n/N; //careful about minus sign
y[k]=y[k]+x[n]*cos(w);
y[k+1]=y[k+1]+x[n]*sin(w);
}
printf("%f+j%f \n",y[k],y[k+1]);
}
}//end of main
MATLAB verification
>> x=[1 3 2 5];
>>fft(x,8) 11.0000 -0.4142 - 7.6569i -1.0000 + 2.0000i 2.4142 -
3.6569i -5.0000 2.4142 + 3.6569i -1.0000 - 2.0000i -0.4142 + 7.6569i
EXPERIMENT NO 10
Impulse response of the given system
Aim: To find the Impulse response of the given first order / second order
system
Theory:
A linear constant coefficient difference equation representing a second order
system is given by y[ n ]+ a 1 y[n− 1]+ a2 y[ n− 2 ]= b0 x[ n]+ b1 x[n− 1]+ b2 x[n− 2];
For a first order system the coefficients a2 and b2 are zero.
Since the difference equation contains past samples of output, i.e., y[n-1], y[n-
2], its impulse response is of infinite duration (IIR). For such systems the
impulse response is computed for a large value of N, say N=100 (to
approximate n=∞).
Impulse response implies x[n]= δ[n], an impulse, and the initial conditions x[-1],
x[-2], y[-1] and y[-2] are zero.
(referexpt 2 &7of part A - h=impz(b,a,N); %impulse response verification in
MATLAB)
To implement in C the following algorithm is used.
Algorithm
1. Input the coefficients b0 b1 b2, a1 a2 (Say the coefficients from a 2nd order
Butterworth filter. Note coefficient of y[n] is a0=1 always)
2. Generate the impulse input of size n (1st element=1, rest all=0)
3. Compute the output as
y[ n ]= − a1 y[ n− 1]− a 2 y[n− 2]+ b 0 x[n]+ b1 x[ n− 1 ]+ b2 x[ n− 2 ];
C Program
#include <stdio.h>
float x[60],y[60];
main()
{float a1,a2,b0,b1,b2;
inti,j,N=20;
a1= -1.1430; a2= 0.4128;
b0=0.0675;b1=0.1349;b2=0.0675;
//generate impulse input
x[0]=1;
for(i=1;i<N;i++)
x[i]=0;
//generate output
for(j=0;j<N;j++)
{y[j]=b0*x[j];
if(j>0)
y[j]=y[j]+b1*x[j-1]-a1*y[j-1];
if ((j-1)>0)
y[j]=y[j]+b2*x[j-2]-a2*y[j-2];
printf("%f \t",y[j]);
}
}//end of main
Note: For a first order system just enter a2=0 and b2=0.
Open ended Experiments:
Find the impulse response of the given difference equation
c. y[n]-1/9y[n-2]=x[n-1]
d. y[n]-3/4y[n-1]+1/8y[n-2]=x[n]+1/2x[n-1]
EXPERIMENT NO 11
Noise removal programs:
Aim: To Add noise above 3kHz and then remove using adaptive filters
Theory:
In the previous experiments involving IIR & FIR filters, the filter coefficients
were determined before the start of the experiment and they remained constant.
Whereas Adaptive filters are filters whose transfer function coefficients or taps
change over time in response to an external error signal. Typical applications of
these filters are Equalization, Linear Prediction, Noise Cancellation, Time-Delay
Estimation, Non-stationary Channel Estimation, etc. Different types of adaptive
filter algorithms are the Kalman adaptive filter algorithm, LMS adaptive filter
algorithm and RLS adaptive filter algorithm
Fig.7.2 Adaptive Filter (In program the coefficients (weights) ‘a’ replaced by
w[T], X0-> delay [0]
In the below program, two signals - a desired sinusoidal signal (can be the output
of the PC speaker/ signal generator of square/ sine wave of frequency not
correlated to 3kHz and not above the fsample/2 of the codec) into the Left
channel and
Noise signal of 3KHz into the Right channel of the Line In are given (generally
using two signal generators with common ground is sufficient).
C Program
#include "NCcfg.h"
#include "dsk6713.h"
#include "dsk6713_aic23.h"
#define beta 1E-13 //rate of convergence
#define N 30 //adaptive FIR filter length-vary this parameter &
observe
float delay[N];
float w[N];
DSK6713_AIC23_Config config = { \
0x0017, /* 0 DSK6713_AIC23_LEFTINVOL Left line input channel volume
*/ \
0x0017, /* 1 DSK6713_AIC23_RIGHTINVOL Right line input channel
volume */\
0x00d8, /* 2 DSK6713_AIC23_LEFTHPVOL Left channel headphone
volume */ \
0x00d8, /* 3 DSK6713_AIC23_RIGHTHPVOL Right channel headphone
volume */ \
0x0011, /* 4 DSK6713_AIC23_ANAPATH Analog audio path control */
\
0x0000, /* 5 DSK6713_AIC23_DIGPATH Digital audio path control */ \
0x0000, /* 6 DSK6713_AIC23_POWERDOWN Power down control */
\
while(1)
{ /* Read a sample to the left channel */
while (!DSK6713_AIC23_read(hCodec,&l_input));
/* Read a sample to the right channel */
while (!DSK6713_AIC23_read(hCodec, &r_input));
l_output=(short int)adaptive_filter(l_input,r_input);
r_output=l_output;
while (!DSK6713_AIC23_write(hCodec, l_output)); /* Send o/p to the left
channel */
while (!DSK6713_AIC23_write(hCodec, r_output)); /* Send o/p to the right
channel*/
}
DSK6713_AIC23_closeCodec(hCodec); /* Close the codec */
}
desired = l_input;
noise = r_input;
dplusn = (short)(desired + noise); //desired+noise
delay[0] = noise; //noise as input to adapt FIR
Result:
Observe the waveform that appears on the CRO screen. Verify that the 3 KHz
noise signal is being cancelled gradually.
In this open end experiments students are expected to write programs to create
wave forms such as square wave, triangular wave and saw tooth wave. Students
may write separate programs for each waveform.
Mini Project
Students are expected to create a GUI based signal generator using MATLAB. The
signal generator will have three buttons to select three signals ie., sine wave, square
wave and triangular wave. Upon the selection the wave form in time domain and
frequency domain needs to be displayed graphically. There should be a control to
change the amplitude and frequency of the signals.
Questions:
1. Why do we need SP processors?
2. What is the difference between Fixed and floating point processors?
3. Explain the architectural features of DSP processor.
4. How do perform signed arithmetic on DSP processor?
5. What are the advantages and disadvantages of DSP processor?