Digital Signal Processing Lab Manual
Digital Signal Processing Lab Manual
Digital Signal Processing Lab Manual
CONTENTS
EXPERIMENT NO-1
Sampling: Is the process of converting a continuous time signal into a discrete time
signal. It is the first step in conversion from analog signal to digital signal.
Nyquist Rate Sampling: The Nyquist rate is the minimum sampling rate required to
avoid aliasing, equal to the highest modulating frequency contained within the signal.
In other words, Nyquist rate is equal to two sided bandwidth of the signal (Upper and
lower sidebands)
To avoid aliasing, the sampling rate must exceed the Nyquist rate. i.e. fs > fN
Program:
% Nyquist Rate Sampling.
clc; % Clear screen
fs = 1400; % Sampling frequency, fs = 1400Hz
t = 0:1/fs:13/fs; % Number of samples
x = cos(2*pi*400*t)+cos(2*pi*700*t); % Input signal
xm = abs (fft(x)); % Determine the absolute FFT of the input signal
disp(‘xm’); % Displays xm on command window
disp (xm); % Displays values of xm on command window
k = 0:length(xm)-1; % Number of samples to be plot on x-axis
subplot (2,2,1); % Divide the figure window to plot the output
stem (100*k, xm); % Plot the output
xlabel ('Hz'); % Name x-axis as “Hz”
ylabel ('Magnitude'); % Name y-axis as “Magnitude”
title ('NR sampling'); % Title is “NR Sampling”
%UNDER Sampling.
fs = 1000; % Sampling frequency, fs = 1000Hz
t = 0:1/fs:9/fs; % Number of samples
x = cos(2*pi*400*t)+cos(2*pi*700*t); % Input signal
xm = abs(fft(x)); % Determine the absolute FFT of the input signal
disp(‘xm1’); % Displays xm1 on command window
disp (xm1); % Displays values of xm1 on command window
k = 0:length(xm1)-1; % Number of samples to be plot on x-axis
subplot(2,2,2); % Divide the figure window to plot the output
stem(100*k, xm1); % Plot the output
xlabel('Hz'); % Name x-axis as “Hz”
4
%OVER Sampling.
fs = 2000; % Sampling frequency, fs = 2000Hz
t = 0:1/fs:20/fs; % Number of samples
x = cos(2*pi*400*t)+cos(2*pi*700*t); % Input signal
xm = abs(fft(x)); % Determine the absolute FFT of the input signal
disp(‘xm2’); % Displays xm2 on command window
disp (xm2); % Displays values of xm2 on command window
k = 0:length(xm2)-1; % Number of samples to be plot on x-axis
subplot(2,2,3); % Divide the figure window to plot the output
stem(100*k,xm2); % Plot the output
xlabel('Hz'); % Name x-axis as “Hz”
ylabel('Magnitude'); % Name y-axis as “Magnitude”
title('OVER sampling'); % Title is “OVER Sampling”
OUTPUT :
xm
Columns 1 through 7
0.0000 0.0000 0.0000 0.0000 7.0000 0.0000 0.0000
Columns 8 through 14
14.0000 0.0000 0.0000 7.0000 0.0000 0.0000 0.0000
xm1
Columns 1 through 7
0.0000 0.0000 0.0000 5.0000 5.0000 0.0000 5.0000
Columns 8 through 10
5.0000 0.0000 0.0000
xm2
Columns 1 through 7
2.0000 2.0741 2.3496 3.1607 11.5127 0.4052 1.8998
Columns 8 through 14
8.6165 4.2355 1.2552 0.3357 0.3357 1.2552 4.2355
Columns 15 through 21
8.6165 1.8998 0.4052 11.5127 3.1607 2.3496 2.0741
5
N R s a m p lin g U N D E R s a m p lin g
15 6
10 4
M agnitude
M agnitude
5 2
0 0
0 500 1000 1500 0 500 1000
Hz Hz
O V E R s a m p lin g
15
10
M agnitude
0
0 500 1000 1500 2000
Hz
6
EXPERIMENT NO-2
If the input to the system is unit impulse i.e. x(n) = δ(n) then the output of the system is
known as impulse response denoted by h(n) where,
h(n) = T[δ(n)]
we know that any arbitrary sequence x(n) can be represented as a weighted sum of
discrete impulses. Now the system response is given by,
∞
y(n) = T[x(n)] = T[∑x(k) δ(n-k)] …(1)
k=-∞
For linear system (1) reduces to
∞
y(n) = ∑x(k) T[δ(n-k)] …(2)
k=-∞
The response to the shifted impulse sequence can be denoted by h(n, k) is denoted by,
For a linear time-invariant system if the input sequence is x(n) and impulse response
h(n) is given, we can fine output y(n) by using eqn (6).
Which is known as convolution sum and can be represented by y(n) = x(n) * h(n)
M M
y(n) = ∑ak y(n-k) + ∑bk x(n-k) …(7)
k=1 k=0
For input x(n) = δ(n)
M
y(n) = ∑bk x(n-k) = 0 for n > M
k=0
Now (7) can be written as,
N
y(n) = ∑ak y(n-k) = 0 a0 = 1 …(8)
k=0
The solution of eqn (8) is known as homogeneous solution. The particular solution is
zero since x(n) = 0 for n > 0, that is
yp(n) = 0
Therefore we can obtain the impulse response by solving the homogeneous equation and
imposing the initial conditions to determine the arbitrary constants.
Example:
Let’s take a second order difference equation
For n = 0,
For n = 1,
y(0) = 1.0000
y(1) = 0.1667
y(2) = 0.1944
y(3) = 0.0602
So, the impulse response for the given difference equation using eqn (19) is
h(n) = {1.0000, 0.1667, 0.1944, 0.0602}
Program:
clc; % Clear screen
nr = [1]; % Numeartor co-efficients
dr = [1,-1/6,-1/6]; % Denominator co-efficients
h = impz(nr,dr,4); % Computes the impulse response of a given
% difference equation, returns the co-efficients
disp('Impulse response h(n):');% Displays impulse response
disp(h); % Displays impulse response on command window
subplot(2,1,1); % Divide the figure window to plot the output
stem(h); % Displays the impulse response
title('Impulse response h(n):');% Title as impulse response
x = [1]; % Input co-efficients
y = conv (h, x); % Convolution of input and impulse co-efficients to get the
% output
disp('Output y(n):') % Displays Output y(n)
disp(y); % Displays the output on command window
subplot(2,1,2); % Divide the figure window to plot the output
stem(y); % Plots the output
title('Output y(n) for given x(n)'); % Title as “Output y(n) for given x(n)”
OUTPUT:
Impulse response:
1.0000
0.1667
0.1944
0.0602
Output y(n):
1.0000
0.1667
0.1944
0.0602
10
Im p u l s e r e s p o n s e
1
0 .5
0
1 1 .5 2 2 .5 3 3 .5 4
O u t p u t y ( n ) fo r g i v e n x ( n )
1
0 .5
0
1 1 .5 2 2 .5 3 3 .5 4
11
EXPERIMENT NO-3
Mathematic Formula:
The linear convolution of two continuous time signals x(t) and h(t) is defined by
Where x(n) is the input signal and h(n) is the impulse response of the system.
Graphical Interpretation:
Example:
x(n) = {1, 2, 3, 1}
h(n) = {1, 1, 1}
x(k) h(k)
3
2
1 1 1 1 1
-4 -3 -2 -1 0 1 2 3 4 5 6 7 0 1 2
∞
n=0; h(-k ) y(0) = ∑ x(k) h(-k) = 1
1 k=-∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
∞
n=1; h(1-k) y(1) = ∑ x(k) h(1-k) = 1+2=3
1 k=- ∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
∞
n=2; h(2-k) y(2) =∑ x(k) h(2-k) = 1+2+3=6
1 k=-∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
∞
n=3; h(3-k) y(3) =∑ x(k) h(3-k) = 2+3+1=6
1 k=-∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
∞
n=4; h(4-k) y(4) = ∑ x(k) h(4-k) = 3+1=4
1 k=-∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
∞
n=5; h(5-k) y(5) = ∑ x(k) h(5-k) = 1
1 k=-∞
-4 -3 -2 -1 0 1 2 3 4 5 6 7
13
6 6
4
3
y(n) = {1, 3, 6, 6, 4, 1}
1 1
-4 -3 -2 -1 0 1 2 3 4 5 6 7
Program:
OUTPUT:
Linear convolution
6
4
Magnitude
0
0 0.5 1 1.5 2 2.5 3 3.5 4 4.5 5
Time
15
EXPERIMENT NO-4
Circular convolution:
Let x1(n) and x2(n) are finite duration sequences both of length N with DFT’s X1(k)
and X2(k). Convolution of two given sequences x1(n) and x2(n) is given by the
equation,
x3(n) = IDFT[X3(k)]
N-1
x3(n) = ∑ x1(m) x2((n-m))N
m=0
Example:
x1(m) x2(m)
1 2
x1(1) x2(1)
x1(2) x1(0)
x2(2) x2(0) 2 2 1
3 1
x1(3) x2(3)
1 4
16
x2(-m)
4
x2(3)
x2(2) x2(0)
3 1
x2(1)
2
Keep x1(m) constant and rotate x2(-m) once to compute further values.
x2(1-m)
1
x2(0)
x2(3) x2(1)
4 2
x2(2)
3
=2+1+8+3
x3(1) = 14
x2(2-m)
2
x2(1)
1 3
x2(0) x2(2)
x2(3)
4
x2(3-m)
3
x2(2)
2 4
x2(1) x2(3)
x2(0) 1
Program:
clc; % Clear screen
x1 = input('Enter 1st seq:'); % Get the first sequence
x2 = input('Enter 2nd seq:'); % Get the second sequence
n = max(length(x1),length(x2)); % Get the Maximum length out of two signals
x1 = fft(x1,n); % Compute FFT of the first sequence
x2 = fft(x2,n); % Compute FFT of the second sequence
y = x1.*x2; % Multiply the two sequences
yc = ifft(y,n); % Compute IFFT of the result
disp('circular convolution:'); % Displays circular convolution
disp(yc); % Displays the result on command window
N=0:1:n-1; % Get the length for x-axis
subplot(1,1,1); % Divide the window to plot the result
stem(N,yc); % Plot the result
xlabel('Time'); % Name the x-axis as “Time”
ylabel('Magnitude'); % Name the y-axis as “Magnitude”
title('Circular convolution'); % Title as Circular convolution
OUTPUT:
Enter 1st seq:[1 1 2 1]
Enter 2nd seq:[1 2 3 4]
Circular convolution:
13 14 11 12
19
Circular convolution
15
10
Magnitude
0
0 0.5 1 1.5 2 2.5 3
Time
EXPERIMENT NO-5
Correlation: Correlation determines the degree of similarity between two signals. If the
signals are identical, then the correlation coefficient is 1; if they are totally different, the
correlation coefficient is 0, and if they are identical except that the phase is shifted by
exactly 1800(i.e. mirrored), then the correlation coefficient is -1.
Autocorrelation: When the same signal is compared to phase shifted copies of itself, the
procedure is known as autocorrelation.
The autocorrelation of a random signal describes the general dependence of the values of
the samples at one time on the values of the samples at another time. Consider a random
process x(t) (i.e. continuous time), its autocorrelation function is,
20
Biased autocorrelation
….. Eqn.1
Unbiased autocorrelation
For m = 1 + 2 + …. + M+1
Where M is the number of lags.
Note that we used the function xcorr to estimate the autocorrelation sequence, it has
double the number of samples as the signal x(n). An important point to remember when
using the function xcorr is that the origin is in the middle of the figure (here it is at lag =
1024). xcorr is a built in function in MATLAB library.
Program:
OUTPUT:
22
S in e w a ve o f fre q u e n c y 1 H z (F s = 2 0 0 H z )
1
0 .5
Amplitude
-0 .5
-1
0 1 2 3 4 5 6
Tim e , [s ]
A uto c o rre la tio n fu n c tio n o f th e s in e w a ve
1000
Autocorrelation
500
-5 0 0
0 500 1000 1500 2000 2500
lag s
We can also include our own functions to the MATLAB library by saving the file name
with .m extension.
For example we can write the autocorrelation function for the sampled signal defined in
Eqn.1, and we should save this file as autom.m
We can call this function autom in the main program instead of the function xcorr, we
will get the output as,
OUTPUT:
23
S i n e w a v e o f fr e q u e n c y 1 H z ( F s = 2 0 0 H z )
1
0 .5
A m plitude
-0 .5
-1
0 1 2 3 4 5 6
T im e , [ s ]
A u t o c o r r e l a t i o n fu n c t i o n o f t h e s i n e w a v e
1000
500
A utocorrelation
-5 0 0
0 200 400 600 800 1000 1200
la g s
EXPERIMENT NO-6
24
Correlation: Correlation determines the degree of similarity between two signals. If the
signals are identical, then the correlation coefficient is 1; if they are totally different, the
correlation coefficient is 0, and if they are identical except that the phase is shifted by
exactly 1800(i.e. mirrored), then the correlation coefficient is -1.
Cross-correlation: When two independent signals are compared, the procedure is known
as cross-correlation.
The cross correlation function measures the dependence of the value of one signal on
another signal. For two WSS (Wide Sense Stationary) processes x(t) and y(t) it is
described by,
Or
Example:
Plot the cross correlation for the following signal,
25
Program:
OUTPUT:
26
P u re s in e w a ve
1
A m plitude
0
-1
0 200 400 600 800 1000 1200
T im e
P u re s in e w a ve + N o is e
50
A m plitude
-5 0
0 200 400 600 800 1000 1200
T im e
C ro s s -c o rre la t io n R x y
1000
C ros s -c orrelation
-1 0 0 0
0 500 1000 1500 2000 2500
la g s
EXPERIMENT NO-7
27
Here y[n] is “Most advanced” output sample and y[n-m] is “Least advanced” ouput
sample.
The difference between these two index values is the order of the difference equation.
Here we have: n-(n-N) = N
y[n] becomes,
Example:
In general we start with the “Most advanced” output sample. Here it is y[n+2].
So, here we need to subtract 2 from each sample argument. We get
And so on…
Program:
clc; % Clear screen
x = [0 0 ones(1, 10)]; % Input x[n] = u[n]
y_past = [1 2]; % Past values to solve difference equation
y(1) = y_past(1); % y[1] <= y[-2]
y(2) = y_past(2); % y[2] <= y[-1]
OUTPUT:
Columns 8 through 14
6.8125 6.8438 5.4531 3.3359 1.5508 0.9902 1.9346
29
D iffe r e n c e e q u a t io n
8
6
O utp ut y [n]
0
-2 0 2 4 6 8 1 0 1 2
In p u t x [ n ]
30
EXPERIMENT NO-8
The sequence of N complex numbers x0,..., xN−1 is transformed into the sequence of N
complex numbers X0, ..., XN−1 by the DFT according to the formula:
N-1
X(k) = ∑x(n)e-j2πnk/N k = 0,1, …. N-1
n=0
Example:
Lets assume the input sequence x[n] = [1 1 0 0]
We have,
N-1
X(k) = ∑x(n)e-j2πnk/N k = 0,1, …. N-1
n=0
For k = 0,
3
X(0) = ∑x(n) = x(0) + x(1) + x(2) + x(3)
n=0
X(0) = 1+1+0+0 = 2
For k = 1,
3
X(1) = ∑x(n)e-jπn/2 = x(0) + x(1) e-jπ/2 + x(2) e-jπ + x(3) e-j3π/2
n=0
= 1 + cos(π/2) - jsin(π/2)
X(1) = 1 – j
31
For k = 2,
3
X(2) = ∑x(n)e-jπn = x(0) + x(1) e-jπ + x(2) e-j2π + x(3) e-j3π
n=0
= 1 + cos π – jsin π
X(2) = 1-1 = 0
For k = 3,
3
X(3) = ∑x(n)e-j3nπ/2 = x(0) + x(1) e-j3π/2 + x(2) e-j3π + x(3) e-j9π/2
n=0
= 1 + cos(3π/2) - jsin(3π/2)
X(3) = 1 + j
Program:
clc; % Clear screen
x1 = input('Enter the sequence:'); % Get the input sequence
n = input('Enter the length:'); % Get the value of N
m = fft(x1,n); % Computes the DFT using FFT algorithm
disp('N-point DFT of a given sequence:'); % Display the results
disp(m); % Displays the result on command window
N = 0:1:n-1; % Decides the length to plot the results
OUTPUT:
Column 4
1.0000 + 1.0000i
1.5 0.5
Phase of X(k)
1 0
0.5 -0.5
0 -1
0 1 2 3 0 1 2 3
Length Length
33
EXPERIMENT NO-9
Mathematic Formula:
The linear convolution of two continuous time signals x(t) and h(t) is defined by
Where x(n) is the input signal and h(n) is the impulse response of the system.
Example:
x1(n) = {1, 1, 2}
x2(n) = {1, 2}
Where,
X1(k) = DFT [x1(n)]
N-1
X1(k) = ∑ x1(n)e-j2πkn/N k= 0, 1, 2, … , N-1
n=0
3
X1(0) = ∑ x1(n) = 1 + 1 + 2 = 4
n=0
5
X1(1) = ∑ x1(n)e-jπn/2 = 1 – j – 2 = -1 - j
n=0
5
X1(2) = ∑ x1(n)e-jπn = 1 – 1 + 2 = 2
n=0
5
X1(3) = ∑ x1(n)e-j3πn/2 = 1 + j – 2 = -1 + j
n=0
Now,
N-1
X2(k) = ∑ x2(n)e-j2πkn/N k= 0, 1, 2, … , N-1
n=0
3
X2(0) = ∑ x2(n) = 1 + 2 = 3
n=0
35
3
X2(1) = ∑ x2(n) e-jπn/2 = 1 + 2(-j) = 1 - j2
n=0
3
X2(2) = ∑ x2(n) e-jπn = 1 + 2(-1) = -1
n=0
3
X2(3) = ∑ x2(n) e-j3πn/2 = 1 + 2(j) = 1 + j2
n=0
We know that,
X3(k) = X1(k) X2(k)
X3(k) = {12, -3+j, -2, -3-j}
N-1
x3(n) = (1/N) ∑ X3(k)ej2πkn/N n = 0, 1, 2, …. , N-1
k=0
3
x3(0) = (1/4) ∑ X3(k) = (1/4) [12 – 3 +j -2 -3 –j] = 1
k=0
3
x3(1) = (1/4) ∑ X3(k)ejπk/2
k=0
x3(1) = (1/4) [12 + (-3 + j) j + (-2) (-1) + (-3 - j) (-j)] = 3
3
x3(2) = (1/4) ∑ X3(k)ejπk
k=0
3
x3(3) = (1/4) ∑ X3(k)ej3πk/2
k=0
Program:
clc; % Clear screen
x1 = input('Enter the 1st seq:'); % Get the first sequence
x2 = input('Enter the 2nd seq:'); % Get the second sequence
n = length(x1) + length(x2)-1; % Get the length of the sequence
x1 = fft(x1,n); % Compute the DFT of x1 using FFT algorithm
x2 = fft(x2,n); % Compute the DFT of x2 using FFT algorithm
y = x1.*x2; % Multiply two DFT’s
yc = ifft(y,n); % Compute IDFT using IFFT algorithm
disp('Linear convolution using DFT and IDFT:'); % Display Linear convolution
disp(yc); % Displays the result on command window
N = 0:1:n-1; % Defines the length of x-axis to plot the result
subplot(1,1,1); % Divide the window to plot the result
stem(N,yc); % Plots the result
xlabel('Time'); % Name the x-axis as Time
ylabel('Magnitude'); % Name the y-axis as Magnitude
title('Linear convolution using DFT and IDFT:'); % Title
OUTPUT:
Enter the 1st seq: [1 1 2]
Enter the 2nd seq: [1 2]
Linear convolution using DFT and IDFT:
1 3 4 4
37
3.5
2.5
Magnitude
1.5
0.5
0
0 0.5 1 1.5 2 2.5 3
Time
38
EXPERIMENT NO-10
Circular convolution:
Let x1(n) and x2(n) are finite duration sequences both of length N with DFT’s X1(k)
and X2(k). Convolution of two given sequences x1(n) and x2(n) is given by,
x3(n) = IDFT[X3(k)]
x3(n) = IDFT[X1(k) X2(k)]
Where,
X1(k) = DFT [x1(n)]
X2(k) = DFT [x2(n)]
Example:
x1(n) = {1, 1, 2, 1}
x2(n) = {1, 2, 3, 4}
N-1
X1(k) = ∑ x1(n)e-j2πkn/N k= 0, 1, 2, … , N-1
n=0
3
X1(0) = ∑ x1(n) = 1 + 1 + 2 + 1 = 5
n=0
3
X1(1) = ∑ x1(n)e-jπn/2 = 1 – j – 2 + j = -1
n=0
3
X1(2) = ∑ x1(n)e-jπn = 1 – 1 + 2 - 1 = 1
n=0
3
X1(3) = ∑ x1(n)e-j3πn/2 = 1 + j - 2 - j = -1
n=0
39
Now,
N-1
X2(k) = ∑ x2(n)e-j2πkn/N k= 0, 1, 2, … , N-1
n=0
3
X2(0) = ∑ x2(n) = 1 + 2 + 3 + 4 = 10
n=0
3
X2(1) = ∑ x2(n) e-jπn/2 = 1 + 2(-j) + 3(-1) + 4(j) = -2 + j2
n=0
3
X2(2) = ∑ x2(n) e-jπn = 1 + 2(-1) + 3(1) + 4(-1) = -2
n=0
3
X2(3) = ∑ x2(n) e-j3πn/2 = 1 + 2(j) + 3(-1) + 4(-j) = -2 – j2
n=0
We know that,
X3(k) = X1(k) X2(k)
X3(k) = {50, 2 – j2, -2, 2 + j2}
N-1
x3(n) = (1/N) ∑ X3(k)ej2πkn/N n = 0, 1, 2, …. , N-1
k=0
40
3
x3(0) = (1/4) ∑ X3(k) = (1/4) [50 + 2 - j2 – 2 + 2 + j2] = 13
k=0
3
x3(1) = (1/4) ∑ X3(k)ejπk/2
k=0
x3(1) = (1/4) [50 + (2 - j2) j + (-2) (-1) + (2 + j2) (-j)] = 14
3
x3(2) = (1/4) ∑ X3(k)ejπk
k=0
3
x3(3) = (1/4) ∑ X3(k)ej3πk/2
k=0
x3(3) = (1/4) [50 + (2 - j2) (-j) + (-2) (-1) + (2 + j2) (j)] = 12
Program:
clc; % Clear screen
x1 = input('Enter 1st sequence:'); % Get the first sequence
x2 = input('Enter 2nd sequence:'); % Get the second sequence
n = max(length(x1), length(x2)); % Get the maximum length of the two sequences
x1 = fft(x1,n); % Compute the DFT of the x1 using FFT algorithm
x2 = fft(x2,n); % Compute the DFT of the x2 using FFT algorithm
y = x1.*x2; % Multiply two DFT’s
yc = ifft(y,n); % Compute the IDFT of mutliplied sequence to get
% the convoluted sequence
disp('Circular convolution using DFT and IDFT:'); % Displays Circular convolution
disp(yc); % Displays the result on command window
N = 0:1:n-1; % Defines the length of x-axis to plot the result
subplot(1,1,1); % Divide the window to plot the result
stem(N,yc); % Plots the results
xlabel('Time'); % Name the x-axis as “Time”
ylabel('Magnitude'); % Name the y-axis as “Magnitude”
title('Circular convolution using DFT and IDFT:'); % Title
41
OUTPUT:
C ir c u la r c o n v o lu t io n u s in g D F T a n d ID F T :
1 5
1 0
M a g n itu d e
0
0 0 .5 1 1 .5 2 2 .5 3
T im e
42
EXPERIMENT NO-11
Finite Impulse Response (FIR) Filter: The FIR filters are of non-recursive type,
whereby the present output sample is depending on the present input sample and previous
input samples.
The transfer function of a FIR causal filter is given by,
N-1
H(z) = ∑ h(n)z-n
n=0
In the design of FIR filters most commonly used approach is using windows.
The desired frequency response Hd(ejw) of a filter is periodic in frequency and can be
expanded in Fourier series. The resultant series is given by,
π
hd(n) = (1/2π) ∫ H(ejw)ejwn dw
-π
And known as Fourier coefficients having infinite length. One possible way of obtaining
FIR filter is to truncate the infinite Fourier series at n = ± [(N-1)/2]
Where N is the length of the desired sequence.
The Fourier coefficients of the filter are modified by multiplying the infinite impulse
response with a finite weighing sequence w(n) called a window.
After multiplying w(n) with hd(n), we get a finite duration sequence h(n) that satisfies
the desired magnitude response,
The frequency response H(ejw) of the filter can be obtained by convolution of Hd(ejw)
and W(ejw) is given by,
π
H(ejw) = (1/2π) ∫ Hd(ejθ) W(ej(w-θ) dθ
-π
Example:
Here we design a lowpass filter using hamming window.
Hamming window function is given by,
=0 otherwise
WH(ejw ) = 0.54[(sin(wN/2))/(sin(w/2))]
+ 0.23[sin (wN/2 – πN/N – 1)/sin (w/2 – π/N -1)]
+ 0.23[sin (wN/2 + πN/N – 1)/sin (w/2 + π/N – 1)]
Program:
OUTPUT:
Columns 8 through 14
Columns 15 through 20
-1 0
-2 0
-3 0
-4 0
Gain in db
-5 0
-6 0
-7 0
-8 0
-9 0
-1 0 0
0 0 .5 1 1.5 2 2.5 3 3 .5
F re q u e n c y in ra d ia n s in t e rm s o f p i
45
EXPERIMENT NO-12
Example:
Let’s design an analog Butterworth lowpass filter.
Steps to design an analog Butterworth lowpass filter.
1. From the given specifications find the order of the filter N.
2. Round off it to the next higher integer.
3. Find the transfer function H(s) for Ωc = 1rad/sec for the value of N.
4. calculate the value of cutoff frequency Ωc
5. find the transfer function Ha(s) for the above value of Ωc by substituting
s→ (s/ Ωc) in H(s).
Program:
OUTPUT:
Cutoff frequency:
0.4914
b=
0.1600 0.4800 0.4800 0.1600
a=
1.0000 -0.0494 0.3340 -0.0045
47
48
49
2. Select Create Board (Marked in Circle, can witness in the below Figure)
3. Right Click on the TI XDS510 emulator and select add to system.. Enter,
(After selecting that options a Connection Properties window will be opened as shown in
step 4).
52
5. Choose the option Falling edge is JTAG Standard in TMS/TDO Output Timing.
53
Mathematical Formula:
The linear convolution of two continuous time signals x(t) and h(t) is defined by
Where x(n) is the input signal and h(n) is the impulse response of the system.
Program:
#include<stdio.h>
main()
{ int m=4; /*Lenght of i/p samples sequence*/
int n=4; /*Lenght of impulse response Co-efficients */
int i=0,j;
int x[10]={1,2,3,4,0,0,0,0}; /*Input Signal Samples*/
int h[10]={1,2,3,4,0,0,0,0}; /*Impulse Response Co-efficients*/
/*At the end of input sequences pad 'M' and 'N' no. of zero's*/
int *y;
y=(int *)0x0000100;
for(i=0;i<m+n-1;i++)
{
y[i]=0;
for(j=0;j<=i;j++)
y[i]+=x[j]*h[i-j];
}
for(i=0;i<m+n-1;i++)
printf("%d\n",y[i]);
}
Output:
1, 4, 10, 20, 25, 24, 16.
62
4. Enter the source code and save the file with “.C” extension.
5. Right click on source, Select add files to project .. and Choose “.C “ file Saved before.
63
6. Right Click on libraries and select add files to Project.. and choose
C:\CCStudio_v3.1\C6000\cgtools\lib\rts6700.lib and click open.
64
Here it
shows
error if
any
65
8. Go to file and load program and load “.out” file into the board..
66
11. To see the Graph go to View and select time/frequency in the Graph, And give the
correct Start address provided in the program, Display data can be taken as per user.
69
12. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).
70
Circular Convolution:
Let x1(n) and x2(n) are finite duration sequences both of length N with DFT’s X1(k) and
X2(k). Convolution of two given sequences x1(n) and x2(n) is given by the equation,
x3(n) = IDFT[X3(k)]
N-1
Program:
#include<stdio.h>
int m,n,x[30],h[30],y[30],i,j,temp[30],k,x2[30],a[30];
void main()
{
int *y;
y=(int *)0x0000100;
printf(" enter the length of the first sequence\n");
scanf("%d",&m);
printf(" enter the length of the second sequence\n");
scanf("%d",&n);
printf(" enter the first sequence\n");
for(i=0;i<m;i++)
scanf("%d",&x[i]);
printf(" enter the second sequence\n");
for(j=0;j<n;j++)
scanf("%d",&h[j]);
if(m-n!=0) /*If length of both sequences are not equal*/
{
if(m>n) /* Pad the smaller sequence with zero*/
{
for(i=n;i<m;i++)
h[i]=0;
n=m;
}
for(i=m;i<n;i++)
x[i]=0;
m=n;
}
y[0]=0;
73
a[0]=h[0];
for(j=1;j<n;j++) /*folding h(n) to h(-n)*/
a[j]=h[n-j];
/*Circular convolution*/
for(i=0;i<n;i++)
y[0]+=x[i]*a[i];
for(k=1;k<n;k++)
{
y[k]=0;
/*circular shift*/
for(j=1;j<n;j++)
x2[j]=a[j-1];
x2[0]=a[n-1];
for(i=0;i<n;i++)
{
a[i]=x2[i];
y[k]+=x[i]*x2[i];
}
}
/*displaying the result*/
printf(" the circular convolution is\n");
for(i=0;i<n;i++)
printf("%d ",y[i]);
}
Output:
4. Enter the source code and save the file with “.C” extension.
5. Right click on source, Select add files to project .. and Choose “.C “ file Saved before.
75
6. Right Click on libraries and select add files to Project.. and choose
C:\CCStudio_v3.1\C6000\cgtools\lib\rts6700.lib and click open.
76
77
7. a) Go to Project to Compile .
b) Go to Project to Build.
c) Go to Project to Rebuild All.
In case of
any errors
or
warnings
it will be
displayed
here
78
8. Go to file and load program and load “.out” file into the board..
79
The corresponding output will be shown on the output window as shown below
82
83
11. To see the Graph go to View and select time/frequency in the Graph, and give the
correct Start address provided in the program, Display data can be taken as per user.
84
12. 12. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).
85
The sequence of N complex numbers x0,..., xN−1 is transformed into the sequence of N
complex numbers X0, ..., XN−1 by the DFT according to the formula:
N-1
X(k) = ∑x(n)e -j2πnk/N
k = 0,1, …. N-1
n=0
Program:
#include <stdio.h>
#include <math.h>
#define N 4 //number of data values
float pi = 3.1416;
short x[N] = {1,1,0,0}; //1-cycle cosine
float out[2] = {0,0}; //initialize Re and Im results
printf("%f %f\n",out[0],out[1]);
}
void main()
{
int j;
for (j = 0; j < N; j++)
dft(x, j, out); //call DFT function
}
Output:
2.000000 0.000000
0.999996 -1.000000
0.000000 0.000007
1.000011 1.000000
89
4. Enter the source code and save the file with “.C” extension.
90
5. Right click on source, Select add files to project .. and Choose “.C “ file Saved before.
91
6. Right Click on libraries and select add files to Project.. and choose
C:\CCStudio_v3.1\C6000\cgtools\lib\rts6700.lib and click open.
92
7. a) Go to Project to Compile .
b) Go to Project to Build.
c) Go to Project to Rebuild All.
It will shows
warnings and
errors if any
Here it
shows
error if
any
93
8. Go to file and load program and load “.out” file into the board..
94
Output will
shown here
96
11. To see the Graph go to View and select time/frequency in the Graph, And give the
correct Start address provided in the program, Display data can be taken as per user.
97
12. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).
98
AIM: Realization of FIR filter (any type) to meet given specifications. The input can be a
signal from Function Generator/Speech signal
101
Finite Impulse Response (FIR) Filter: The FIR filters are of non-recursive type,
whereby the present output sample is depending on the present input sample and previous
input samples.
The transfer function of a FIR causal filter is given by,
N-1
H(z) = ∑ h(n)z-n
n=0
Where h(n) is the impulse response of the filter.
The Fourier transform of h(n) is
N-1
H(ejw) = ∑h(n)e-jwn
n=0
In the design of FIR filters most commonly used approach is using windows.
The desired frequency response Hd(ejw) of a filter is periodic in frequency and can be
expanded in Fourier series. The resultant series is given by, π
hd(n) = (1/2π) ∫ H(ejw)ejwn dw
-π
And known as Fourier coefficients having infinite length. One possible way of obtaining
FIR filter is to truncate the infinite Fourier series at n = ± [(N-1)/2]
Where N is the length of the desired sequence.
The Fourier coefficients of the filter are modified by multiplying the infinite impulse
response with a finite weighing sequence w(n) called a window.
After multiplying w(n) with hd(n), we get a finite duration sequence h(n) that satisfies
the desired magnitude response,
The frequency response H(ejw) of the filter can be obtained by convolution of Hd(ejw)
and W(ejw) is given by,
π
H(ejw) = (1/2π) ∫ Hd(ejθ) W(ej(w-θ) dθ
-π
H(e ) = Hd(e ) * W(ejw)
jw jw
Program:
#include <stdio.h>
#include "c6713dsk.h"
102
#include "master.h"
#include "aic23cfg.h"
#include "dsk6713_aic23.h"
#include <std.h>
#include <swi.h>
#include <log.h>
#include <c6x.h>
#include <csl.h>
#include <csl_mcbsp.h>
// Delta
/*float filter_Coeff[] ={0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,
0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,0.00,
0.00,0.00,0.00,0.00,0.00,0.00,1.00,0.00};*/
-1.808215737734512e-002,2.635896986048919e-004,1.323547007544908e-
002,1.517265313889167e-002,
9.822200806739014e-003,3.800020076486443e-003,3.294316420702696e-004};
DSK6713_AIC23_CodecHandle hCodec;
Int32 InitWait =1;
Int32 data;
Int32 Logger[1024];
Int32 LoggerIndex =0;
float in_buffer[100];
main(){
int i;
LED=0x0;
// Filter Initialization
for( i = 0 ; i < 100; i++ ) in_buffer[i]=0.0;
// Initialize codec
hCodec = DSK6713_AIC23_openCodec(0, &config);
IRQ_globalEnable();
104
IRQ_enable(IRQ_EVT_RINT1);
IRQ_enable(IRQ_EVT_XINT1);
}
void led(){
static int cc = 1;
LED = cc;
// To Shift Pattern
if (cc == 0x03) cc = 0x05;
else if (cc == 0x05) cc = 0x06;
else if (cc == 0x06) cc = 0x03;
else cc = 0x03;
//To count Binary
//cc++; if (cc>0x07) cc = 0x00;
// TO Toggle LED
// *cc ^= 0x07; if ((cc !=0x00) && (cc !=0x07)) cc = 0x07;
}
setpll200M(){
void read(){
int i = 0;
float result;
data=MCBSP_read(DSK6713_AIC23_DATAHANDLE);
result = 0;
for( i = 0 ; i <= 30; i++ ) result += filter_Coeff[i] * in_buffer[i];
data = (Int32)(result*512);
//data = (Int32)(in_buffer[30]*16);
Logger[LoggerIndex++] = data;
if (LoggerIndex == 1024)
LoggerIndex = 0;
}
void write(){
if (InitWait<1000){
InitWait++;
MCBSP_write(DSK6713_AIC23_DATAHANDLE, 0);
105
MCBSP_write(DSK6713_AIC23_DATAHANDLE, 0);
}
else{
MCBSP_write(DSK6713_AIC23_DATAHANDLE, data);
MCBSP_write(DSK6713_AIC23_DATAHANDLE, data);
}
}
Output:
4. Enter the source code and save the file with main.c extension.
106
5. Right click on source, Select add files to project and Choose main.c file Saved before.
6. Add the other supporting .c files which configure the audio codec.
107
7. 7. a) Go to Project to Compile.
b) Go to Project to Build.
c) Go to Project to Rebuild All.
108
It will shows
warnings and
errors if any
8. Go to file and load program and load “.out” file into the board.
10. To see the Graph go to View and select time/frequency in the Graph and give the
correct Start address provided in the program, Display data can be taken as per user.
111
11. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).
12. In the graph, chose FFT magnitude as display type we will get Graph B
112
Program:
#include <stdio.h>
#include "c6713dsk.h"
#include "master.h"
#include "aic23cfg.h"
#include "dsk6713_aic23.h"
#include <std.h>
#include <swi.h>
#include <log.h>
#include <c6x.h>
#include <csl.h>
#include <csl_mcbsp.h>
#define FiltLen 47
#define SINE_TABLE_SIZE 48
float PrNoise[600]={0.3509,0.1118,0.3631,0.2673,0.2826,0.1909,0.2901,0.1378,0.1270,
0.1798,0.2925,0.3730,0.1307,0.1380,0.2859,0.1738,0.3278,0.0355,0.3177,0.2905,
0.1473,0.2380,0.2112,0.2662,0.3228,0.0264,0.2991,0.3027,0.1220,0.1676,
0.2360,0.2942,0.3058,0.3013,0.1423,0.1478,0.3479,0.2017,0.3278,0.1164,
0.2747,0.2752,0.4239,0.0666,0.2130,0.2124,0.0124,0.3306,0.3134,0.1420,
0.2837,0.0446,0.2438,0.1069,0.1902,0.3497,0.0962,0.1404,0.2046,0.1419,
0.3231,0.3962,0.0549,0.0875,0.2742,0.1418,0.3797,0.3756,0.2441,0.3271,
0.1456,0.2332,0.3789,0.2250,0.3798,0.3153,0.2295,0.2950,0.3924,0.0982,
0.1493,0.3649,0.1159,0.2095,0.3088,0.3656,0.2539,0.0606,0.0548,0.2847,
0.2610,0.4005,0.2985,0.2459,0.1789,0.0824,0.3774,0.2256,0.0309,0.2949,
0.2133,0.0136,0.3288,0.0923,0.0491,0.0178,0.1205,0.1107,0.3042,0.0761,
0.1512,0.1302,0.3434,0.1384,0.2454,0.1873,0.2804,0.0407,0.4164,0.3858,
0.0678,0.2275,0.1430,0.2304,0.0500,0.1793,0.1887,0.2067,0.1776,0.0374,
0.2449,0.2093,0.0772,0.1982,0.1787,0.2021,0.2916,0.2557,0.3304,0.0184,
0.0892,0.1823,0.3762,0.2984,0.1576,0.1120,0.0088,0.3026,0.2274,0.1223,
0.2151,0.1131,0.3248,0.1441,0.3475,-0.0471,0.2749,0.1925,0.1708,0.2431,
0.2975,0.0634,0.3891,0.0372,0.1486,0.0943,0.3835,0.0355,0.2320,0.2466,
117
0.2428,0.3175,-0.0105,0.2891,0.1764,0.2621,0.0814,0.2239,0.3074,0.4196,
0.2065,0.0613,0.0321,0.2495,0.3044,0.2513,0.1193,0.3635,0.2031,0.3801,
0.0303,0.0733,0.3001,0.3507,0.2985,0.1186,0.0656,0.3612,0.3397,0.1294,
0.1102,0.1194,0.3025,0.2892,0.1845,0.1956,0.1073,0.2981,0.3682,0.2311,
0.2244,0.2099,0.0990,0.2220,0.2894,0.2813,0.2316,0.0653,0.2872,0.1048,
0.1335,0.1639,0.1335,0.2752,0.0262,0.2958,0.2226,0.2916,0.1142,0.2017,
0.3252,0.2093,0.1280,0.4335,0.0627,0.1850,0.4388,0.1821,0.1451,0.0544,
0.3462,0.0154,0.0822,0.3031,0.1478,0.2130,0.2230,0.2897,0.0397,0.2436,
0.0428,0.3551,0.1458,0.3382,0.0957,0.2303,0.3804,0.0262,0.0356,0.0130,
0.2607,0.2102,-0.0020,0.2581,0.1933,-0.0047,0.0244,0.0922,0.3805,0.1092,
0.1670,0.1447,0.0477,0.3077,0.2124,0.2124,0.1879,0.1623,0.1219,0.2904,
0.0953,0.1132,0.0502,0.4002,0.3765,0.0096,0.1440,0.2291,0.1027,0.3114,
0.2580,0.2089,0.1434,0.3168,0.3503,0.2551,0.1064,0.3127,0.0588,0.1926,
0.3867,0.1418,0.1538,0.4241,0.0659,0.1438,0.2286,0.0508,0.2072,0.2740,
0.1688,0.2416,0.0827,0.2314,0.3496,0.1934,0.3886,0.0894,0.0704,0.1493,
0.1843,0.1859,0.1252,0.2559,0.0035,0.1217,0.0717,0.0912,0.0251,0.2405,
0.1436,0.1074,0.0493,0.1552,0.2456,0.3565,-0.0167,0.3025,-0.0187,0.2772,
0.2816,0.3582,0.0750,0.2422,0.2169,0.1210,0.2634,0.2424,0.0600,0.1631,
0.3293,0.1383,0.2371,0.1551,0.0338,0.1593,0.3720,0.1812,0.0607,0.1999,
0.1206,0.2411,0.1635,0.2727,0.2958,0.0758,0.0701,0.3565,0.2880,0.0363,
0.3726,0.2002,0.2003,0.2127,0.2768,0.3146,0.1400,0.0291,0.2936,0.1341,
0.3375,0.1544,0.3321,0.0716,0.0532,0.3473,0.0176,0.2671,0.2772,0.1617,
0.1264,0.3688,0.1475,0.1768,0.0764,0.1556,0.1539,0.3684,0.0979,0.1012,
0.1261,0.2401,0.0153,0.3234,0.0373,0.2052,0.0465,0.3405,0.3056,0.0901,
0.2585,0.1746,0.2905,0.1795,0.3366,0.1744,0.1618,0.2372,0.1421,0.3937,
0.1927,0.0760,0.1248,0.2367,0.1159,0.0431,0.3350,0.2452,0.1800,0.1234,
0.1133,0.2164,0.1742,0.2783,0.0053,0.3180,0.2518,0.0386,0.3270,0.0609,
0.2273,0.2060,0.0477,0.0029,0.3182,0.3218,0.1980,0.0483,0.2532,0.0704,
0.2688,0.1805,0.0634,0.3304,0.2816,0.3470,0.0396,0.0822,0.3077,0.2812,
0.2906,0.1659,0.1466,0.2278,0.3560,0.3095,0.2671,0.1798,0.3339,0.1612,
0.1967,0.2755,0.2225,0.2483,0.3013,0.2941,0.0201,0.0807,0.1395,0.2114,
0.0911,0.2137,0.1130,0.1435,0.2817,0.0310,0.0678,0.3107,0.1429,0.0814,
0.2429,0.3712,0.1587,0.2622,0.2169,0.1503,0.1834,0.3897,0.0846,0.1703,
0.2341,0.2631,0.3412,0.1344,0.0903,0.1993,0.0939,0.2847,0.1697,0.2312,
0.2761,0.1753,0.1190,0.0868,0.3864,0.0813,0.3023,0.2145,0.2764,0.3148,
0.0086,0.1329,0.3952,0.2684,0.3843,0.2181,0.0226,0.2681,0.1080,0.2249,
0.2832,0.2395,0.2193,0.1590,0.0663,0.1474,-0.0163,0.2260,0.3727,0.0303,
0.0235,0.3627,0.1062,0.0084,0.3246,0.0568,0.3485,0.0407,0.1353,0.2338,
0.2315,0.2545,0.2482,0.1510,0.0363,0.2882,0.0925,0.2603,0.3444,0.0445,
0.4034,0.0162,0.3319,0.3212,0.0066,0.2010,0.3604,0.1120,0.3155,0.2390,
0.3231,0.3301,0.0269,0.1138,0.2520,0.1875,0.3778,0.2939,0.2133,0.1170,
0.0977,0.3524,0.1664,0.3211,0.0252,0.3361,0.0023,0.3513,0.3686,0.2151,
0.0581,0.0777,0.1664,0.3211,0.0252,0.3361,0.0023,0.3513,0.3686,0.2151};
1.039856067649067e-002, 5.093274200275827e-003,1.421581262318843e-003,
2.515430936577368e-003,9.363053213111126e-003,1.949152112446623e-002,
2.722897698684972e-002,2.579943237700517e-002,1.050645191333675e-002,
-1.832163998604397e-002,-5.406194181033640e-002,-8.514869723584616e-002,
-9.887618777194764e-002,-8.633153232820758e-002,-4.651515024517261e-002,
1.217011610629542e-002,7.394838432088444e-002,1.206802616409422e-001,
1.380624377729094e-001,1.206802616409422e-001,7.394838432088444e-002,
1.217011610629542e-002,-4.651515024517261e-002,-8.633153232820758e-002,
-9.887618777194764e-002,-8.514869723584616e-002,-5.406194181033640e-002,
-1.832163998604397e-002,1.050645191333675e-002,2.579943237700517e-002,
2.722897698684972e-002,1.949152112446623e-002,9.363053213111126e-003,
2.515430936577368e-003,1.421581262318843e-003,5.093274200275827e-003,
1.039856067649067e-002,1.403350814552515e-002,1.428453375748106e-002,
1.182863130963947e-002,8.917428211564256e-003,-2.181030629062908e-002};
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 */
0x0043, /* 7 DSK6713_AIC23_DIGIF Digital audio interface format */
0x008c, /* 8 DSK6713_AIC23_SAMPLERATE Sample rate control */
0x0001 /* 9 DSK6713_AIC23_DIGACT Digital interface activation */
};
DSK6713_AIC23_CodecHandle hCodec;
Int32 InitWait =1;
Int32 data;
float in_buffer[100];
float InSigBuffer[600];
float NoiseBuffer[600];
float CorrSigBuffer[600];
119
float RecovSigBuffer[600];
int LogIndex =0;
main(){
int i;
LED=0x0;
for( i = 0 ; i < 100; i++ ) in_buffer[i]=0.0;
hCodec = DSK6713_AIC23_openCodec(0, &config);
IRQ_globalEnable();
IRQ_enable(IRQ_EVT_RINT1);
IRQ_enable(IRQ_EVT_XINT1);
}
void led(){
static int cc = 1;
LED = cc;
if (cc == 0x03) cc = 0x05;
else if (cc == 0x05) cc = 0x06;
else if (cc == 0x06) cc = 0x03;
else cc = 0x03;
}
setpll200M(){
}
void read(){
int i = 0;
float result;
float InData;
float InNoise;
float InCorrup;
static int NoiseIndex=0;
static int SinIndex = 0;
data=MCBSP_read(DSK6713_AIC23_DATAHANDLE);
if(data>=32768) data= data|0xffff0000;
// For Demo
InSigBuffer[LogIndex]= InData;
NoiseBuffer[LogIndex]= InNoise ;
CorrSigBuffer[LogIndex]= InCorrup;
RecovSigBuffer[LogIndex] = (float)data;
LogIndex++;
if (LogIndex == 600)
LogIndex =0;
void write(){
if (InitWait<1000){
InitWait++;
MCBSP_write(DSK6713_AIC23_DATAHANDLE, 0);
MCBSP_write(DSK6713_AIC23_DATAHANDLE, 0);
}
else{
MCBSP_write(DSK6713_AIC23_DATAHANDLE, data);
MCBSP_write(DSK6713_AIC23_DATAHANDLE, data);
}
}
Output:
121
4. Enter the source code and save the file with main.c extension.
5. Right click on source, Select add files to project and Choose main.c file Saved before.
122
6. Add the other supporting .c files which configure the audio codec.
7. 7. a) Go to Project to Compile.
b) Go to Project to Build.
c) Go to Project to Rebuild All.
123
It will shows
warnings and
errors if any
8. Go to file and load program and load “.out” file into the board.
124
10. To see the Graph go to View and select time/frequency in the Graph and give the
correct Start address provided in the program, Display data can be taken as per user.
11. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).
126
AIM: To find Impulse response of a first order and second order system.
128
M M
y(n) = ∑ak y(n-k) + ∑bk x(n-k)
k=1 k=0
}
}
Output:
0.131100 0.360237 0.364799 0.174741 0.031373
void main()
{
int j, k;
float a[Order+1] = {0.1311, 0.2622};
float b[Order+1] = {1, -0.7478};
for(j=0; j<Len; j++)
{
sum = 0.0;
for(k=1; k<=Order; k++)
{
if((j-k)>=0)
sum = sum+(b[k]*h[j-k]);
}
if(j<=Order)
h[j] = a[j]-sum;
else
h[j] = -sum;
printf("%f ", j, h[j]);
}
}
Output:
0.131100 0.360237 0.269385 0.201446 0.150641
4. Enter the source code and save the file with “.C” extension.
130
5. Right click on source, Select add files to project .. and Choose “.C “ file Saved before.
131
6. Right Click on libraries and select add files to Project.. and choose
C:\CCStudio_v3.1\C6000\cgtools\lib\rts6700.lib and click open.
132
7. a) Go to Project to Compile.
b) Go to Project to Build.
133
It shows errors
and warnings
here.
8. Go to file and load program and load “.out” file into the board..
134
Output will
display
here
137
11. To see the Graph go to View and select time/frequency in the Graph, and give the
correct Start address or the output variable name provided in the program, Display data
can be taken as per user. Select DSP data type as 32-bit floating point.
138
12. Green line is to choose the point, Value at the point can be seen (Highlighted by
circle at the left corner).