Signals and Systems Lab (10!12!19) With Answers
Signals and Systems Lab (10!12!19) With Answers
List of Experiments
(Minimum Twelve experiments to be conducted)
1. Basic operations on Matrices
2. Generation of Various signals and Sequences (Periodic and Aperiodic), Such as Unit Impulse,
Unit Step, Square, Saw Tooth, Triangular, Sinusoidal, Ramp, sinc function.
3. Operations on Signals and Sequences such as Addition, Multiplication, Scaling, Shifting,
Folding, Computation of Energy and Average power.
4. Finding the Even and Odd parts of Signal or Sequence and Real and Imaginary parts of Signal.
5. Convolution between Signals and Sequences.
6. Autocorrelation and Cross correlation between Signals and Sequences.
7. Verification of Linearity and Time Invariance properties of a Given Continuous / Discrete
System.
8. Computation of Unit Sample, Unit Step and Sinusoidal Responses of the given LTI system and
verifying its Physical Realizability and Stability properties.
9. Gibbs phenomenon.
10. Finding the Fourier Transform of a given Signal and plotting its Magnitude and phase
Spectrum.
11. Waveform Synthesis using Laplace Transform.
12. Locating Zeros and poles, and plotting the Pole-Zero maps in S-Plane and Z-Plane for the given
Transfer Functions.
13. Generation of Gaussian Noise (Real and Complex), Computation of its Mean, M.S. Values and
its Skew, Kurtosis, and PSD, Probability Distribution Function.
14. Sampling Theorem Verification.
INDEX
Experiment No-1
PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
clc;
close all;
clear all;
a=[1 2 -9 ; 2 -1 2; 3 -4 3];
b=[1 2 3; 4 5 6; 7 8 9];
disp('The matrix a= ');a
disp('The matrix b= ');b
% to find sum of a and b
c=a+b;
disp('The sum of a and b is ');c
% to find difference of a and b
d=a-b;
disp('The difference of a and b is ');d
%to find multiplication of a and b
e=a*b;
disp('The product of a and b is ');e
% to find size of matrix a
[f g]=size(a);
disp('the number of rows in matrix a is');f
disp('the number of columns in matrix a is');g
% to find rank of matrix a
h=rank(a);
disp('the rank of matrix a is');h
% to find transpose of matrix a
j=a';
disp('the transpose of matrix a is');j
% to find main diagnol elements of matrix a
k=diag(a);
disp('the main diagnol elements of matrix a is');k
% to find determinent of matrix a
m=det(a);
disp('the determinant of matrix a is');m
% to find inverse of matrix a
n=inv(a);
disp('the inverse of matrix a is');n
% to display 4x4 zeros matrix
o=zeros(4,4);
disp('the zeros matrix of size 4x4 s');o
% to display 4x4 ones matrix
p=ones(4,4);
disp('the oness matrix of size 4x4 s');p
% to display null matrix
q=[];
disp('the null matrix q is');q
RESULT:- Thus Matlab Program to perform some basic operations on matrices has been executed
successfully.
OUTPUT:-
The matrix a=
a=
1 2 -9
2 -1 2
3 -4 3
The matrix b=
b=
1 2 3
4 5 6
7 8 9
c=
2 4 -6
6 4 8
10 4 12
d=
0 0 -12
-2 -6 -4
-4 -12 -6
e=
f=
g=
h=
j=
1 2 3
2 -1 -4
-9 2 3
k=
1
-1
3
m=
50
n=
o=
0 0 0 0
0 0 0 0
0 0 0 0
0 0 0 0
p=
1 1 1 1
1 1 1 1
1 1 1 1
1 1 1 1
q=
[]
Experiment No-2a
AIM: -To write a“MATLAB” Program to generate of discrete time signals like
unit impulse, unit step, unit ramp, exponential signal and sinusoidal signals.
PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
clc;
clear all;
close all;
n=-10:1:10;
L=length(n);
for i=1:L
if n(i)==0
impulse(i)=1;
else
impulse(i)=0;
end;
if n(i)>=0
step(i)=1;
ramp(i)=n(i);
else
step(i)=0;
ramp(i)=0;
end;
end;
% to generate exponential sequence
a=0.85;
x4=a.^n;
% to generate sinusoidal sequence
f=0.1;
x5=sin(2*pi*f*n);
figure;
subplot(3,2,1);
stem(n,impulse);
xlabel('time n ---->');
ylabel('amplitude---->');
title('Unit impulse sequence');
subplot(3,2,2);
stem(n,step);xlabel('time n ---->');
ylabel('amplitude---->');
title('Unit step sequence')
subplot(3,2,3);
stem(n,ramp);
xlabel('time n ---->');
ylabel('amplitude---->');
title('Unit ramp signal');
subplot(3,2,4);
stem(n,x4);xlabel('time n ---->');
ylabel('amplitude---->');
title('exponential signal');
subplot(3,2,[5,6]);
stem(n,x5);
xlabel('time n ---->');
ylabel('amplitude---->');
title('sinusoidal signal');
RESULT:- Thus the Generation of discrete time signals like unit impulse, unit step,unit ramp,
exponential signaland sinusoidal signals has been executed successfully by using Matlab.
OUTPUT:-
Experiment No-2b
AIM: -To write a“MATLAB” Program to generate of continuous time signals like
unit step, sawtooth, triangular, Sinusoidal, ramp, and sinc function.
PROGRAM:-
clc;
clear all;
close all;
t=-10:0.01:10;
k=length(t);
for i=1:k
%to generate unit step and ramp function
if t(i)<0
step(i)=0;
ramp(i)=0;
else
step(i)=1;
ramp(i)=t(i);
end;
end;
%to generate sinusoidal function
f=0.1;
x=sin(2*pi*f*t);
%to generate triangular and sawtooth waveforms
y=sawtooth(t,0.5);
z=sawtooth(t);
plot(t,x);
xlabel('t--->');ylabel('amp--->');
title('sinusoidal');
subplot(2,3,4);
plot(t,y);
xlabel('t--->');ylabel('amp--->');
title('triangular');
subplot(2,3,5);
plot(t,z);
xlabel('t--->');ylabel('amp--->');
title('sawtooth');
subplot(2,3,6);
plot(t,x6);
xlabel('t--->');ylabel('amp--->');
title('sinc function');
RESULT:- Thus continuous time signals like unit step, sawtooth,triangular, sinusoidal, ramp and
sinc functionshas been executed successfully by using Matlab.
OUTPUT:-
Experiment No-03
PROGRAM:-
clc;
clear all;
close all;
% generating two input signals
t=0:.01:1;
x1=sin(2*pi*4*t);
x2=sin(2*pi*8*t);
subplot(2,2,1);
plot(t,x1);
xlabel('time');
ylabel('amplitude');
title('input signal 1');
subplot(2,2,2);
plot(t,x2);
xlabel('time');
ylabel('amplitude');
title('input signal 2');
% addition of signals
y1=x1+x2;
subplot(2,2,3);
plot(t,y1);
xlabel('time');
ylabel('amplitude');
title('addition of two signals');
% multiplication of signals
y2=x1.*x2;
subplot(2,2,4);
plot(t,y2);
xlabel('time');
ylabel('amplitude');
title('multiplication of two signals');
% scaling of a signal1
A=2;
y3=A*x1;
figure;
subplot(2,2,1);
plot(t,x1);
xlabel('time');
ylabel('amplitude');
title('input signal')
subplot(2,2,2);
plot(t,y3);
xlabel('time');
ylabel('amplitude');
title('amplified input signal');
% folding of a signal1
h=length(x1);
nx=0:h-1;
subplot(2,2,3);
plot(nx,x1);
xlabel('nx');
ylabel('amplitude');
title('input signal')
y4=fliplr(x1);
nf=-fliplr(nx);
subplot(2,2,4);
plot(nf,y4);
xlabel('nf');
ylabel('amplitude');
title('folded signal');
%shifting of a signal 1
figure;
subplot(3,1,1);
plot(t,x1);
xlabel('time t');
ylabel('amplitude');
title('input signal');
subplot(3,1,2);
plot(t+2,x1);
xlabel('t+2');
ylabel('amplitude');
title('right shifted signal');
subplot(3,1,3);
plot(t-2,x1);
xlabel('t-2');
ylabel('amplitude');
title('left shifted signal');
% program for energy of a sequence
z1=input('enter the input sequence');
e1=sum(abs(z1).^2);
disp('energy of given sequence is');e1
% program for power of a sequence
p1= (sum(abs(z1).^2))/length(z1);
disp('power of given sequence is');p1
RESULT: -Thus the MATLAB Program to perform operations onsignals has been executed
successfully.
OUTPUT:-
enter the input sequence[2 -1.1 3.4 5.5 7 8.9 -0.5 2.1 5.5]
energy of given sequence is
e1 = 210.1400
p1 = 23.3489
Experiment No-4
PROGRAM:-
clc;
clear all;
close all;
t=-5:0.001:5;
A=0.8;
x1=A.^(t);
x2=A.^(-t);
if(x2==x1)
disp('The given signal is even signal');
else
if(x2==(-x1))
disp('The given signal is odd signal');
else
disp('The given signal is neither even nor odd');
end
end
xe=(x1+x2)/2;
xo=(x1-x2)/2;
subplot(2,2,1);
plot(t,x1);
xlabel('t');ylabel('x(t)');title('signal x(t)');
subplot(2,2,2);
plot(t,x2);
xlabel('t');ylabel('x(t)');title('signal x(-t)');
subplot(2,2,3);
plot(t,xe);
xlabel('t');ylabel('x(t)');title('even part signal x(t)');
subplot(2,2,4);
plot(t,xo);
xlabel('t');ylabel('x(t)');title('odd part signal x(t)');
RESULT:- Thus the MATLAB Program to find even and odd parts of signals has been executed
successfully.
OUTPUT:-
The given signal is neither even nor odd
Experiment No-5
PROGRAM:-
clc;
clear all;
close all;
x=[1 -2 4 1.5 6 -0.5] ;
subplot(2,2,1);
stem(0:length(x)-1,x);
axis([0 8 -4 7]);
xlabel('time n ---->');
ylabel('amplitude---->');
title('the sequence y1[n]')
h=[-2 -2.5 3 4.5 1.5 5];
subplot(2,2,2);
stem(0:length(h)-1,h);
axis([0 8 -4 7]);
xlabel('time n ---->');
ylabel('amplitude---->');
title('the sequence y2[n]')
y=conv(x,h);
subplot(2,2,[3,4]);
stem(0:length(y)-1,y);
axis([0 15 -15 50]);
xlabel('time n ---->');
ylabel('amplitude---->');
title('the convolution sequence of x[n]&h[n]=');
RESULT:- Thus the MATLAB Program to find the convolution of two sequences has been
executed successfully.
OUTPUT:-
Experiment No-06
.PROCEDURE:
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:
plot(lag2,cxx);
grid;
title('cross-correlation function of sine wave');
OUTPUT:
Experiment No-7(a)
AIM: - To write a matlab program to verify the given system is linear or non-linear.
SOFTWARE REQURIED :-
MATLAB R2014a
PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
clc;
clear all;
close all;
n=0:10;
a1=input('enter the scaling factor a1=');
a2=input('enter the scaling factor a2=');
x1=cos(2*pi*0.1*n);
x2=cos(2*pi*0.4*n);
x3=a1*x1+a2*x2;
%y(n)=n.x(n);
y1=n.*x1;
y2=n.*x2;
y3=n.*x3;
yt=a1*y1+a2*y2;
yt=round(yt);
y3=round(y3);
if y3==yt
disp('given system [y(n)=n.x(n)]is Linear');
else
disp('given system [y(n)=n.x(n)]is non Linear');
end
%y(n)=x(n).^2
x1=[1 2 3 4 5];
x2=[1 4 7 6 4];
x3=a1*x1+a2*x2;
y1=x1.^2;
y2=x2.^2;
y3=x3.^2;
yt=a1*y1+a2*y2;
if y3==yt
disp('given system [y(n)=x(n).^2 ]is Linear');
else
disp('given system is [y(n)=x(n).^2 ]non Linear');
end
RESULT:- Thus the MATLAB Program to verify the system is linear ornon-linear has been
executed successfully.
OUTPUT:-
enter the scaling factor a1=2
enter the scaling factor a2=3
given system [y(n)=n.x(n)]is Linear
given system is [y(n)=x(n).^2 ]non Linear
Experiment No-07(b)
AIM: - To write a matlab program to verify the given system is Time –invariant
or Time–variant.
PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
RESULT:- Thus the MATLAB Program to verify the system is Time –invariant or Time–variant
systemhas been executed successfully..
OUTPUT:-
Experiment No-08
AIM: - To write a matlab program to compute the Unit sample, unit step and sinusoidal response of
the given LTI system and verifying its stability.
.PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
figure;
zplane(b,a);
[p z]=pzmap(b,a);
if max(abs(p))>=1
disp('the given system is not a stable system');
else
disp('the given system is a stable system');
end;
RESULT: -Thus Matlab program to compute the Unit sample, unit step and sinusoidal response of
the given LTI system and verifying its stability has been executed successfully.
OUTPUT:-
the given system is a stable system
Experiment No-9
GIBBS PHENOMENON
AIM: -To write a MATLAB program to construct the following periodic signal represented by its
FourierSeries by considering only 3,9,59 terms.
.PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
clc;
clear all;
close all;
N=input('enter the no. of signals to reconstruct=');
n_har=input('enter the no. of harmonics in each signal=');
t=-1:0.001:1;
omega_0=2*pi;
for k=1:N
x=0.5;
for n=1:2:n_har(k)
b_n=2/(n*pi);
x=x+b_n*sin(n*omega_0*t);
end
subplot(N,1,k);
plot(t,x);
xlabel('time--->');
ylabel('amp---->');
axis([-1 1 -0.5 1.5]);
text(0.55,1.0,['no.of har=',num2str(n_har(k))]);
end
RESULT:- In this experiment Gibbs phenomenons have been demonstrated using MATLAB.
OUTPUT:-
Experiment no-10
MAGNITUDE AND PHASE SPECTRUM OF FOURIER TRANSFORM
AIM: -.To find Fourier transform of the given signal and to plot its magnitudeand phase spectrum.
PROCEDURE:-
Open MATLAB
Open new M-file
Type the program
Save in current directory
Compile and Run the program
For the output see command window\ Figure window
PROGRAM:-
clc; clear all; close all;
syms t s ;
syms w float;
f=3*exp(-t)*heaviside(t); % given function
F=fourier(f); % to find Fourier Transform
disp('the fourier transform of 3*exp(-t)*u(t) =');
disp(F); % to display the result in the command window
w=-2*pi:pi/50:2*pi;
F1=subs(F,w); % substitute w in F function
Fmag=abs(F1); % to find magnitude
Fphas=angle(F1); % to find phase
subplot(2,1,1);
plot(w,Fmag);
xlabel('w ---->');
ylabel('Magnitude --->');
title('Magnitude spectrum');
grid;
subplot(2,1,2);
plot(w,Fphas);
xlabel('w ---->');
ylabel('Phase in radians--->');
title('Phase spectrum');
grid;
RESULT: -Thus MATLAB program to find Fourier transform and toplot its magnitude andPhase
spectrums has been executed successfully.
OUTPUT:-
the fourier transform of 3*exp(-t)*u(t) =
3/(w*i + 1)
Experiment no-11
LAPLACE TRANSFORM
AIM: -.MATLAB program to plot the given waveform using waveform synthesis method by
applying Laplace transform.
PROGRAM:-
clc;
close all;
syms s;
F =(1/(s^2))*(1-exp(-s)-(1/2)*exp(-3*s)+(1/2)*exp(-5*s));
f=ilaplace(F);
pretty(simplify(f))
ezplot(f,[0,5]);
grid;
RESULT: - Thus the MATLAB program to plot waveform using waveform synthesis method by
applying Laplace Transform has been executed successfully.
OUTPUT:-
heaviside(t - 3) (t - 3) heaviside(t - 5) (t - 5)
t - heaviside(t - 1) (t - 1) - ------------------------ + ------------------------
2 2
Experiment No-12(a)
PROGRAM:-
clc; clear all; close all;
num=input('enter the numerator polynomial vector\n'); % [1 -2 1]
den=input('enter the denominator polynomial vector\n'); % [1 6 11 6]
H=tf(num,den)
[p z]=pzmap(H);
disp('zeros are at ');
disp(z);
disp('poles are at ');
disp(p);
pzmap(H);
if max(real(p))>=0
disp(' All the poles do not lie in the left half of S-plane ');
disp(' the given LTI systen is not a stable system ');
else
disp('All the poles lie in the left half of S-plane ');
disp(' the given LTI systen is a stable system ');
end;
RESULTS: -Thusthe MATLAB programto draw pole-zero map in S-plane has been executed
successfully.
OUTPUT:-
H=
s^2 - 2 s + 1
----------------------
s^3 + 6 s^2 + 11 s + 6
zeros are at
1
1
poles are at
-3.0000
-2.0000
-1.0000
Experiment no-12(b)
PROGRAM:-
clc; clear all; close all;
num=input('enter the numerator polynomial vector \n'); %[1 0 0]
den=input('enter the denominator polynomial vector \n');%[1 1 0.16]
H=filt(num,den)
z=zero(H);
disp('the zeros are at ');
disp(z);
[r p k]=residuez(num,den);
disp('the poles are at ');
disp(p);
zplane(num,den);
title('Pole-Zero map in the Z-plane');
if max(abs(p))>=1
disp('all the poles do not lie with in the unit circle');
disp('hence the system is not stable');
else
disp('all the poles lie with in the unit circle');
disp('hence the system is stable');
end;
RESULTS: -Thus the MATLAB program to draw pole-zero map in z-plane has been executed
successfully.
OUTPUT:-
enter the numerator polynomial vector
[1 0 0]
enter the denominator polynomial vector
[1 1 0.16]
H=
1
--------------------
1 + z^-1 + 0.16 z^-2
Experiment no-13
GAUSSIAN NOISE
AIM: -.To generate a Gaussian noise and to compute its Mean, Mean Square Value, Skew, Kurtosis
and to plot Probability Density function.
SOFTWARE REQURIED :-
MATLAB R2014a
.
PROCEDURE:-
Open MATLAB Software
Open new M-file
Type the program
Save in current directory
Run the program
For the output see command window\ Figure window.
PROGRAM:-
clc; clear all; close all;
t=-10:0.01:10;
L=length(t);
n=randn(1,L);
subplot(2,1,1);
plot(t,n);
xlabel('t --->'),ylabel('amp ---->');
title('normal random function');
nmean=mean(n);
disp('mean=');disp(nmean);
nmeansquare=sum(n.^2)/length(n);
disp('mean square=');disp(nmeansquare);
nstd=std(n);
disp('std=');disp(nstd);
nvar=var(n);
disp('var=');disp(nvar);
nskew=skewness(n);
disp('skew=');disp(nskew);
nkurt=kurtosis(n);
disp('kurt=');disp(nkurt);
p=normpdf(n,nmean,nstd);
subplot(2,1,2);
stem(n,p)
title('Gaussian distribution function');
RESULTS: -Thus Matlab program to generate Gaussian noise and to compute its Mean, Mean
Square Value,Skew, Kurtosis and to plot its Probability density function has been executed
successfully.
OUTPUT:-
mean= -0.0146
std= 0.9932
var= 0.9865
skew= 0.0155
kurt= 3.0762
Experiment No-14
SAMPLING THEOREM
PROGRAM:-
clc;
close all;
clear all;
f1=3;
f2=20;
t=-0.4:0.0001:0.4;
x=cos(2*pi*f1*t)+cos(2*pi*f2*t);
figure(1);
plot(t,x,'-.r');
xlabel('time----->');
ylabel('amp--->');
title('The original signal');
%case 1: (fs<2fm)
fs1=1.4*f2;
ts1=1/fs1;
t1=-0.4:ts1:0.4;
xs1=cos(2*pi*f1*t1)+cos(2*pi*f2*t1);
figure(2);
plot(t1,xs1);
hold on;
plot(t,x,'-.r');
hold off;
legend('fs<2fm');
%case 2: (fs=2fm)
fs2=2*f2;
ts2=1/fs2;
t2=-0.4:ts2:0.4;
xs2=cos(2*pi*f1*t2)+cos(2*pi*f2*t2);
figure(3);
plot(t2,xs2);
hold on;
plot(t,x,'-.r');
hold off;
legend('fs=2fm');
%case 3: (fs>2fm)
fs3=8*f2;
ts3=1/fs3;
t3=-0.4:ts3:0.4;
xs3=cos(2*pi*f1*t3)+cos(2*pi*f2*t3);
figure(4);
plot(t3,xs3);
hold on;
plot(t,x,'-.r');
hold off;
legend('fs>2fm');
RESULTS:- Thus the MATLAB program to verify Sampling theorem has been executed
successfully.
OUTPUT: -
Experiment no-15
AIM: -.To write a MATLAB program to detect the periodic signal by masked byNoise using
Correlation method.
PROGRAM:-
clc;
clear all;
close all;
t=0:0.01:10;
s=cos(2*pi*3*t)+sin(2*pi*5*t); % periodic signal
figure;
subplot(2,1,1);
plot(t,s);
axis([0 10 -2 2]);
xlabel(' t ---->'),ylabel(' amp ----> ');
title('the periodic signal');
L=length(t);
n=randn(1,L); % noise signal
subplot(2,1,2);
plot(t,n);
xlabel(' t ---->'),ylabel(' amp ----> ');
title('the noise signal');
L=length(t);
f=s+n; % received signal
figure;
subplot(2,1,1);
plot(t,f);
xlabel(' t ---->'),ylabel(' amp ----> ');
title('the received signal');
rxx=xcorr(f,s,200);
subplot(2,1,2);
plot(rxx);
title('the Correlator output');
RESULTS: - Thus the MATLAB Program to detect the periodic signal masked by noise using
Auto Correlation and Cross Correlation method has been executed successfully.
OUTPUT
1.Define a signal.
A signal is defined as a single-valued function of one or more independent variables which contain
some information.
2.What is signal modeling?
The representation of a signal by mathematical expression is known as signal modeling.
3.What is one dimensional signal?
A signal which depends on only one independent variable is called a one dimensional signal.
4.What are the basic operations on signals?
The basic operations on signals are
Time shifting
Time reversal
Time scaling
Amplitude scaling
Signal addition
Signal multiplication
5.How are signals classified?
Signals are classified according to their characteristics. Some of them are:
Continuous- time and discrete-time signals
Deterministic and random signals
Periodic and aperiodic signals
Energy and power signals
Even and odd signals
Causal and non-causal signals
6.Distinguish between deterministic and random signals.
A deterministic signal is a signal exhibiting no uncertainty of its magnitude and phase at any given
instant of time. It can be represented by a mathematical equation. Whereas a random signal is a
signal characterized by uncertainty about its occurrence. It cannot be represented by a mathematical
equation.
7.Distinguish between energy and power signals.
An energy signal is one whose total energy E = finite value and whose average power P = 0,
whereas a power signal is the one whose average power P = finite value and total energy E = ∞.
8.Are all sinusoidal signals periodic?
In the case of continuous-time signals, all sinusoidal signals are periodic. But in the case of discrete-
time signals, not all sinusoidal signals are periodic.
9.What is the condition to be satisfied for a discrete-time sinusoidal sequence to be periodic?
For the discrete-time sinusoidal sequence to be periodic, the condition to be satisfied is,
the fundamental frequency ω must be rational multiple of 2π
10.What is an analog signal?
Continuous-time signals are also called analog signals.
11.What are digital signals?
The signals that are discrete in time and quantized in amplitude are called digital signal.
12. Distinguish between causal and non-causal signals.
A continuous-time signal is said to be causal, if x(t) = 0 for t < 0. Otherwise the signal is non-
causal.
A discrete-time signal is said to be causal, if x(n) =0 for n< 0, otherwise the signal is non-causal.
13.Do all the signals belong to either energy signal or power signal category?
No, some signals may not correspond to either energy signal type or power signal type. Such signals
are neither power signals nor energy signals.
14.Can every signal be decomposed into even or odd parts?
Yes, every signal can be decomposed into even and odd parts.
15. What are the different types of representing discrete-time signals?
There are four different types of representation of discrete-time signals. They are:
Graphical representation
Functional representation
Tabular representation
Sequence representation
16.Define System
A system is defined as a physical device that generates a response or output signal for agiven input
signal
17.How are systems classified?
Continuous-time and discrete-time systems
Lumped parameter and distributed parameter systems
Static and dynamic systems
Causal and non-causal systems
Time-invariant and time varying systems
Stable and unstable systems
Invertible and non-invertible system
18.Define Continuous Time system
A continuous time system is a system which transforms continuous-time input signals into
continuous-time output signals.
19. Define Discrete Time system
A discrete time system is a system which transforms discrete -time input signals into discrete -time
output signals.
20.Define Static System
A static or memory- less system is a system in which the response at any instant is due to present
input alone. i.e. for a static or memory-less system, the output at any instant t ( or n) depends only
on the input applied at that instant t ( or n) but not on the past or future values of input.
21.Define Dynamic System
A dynamic or memory system is a system in which the response at any instant depends upon past or
future inputs.
22.Define Unstable System
An unstable system is a system which produces an unbounded output for a bounded input.
23.Define Bounded Input Bounded Output Stable System
A bounded input-bounded output stable system is a system which produces a bounded input for
every bounded output.
24.Define Linear System
A linear system is a system which obeys the principle of superposition and principle of
homogeneity
25.Define Time-invariant System
A time - invariant (or shift-invariant) system is a system whose input / output characteristics do not
change with time, i.e. a system for which a time shift in the input results in a corresponding time
shift in the output.
26.Define Time-variant System
A time -variant (or shift-invariant) system is a system whose input / output characteristics change
with time, i.e. a system for which a time shift in the input does not result in a corresponding time
shift in the output.
27. Define Causal System
A causal (or non-anticipative) system is a system whose output at any time t depends onthe present
and past values of the input but not on the future inputs.42.
28.Define non-Causal System
A non-causal (anticipative) system is a system whose output at any time t depends on the future
inputs
29. What are the conditions for a system to be LTI system?
The conditions for a system to be LTI system are,
i) the system must possesses Linearity and
ii) time invariant property
Linearity:
An LTI system is a system that possesses the important property of superposition that is the output
of the system to a weighted sum of inputs is equal to the weighted sum of the outputs corresponding
to each of the individual inputs.
Time Invariant:
A system is said to be time-invariant if its input-output characteristics do not change with time.
30. What are the three important classes of transformation methods available for continuous-
time systems?
The three important classes of transformation methods available for continuous-time systems are:
Fourier series, Fourier transform, Laplace transform.
31. What is generalized Fourier series representation?
Representation of a function x(t) by a set of infinite mutually orthogonal functions is called
generalized Fourier series representation.
32. What are the three important classes of Fourier series available?
The three important classes of Fourier series methods available are
Trigonometric form
Cosine form
Exponential form
33. What is Fourier spectrum?
The Fourier spectrum of a periodic signal is a plot of its Fourier coefficients versus frequency ω. It
is in two parts: (a) the amplitude spectrum and (b) The phase spectrum. The plot of the amplitude of
Fourier coefficients versus frequency is known as the amplitude spectra, and the plot of the phase of
Fourier coefficients versus frequency is known as the phase spectra. The two plots together are
known as Fourier frequency of spectra of x(t).
34. What are the limitations of Fourier transform?
The limitations of the Fourier transform are as follows
There are many functions for which the Laplace transform exists, but the Fourier transform does not
exist.
It is less powerful than Laplace transform
35. What is the importance of impulse response?
The importance of impulse response of an LTI system is that, the characteristics of anLTI system
are completely characterized by its impulse response.
36. Define Impulse Response of a system
The impulse response of a system is defined as:
The output of the system when the input is applied as a unit impulse.Or
The inverse Laplace transform (or the inverse Fourier transform) of thetransfer function of the
system.
37. Define Transfer Function of a system
The ratio of the Laplace transform of the output variable to the Laplace transform ofthe input
variable
38. What is signal bandwidth?
The band of frequencies that contain most of the signal energy is known as the bandwidth of the
signal.
39. What is system bandwidth?
The bandwidth of a system is defined as the range of frequencies over which the magnitude |𝐻 (𝜔)|
remains within1⁄ times (within 3 dB) of its value at the mid-band
√2
40. What is meant by convolution?
Convolution is a mathematical operation which is used to express the input andoutput relationship
of an LTI system.
41. What is meant by correlation?
Correlation is an operation between signals and it gives us the degree of similarity between the two
signals. Correlation is of two types: cross correlation and autocorrelation. Cross correlation is a
measure of similarity between one signal and time delayed version of another signal.
Autocorrelation is a measure of similarity between a signal and time delayed version of same signal.
42. What are the two theorems of convolution associated with Fourier transform?
The two theorems of convolution associated with Fourier transform are
Time convolution theorem
Frequency convolution theorem
43. Define spectral Density
The Spectral Density is defined as the distribution of power or energy of a signal per unit bandwidth
as a function of frequency.
44. Define Normalized energy
The Normalized Energy of a signal is defined as the energy dissipated by a voltage signal applied
across 1Ω resistor ( or current flowing through a 1Ω resistor)..
45. Define Energy Spectral Density
Energy spectral density is defined as the distribution of energy of a signal in frequency domain.
46. What is meant by Power Spectral Density?
The distribution of average power of the signal in the frequency domain is called power spectral
density.
47. State Parseval’s power theorem.
The Parseval’s power theorem defines the power of a signal in terms of its Fourier
series coefficients. It states that the power of a signal is equal to the sum of square of the
magnitudes of various harmonics present in the discrete spectrum.
48. What is the relation between convolution and correlation?
The relation between convolution and correlation is that the cross correlation of x1(t) and x2(t)
is same as the convolution of x1(t) and x2(-t).
49. What is sampling?
Sampling is a process of converting a continuous-time signal into a discrete time signal.
50. What is sampling period?
The sampling period or sampling interval is the time interval between successive samples.
51. What is sampling frequency?
The sampling frequency is the reciprocal of sampling period. It indicates the number of samples per
second.
52. State sampling theorem.
A continuous time signal can be completely represented in its samples and recovered back if the
sampling frequency is twice of the highest frequency content of the signal .i.e., fs ≥2fm
53. What is aliasing?
Aliasing is defined as the phenomenon in which a high frequency component inthe frequency
spectrum of signal takes identity of a lower frequency component in thespectrum of the sampled
signal.
The impulse response is the inverse Fourier transform of the transfer function H(ω) in frequency
domain.
Or
The impulse response is the inverse Laplace transform of the transfer function in s-domain
65. What is the Conditions for a discrete-time LTI system to be causal?
A discrete-time LTI system with rational system function H(z) is causal if and only if the ROC is
the exterior of a circle outside the outermost pole
66. what is the Conditions for a discrete-time LTI system to be stable?
A discrete-time LTI system is stable if and only if the ROC of its system function H(z)includes the
unit circle |z|=1.
67. What are the methods used to find inverse z-transform?