0% found this document useful (0 votes)
49 views36 pages

DSP Lab Manual

The document describes experiments conducted on digital signal processing concepts. Experiment 4 aims to study the impulse response of linear time-invariant (LTI) systems. It explains that the output of an LTI system, when given an impulse as input, is the impulse response. Equations to calculate the impulse response coefficients are given by relating the input, output and previous coefficient values of the LTI system. The experiment concludes with studying the impulse response of LTI systems.

Uploaded by

mayur bokan
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
49 views36 pages

DSP Lab Manual

The document describes experiments conducted on digital signal processing concepts. Experiment 4 aims to study the impulse response of linear time-invariant (LTI) systems. It explains that the output of an LTI system, when given an impulse as input, is the impulse response. Equations to calculate the impulse response coefficients are given by relating the input, output and previous coefficient values of the LTI system. The experiment concludes with studying the impulse response of LTI systems.

Uploaded by

mayur bokan
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 36

Laboratory Journal

of
DIGITAL SIGNAL PROCESSING

For completion of term work of 6th semester


curriculum program

Bachelor of Technology

In

ELECTRONICS AND TELECOMMUNICATION ENGINEERING

DEPARTMENT OF ELECTRONICS AND TELECOMMUNICATION

ENGINEERING

Dr. BABASAHEB AMBEDKAR TECHNOLOGICAL UNIVERSITY

Lonere-402 103, Tal. Mangaon, Dist. Raigad (MS)

INDIA
List of Practical

Exp. No. Title

1. To study Fourier transform of given sequence.

2. To study sampling theorem

3. To study design of various types of filter.

4. To study impulse response of LTI system.

5. To study IIR low pass filter.

6. To study circular shifting property of sequence.

7. Study of discrete Fourier transform.

8. To implement DFT-FFT algorithm using matlab.

9 To study pole-zero plot of linear phase transfer function.

10 To implement comb filter

11 To illustrate step and impulse response of the system

12 To illustrate zero state and zero input response for first and second order system
EXPERIMENT NO.1
Aim: To study Fourier transform of given sequence.

Theory: Fourier transform convert the time domain to frequency domain. It is of two types.
i. CTFT: Continuous Time Fourier Transform
ii. DTFT: Discrete Time Fourier Transform

The DTFT of sequence x[n] is given by


X(ejω)= [ ]
Where x[n] should be absolutely summable. i.e. ∑│x(n)│<∞
1. Fourier transform is periodic with period 2π.
2. Magnitude of Fourier transform is given as
|X(ejω)| = |x(n)|
3. Phase is given as < X(ejω)=ω
4. If x[n] is given sequence , then
FT of x[n]=X(ω) symmetric
Real part of x[n]=XR(ω) symmetric
Imaginary Part x[n]=Xi(ω) antisymmetric
Phase of x[n]= <X(ω) antisymmetric

Conclusion: Thus we have studied Fourier transform.


%Fourier Transform%
x=input('enter the signal X:')
N=length(x)
w=-pi
for i=1:1:100
n=1:1:N
e=exp(-j*w*n)
xft(i)=x*e'
w=w+(2*pi)/100
end
subplot(2,2,1)
plot(abs(xft))
title('absolute of X')
subplot(2,2,2)
plot(phase(xft))
title('phase of X')
subplot(2,2,3)
plot(real(xft))
title('real of X')
subplot(2,2,4)
plot(imag(xft))
title('imagnary of X')

Output:
enter the signal x:[1 2 3 4 5 6 7]
absolute of X phase of X
30 60

40
20
20
10
0

0 -20
0 50 100 0 50 100

real of X imagnary of X
40 40

20
20
0
0
-20

-20 -40
0 50 100 0 50 100
EXPERIMENT NO.2

Aim: To study sampling theorem.

Theory:
Definition: It states that sampling frequency must be greater than or equal to twice that of maximum
signal frequency.
fs≥2fin

X[n] =x[nT]=x[t] | t=nT


Where T=sampling period = =sampling frequency (fs)
fs≥2fm
fm=maximum frequency of signal

Conclusion: Hence we have studied the sampling theorem.


%sampling theorem%
f1=input('enter first frequency:')
f2=input('enter second frequency:')
N=input('enter no. of samples required:')
t=0:0.01:1
T=1
y=sin(2*pi*f1*t)-sin(2*pi*f2*t)
for n=1:1:N
x(n)=y(n*T)
end
subplot (2,1,1)
plot(y)
xlabel('T')
ylabel('Amplitude')
title('continuous signal')
subplot(2,1,2)
stem(x)
xlabel('N')
ylabel('Amplitude')
title('sampling signal')

Output:
Enter the first frequency:0.3
Enter the second frequency:0.9
Enter no. of samples required:99
continuous signal
2
Amplitude

-1
0 20 40 60 80 100 120
T
sampling signal
2

1
Amplitude

-1
0 10 20 30 40 50 60 70 80 90 100
N
EXPERIMENT NO.3

Aim: To study design of various types of filter.

Theory: There are four types of filters


a. Low pass filter
b. Band pass filter
c. Band stop filter
d. High pass filter

a. Low pass filter: It allows low frequencies to pass through it. For low-pass filter transfer function
is
±
H(z)=( )( ± )
j0
ω=0 z=e =1
ω=π z=ejπ=-1
Syntax in matlab: B1=FIR(N, ωn, ‘low’);
b. High pass filter: It allows high frequencies to pass through it. For high-pass filter transfer
function is
±
H(z)=( )( ± )
j0
ω=0 z=e =1
ω=π z=ejπ=-1
Syntax in matlab: B2=FIR(N, ωn, ‘high’);
c. Band pass filter: It allows certain frequencies of band to pass through it.
Syntax in matlab: B3=FIR(N, ω, ‘band-pass’);
d. Band stop filter: It attenuates certain band of frequencies.
Syntax in matlab: B4=FIR(N, ω, ‘band-stop);
Conclusion: Hence we have studied design of all types of filter.
%design of filters%
N=input('enter the order of fir filter')
wn=input('enter the cutoff frequency')
w1=input('enter the first cutoff frequency')
w2=input('enter the second cutoff frequency')
W=[w1 w2]
B1=FIR1(N,wn,'low')
B2=FIR1(N,wn,'high')
B3=FIR1(N,w,'bandpass')
B1=FIR1(N,w,'stop')
FREQZ(B1)
figure
FREQZ(B2)
figure
FREQZ(B3)
figure
FREQZ(B4)
Figure

Output:
Enter the order of FIR filter:90
Enter the cut off frequency:0.30
Enter the first cut off frequency:0.4
Enter the second cut off frequency:0.80

50
Magnitude (dB)

-50

-100

-150
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)

0
Phase (degrees)

-1000

-2000

-3000
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)
Magnitude (dB) 50

-50

-100

-150
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)

2000
Phase (degrees)

-2000

-4000

-6000
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)

50
Magnitude (dB)

-50

-100

-150
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)

0
Phase (degrees)

-1000

-2000

-3000
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)
Magnitude (dB) 50

-50

-100

-150
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)

0
Phase (degrees)

-2000

-4000

-6000
0 0.1 0.2 0.3 0.4 0.5 0.6 0.7 0.8 0.9 1
Normalized Frequency ( rad/sample)
EXPERIMENT NO.4

Aim: To study impulse response of LTI system.

Theory: When x(n) and h(n) are two causal sequence are given as input to the LTI system then output is

y[n]= h[k]x[n − k]

Then using above equation we can find the values of h[n] as follows

y[0]= h[k]x[0 − k]

y[0]=h[0] x[0]

[ ]
h[0]= [ ]
-----------------------------------------------------------------------------------------------------------------(1)
y[1]= h[k]x[1 − k]

y[1]=h[0] x[1]+ h[1] x[0]

[ ] [ ] [ ]
h[1]= [ ]
--------------------------------------------------------------------------------------------(2)

y[2]= h[k]x[2 − k]

[ ] [ ] [ ] [ ] [ ]
h[2]= ------------------------------------------------------------------------------------------(3)
[ ]
By observing equation (1), (2), (3)
We can write the general formula for h[n] as follows

[ ] ( ) ( )
h[n]=
[ ]
Conclusion: We can find the impulse response input if we know that the input sequence and total
output of LTI system.
%impulse response of LTI system%
clear all
x=input('enter the sequence')
y=input('enter the response')
h(1)=y(1)/x(1)
n1=length(x)
n2=length(y)
N=n2-n1+1
for n=2:1:N
s=0
for k=1:1:n-1
s=s+h(k)*x(n-k+1)
end
h(n)=(y(n)-s)/x(1)
end
disp(h)
stem(h)

Output:
enter the sequence[1 1 1]
enter the response [1 8 7 6 5]

-1
1 1.2 1.4 1.6 1.8 2 2.2 2.4 2.6 2.8 3
EXPERIMENT NO.5

Aim: To study IIR low pass filter.

Theory:Simple IIR filter pole to be exist not zero.


The transfer function of IIR low pass filter is given as
±
H(z)=( )( )
±
ω=0, z=1
ω=π, z=-1
The cut-off frequency of the filter is given as
ωc=cos-1( )
±
α=
Conclusion: Thus we studied low pass filter by observing its magnitude and requency response.
%IIR low pass filter%
wc=input('enter the frequency:')
a1=(1+sin(wc))/cos(wc)
a2=(1-sin(wc))/cos(wc)
A=min(a1,a2)
for i=1:1:100
b=exp(-j*wc)
hlp(i)=((1-A)/2)*(1+b)/(1-A*b)
wc=wc+2*pi/100
end
subplot(2,1,1)
plot(abs(freqz(hlp)))
title('absolute frequency of hlp')
subplot(2,1,2)
plot(angle(freqz(hlp)))
title('angle of hlp')

Output:
Enter the frequency: 0.33
absolute frequency of hlp
20

15

10

0
0 100 200 300 400 500 600

angle of hlp
4

-2

-4
0 100 200 300 400 500 600
EXPERIMENT NO.6

Aim: To study circular shifting property of sequence.

Theory: If x(n) is given sequence of length N, l is circular shift factor then x(n) can be circularly shifted
as follows

Eg. x[n]={1,2,3,4} and l=2


x1[n]={3,4,1,2}
It can be shifted by writing a program using if as follows
x1[n]=x[n-l], when l<n≤N-1
x1[n]=x[n-l+N], when 0<n≤l

Conclusion : Hence we have studied the circular shift property of a given sequence.
%circular shifting property%
clc
x=input('enter the sequence')
N=length(x)
l=input ('enter the shift factor' )
for n=1:1:N
if (n>l)
x1(n)=x(n-l)
else
x1(n)=x(n-l+N)
end
end
disp(x1)

Output:
enter the sequence[ 6 5 4 3 2 1]
Output:
x=
6 5 4 3 2 1
N=
6
enter the shift factor3
l=
3
x1 =
3 6 1 2 3 4
x1 =
3 2 1 2 3 4
x1 =
3 2 1 2 3 4
x1 =
3 2 1 6 3 4
x1 =
3 2 1 6 5 4
x1 =
3 2 1 6 5 4
3 2 1 6 5 4
EXPERIMENT NO.7

Aim : Study of discrete Fourier transform.

Theory:
It is sampled from a continuous time Fourier transform
x(n) is sequence of length N
X(ω)= x(n)e
x(k)= X(ω)|ω=
( )
X(k)= x(n)e
k=0,1,-------------------N-1
DFT is periodic with period N
i.e. X[k+N]=X[k]
X*[n-k]=X[k]
For each value of k, N times complex multiplications are needed while N-1 times additions are needed.
While for N point DFT we require
N2=complex multiplication
N(N-1)=complex addition
Conclusion: Hence we studied discrete Fourier transform of sequence.
%discrete Fourier transform%
x=input('enter the discrete signal x')
N=length(x)
for k=0:1:N-1
n=0:1:N-1
e=exp(-j*2*pi*n*k/N)
x(k+1)=x*e'
end
subplot(2,2,1)
stem(abs(x))
title('absolute of x')
subplot(2,2,2)
stem(phase(x))
title('phase of x')
subplot(2,2,3)
stem(real(x))
title('real of x')
subplot(2,2,4)
stem(imag(x))
title('imagnary of x')

Output:
Enter the discrete signal X:[1 2 3 4 5 6 7]
absolute of x phase of x
100 2

0
50
-2

0 -4
0 2 4 6 8 0 2 4 6 8

real of x imagnary of x
40 50

20 0

0 -50

-20 -100
0 2 4 6 8 0 2 4 6 8
EXPERIMENT NO.8
Aim: To implement DFT-FFT algorithm using matlab.

Software: Matlab

Theory: Fast Fourier Transform (FFT). The FFT is an algorithm that efficiently computes the
DFT.
The DFT of a sequence x[n] of length N is given by complex value sequence, X(k)
X(k)= x[n] 0< k ≤ N-1

Let ωn be the complex value phase factor which is root of unity.

ωn=

X(k)= x[n] W 0< k ≤ N-1


Similarly, x(n)= X[k] W 0< n ≤ N-1
DFT is primarily in efficient as it does not expect the symmetry and periodicity. An efficient
algorithm for DFT is FFT algorithm.

Symmetric property W = −W
Periodicity property W =W

Decimation in FFT
Let us assume that x(n) represents sequence of N values where N is
integer of power 2 i.e. N=2
The given sequence is decimated into two N/2 point segments consisting of even and odd
segment.
X(k)= x[n] W
/ /
= x[2n] W + x[2n + 1] W
/ /
= x[2n] W / +W x[2n + 1] W /

From signal flow graph


g0(0)=x(0)+x(4) ; h0(0)=x(1)+x(5);
g0(1)=x(0)-x(4) ; h0(1)=x(1)-x(5);
g1(0)=x(2)+x(6) ; h1(0)=x(3)+x(7);
g1(1)=x(2)-x(6) ; h1(1)=x(3)-x(7);

for 4-point DFT


G(0)= g0(0)+w40 g1(0); H(0)= h0(0)+w40 h1(0)
G(1)= g0(1)+w41 g1(1); H(1)= h0(1)+w41 h1(1)
G(2)= g0(0)+w42 g1(0); H(2)= h0(0)+w42 h1(0)
G(3)= g0(1)+w43 g1(1); H(3)= h0(1)+w43 h1(1)

For 8-point DFT


X(0)= G(0)+w80 H(0)
X(1)= G(1)+w81 H(1)
X(2)= G(2)+w82 H(2)
X(3)= G(3)+w83 H(3)
X(4)= G(0)+w84 H(0)
X(5)= G(1)+w85 H(1)
X(6)= G(2)+w86 H(2)
X(7)= G(3)+w87 H(3)

Conclusion :Hence we have implemented DFT FFT algorithm and concluded that we can reduce
the multiplier by using DFT FFT.
%algorithm for fft%
x=input('enter the length and sequence')
for i=1:1:4
g(i)=x(i)+x(i+4)
g(i+4)=x(i)-x(i+4)
end
for i= 1:1:2
h(i)=g(i)+g(i+2)
h(i+2)=g(i)-g(i+2)
end
for i=5:1:6
h(i)=g(i)-(j*(g(i+2)))
h(i+2)=g(i)+(j*(g(i+2)))
end
y(i)=bitrevorder(h(i))
for i=1:1:4
X(i)=y(i)+exp(-j*2*pi*(i-1)/8)*y(i+4)
X(i+4)=y(i)+exp(-j*2*pi*(i+3)/8)*y(i+4)
end
z=fft(x)
disp('X=')
disp (X)
disp('z')
disp(z)

Output:

Enter the length and sequence [1 2 3 4 5 6 7 8]

X=

36.0000 -4.0000+9.6569i -4.0000+4.0000i -4.0000+1.6569i

4.0000 -4.0000-1.6569i -4.0000-4.0000i -4.0000-9.6569i

Z=

36.0000 -4.0000+9.6569i -4.0000+4.0000i -4.0000+1.6569i

4.0000 -4.0000-1.6569i -4.0000-4.0000i -4.0000-9.6569i


EXPERIMENT NO.9

Aim:-To study pole-zero plot of linear phase transfer function.

Theory:- Linear phase transfer function


For function to be linear phase,phase responce should be such that
Phase response Φ(ω)=kω+c
Type 1:
Symmetric impulse response of odd length
h(n)=h(l-1-n)
if length =9; h(n)=h(8-n)
h[1]=h[7]
h[2]=h[6]
h[3]=h[5]
h[4]=h[4]
h[n]={h0,h1,h2,h3,h4,h3,h2,h1,h0}
/
For this IR, H(ω)=e-jNω/2 [∑ 2 hi cos( − i)ω + ]
And H(ω)=- if HR(ω)>0
=- + if HR(ω)<0

Type2:
Symmetric impulse response of even length
Let L=6
h[n]={h0,h1,h2,h2,h1,h0}

Type3:
Anti-symmetric impulse response of odd length
Let L=7
h[n]={h0,h1,h2,0,-h2,-h1,-h0}

Type4:
Anti-symmetric impulse response of even length
Let L=6
h[n]={h0,h1,h2,- h2,-h1,-h0}

Z-plane: Z-plane zero plot of zeros Z and pole P with unit circle for reference . Each zero is
represented with ‘O’ and each pole with ‘X’. Multiple zeros and poles are indicated by
multiplicity number shown to upper right of zero or pole.

Conclusion: Thus we have pole-zero plot of linear phase transfer function.


%to find pole zero plot of linear phase transfer function%
w=input('enter the first sequence')
x=input('enter the second sequence')
y=input('enter the third sequence')
z=input('enter the forth sequence')
zplane(w)
figure
zplane(x)
figure
zplane(y)
figure
zplane(z)
figure

Output
Enter the first sequence [ 1 2 3 4 3 2 1]
Enter the second sequence [ 1 2 3 0 -3 -2 -1]
Enter the third sequence [ 1 2 3 -3 -2 -1]
Enter the forth sequence [ 1 2 3 3 2 1]

1.5
2
1

0.8 1

0.6
0.5
0.4
Imaginary Part
Imaginary Part

0.2 6
0
2 6
0

-0.2 -0.5
-0.4

-0.6 -1

-0.8

-1
2 -1.5

-1 -0.5 0 0.5 1 -2 -1.5 -1 -0.5 0 0.5 1 1.5 2


Real Part Real Part

1.5
1

1 0.8

0.6
0.5
0.4
Imaginary Part

Imaginary Part

5 0.2
0
5
0

-0.5 -0.2

-0.4
-1
-0.6

-1.5 -0.8

-1
-2 -1.5 -1 -0.5 0 0.5 1 1.5 2 -1 -0.5 0 0.5 1
Real Part Real Part
EXPERIMENT NO.10

Aim:-To implement comb filter


Theory:-
a. Transfer function of comb filter with low pass filter
G(z)=HLP(z)L=(1+z-L)/2
HLP(ejw)L =(1+e-jwL)/2
= e-jwL/2(ejwL/2 +e-jwL/2)/2
= e-jwL/2cos(wL/2)
│G(w)│ =│cos(wL/2)│
│G(w)│ will be zero when wL/2=(2k+1)π/2
i.e w=(2k+1) π/L for k=0,1,2,3........

Fig.a. Comb Filter with low pass filter.

b. Transfer function of comb filter with high pass filter


HHP(z)=(1-z-L)/2
G(w)= HHP(zL)=(1-z-L)/2
=(1-ejwL)/2
= e-jwL/2(ejwL/2 –e-jwL/2)/2
=j e-jwL/2sin(wL/2)
│G(w)│ =│sin(wL/2)│
│G(w)│=0 when wL/2=kπ
i.e w=2πk/L for k=0,1,2,3......
Fig.b. Comb Filter with high pass filter.

Conclusion:-Thus we have studied implementation of comb filter.


%to implement comb filter%
clc
L=input('enter the length of filter')
n=input('enter the response of filter')
w=0
for l=1:1:100
e=exp(-j*w*L/2)
y(l)=e*cos(w*L/2)
w=w+(2*pi/100)
end
plot(abs(y))
Output:
enter the length of filter6
L=
6
enter the response of filter6
n=
6

0.9

0.8

0.7

0.6

0.5

0.4

0.3

0.2

0.1

0
0 10 20 30 40 50 60 70 80 90 100
EXPERIMENT NO.11
Aim:
To illustrate step and impulse response of the system
Software:
MATLAB 7.3
Theory:
Step response: It is defined as the response or output of the system when an input
applied to the system is unit step signal.
Impulse response: It is defined as response or output of the system when input
applied is impulse signal.
Program:
%step and impulse reasponse
num=[2];
den=[2 1 2];
printsys(num,den)
a = tf(num,den);
subplot(211)
impulse(a);
subplot(212)
step(a)
Conclusion:
Thus, we have illustrated the step and impulse response of a system using matlab.
******************************************************************************
Sample output
******************************************************************************
num/den =

2
--------------
2 s^2 + s + 2
>>
Impulse Response
1

0.5
Amplitude

-0.5
0 5 10 15 20 25
Time (sec)

Step Response
1.5

1
Amplitude

0.5

0
0 5 10 15 20 25
Time (sec)
EXPERIMENT NO. 12
Aim:
To illustrate zero state and zero input response for first and second order system
Software:
MATLAB 7.3
Theory:
Zero state response: It is the response of the system when all initial conditions are
assumed to zero and considering only the input applied to the system.
Zero input response: It is the response of the system when input is zero and initial
conditions are considered. It gives state of the system before any input is applied.
Program:
%FIRST ORDER FUNCTION
function [ydot]=myfun1(t,y)
ydot=-4*y+2*cos(2*t).*(t >= 0);
%END OF FUNCTION
%matlab program to solve first order differential Eqution
tspan=[0:0.01:15];
y0=[2];
[t,y]=ode23('myfun1',tspan,y0);
%solve ODE using ode23
plot(t,y,'k');
grid on;
xlabel('time');
ylabel('output response y(t)');
title('total response=ZIR+ZSR:MATLAB Result verification for First order Differential
equation');
figure;
y=1.6*exp(-4*t)+0.2*sin(2*t)+0.4*cos(2*t);
plot(t,y,'k');
grid on;
xlabel('time');
ylabel('output Response y(t)');
title('Total Response=ZIR+ZSR:Analytical Result Verification for first order Differential
Equation');
*******************************************
%SECOND ORDER DIFFERENTIAL EQUATION
function [ydot]=myfunct2(t,y)
%usage:ydot=myfunc2(t,y)
ydot(1,1)=-5*y(1)-4*y(2)+3*cos(t)*(t>=0);
ydot(2,1)=y(1);
%end of function
Clear all;
tspan=[0:0.02:20];
y0=[-5;2];
[t,y]=ode23('myfunc2',tspan,y0)
plot(t,y(:,2),'k')
grid on;
xlabel('time');
ylabel('output Response y(t)');
title('Total Response=ZIR+ZSR:for second order Differential Equation');
figure;
y=(1/2)*exp(-t)+(21/17)*exp(-4*t)+(9/34)*cos(t)+(15/34)*sin(t);
plot(t,y,'k')
grid on;
xlabel('time');
ylabel('output Response y(t)');
title('Total Response=ZIR+ZSR:Analytical Result Verification for second order
Differential Equation');
Conclusion:
Thus, ZIR and ZSR for first order and second order differential equations are verified
using matlab.
SAMPLE OUTPUT

total response=ZIR+ZSR:MATLAB Result verification for First order Differential equation


2

1.5
output response y(t)

0.5

-0.5
0 5 10 15
time

Total Response=ZIR+ZSR:Analytical Result Verification for first order Differential Equation


2

1.5
output Response y(t)

0.5

-0.5
0 5 10 15
time
Total Response=ZIR+ZSR:for second order Differential Equation
2

1.5

1
output Response y(t)

0.5

-0.5

-1
0 2 4 6 8 10 12 14 16 18 20
time

Total Response=ZIR+ZSR:Analytical Result Verification for second order Differential Equation


2

1.5

1
output Response y(t)

0.5

-0.5

-1
0 2 4 6 8 10 12 14 16 18 20
time

You might also like

pFad - Phonifier reborn

Pfad - The Proxy pFad of © 2024 Garber Painting. All rights reserved.

Note: This service is not intended for secure transactions such as banking, social media, email, or purchasing. Use at your own risk. We assume no liability whatsoever for broken pages.


Alternative Proxies:

Alternative Proxy

pFad Proxy

pFad v3 Proxy

pFad v4 Proxy