INDEX [shaikanwar.weebly.com]



CONTENTS

S.No Experiment Name Page No.

LIST OF EXPERIMENTS:

1. Basic operations on matrices. 1

2. Generation on various signals and Sequences 6

(periodic and aperiodic), such as unit impulse, unit step,

square, sawtooth, triangular, sinusoidal, ramp, sinc.

3. Operations on signals and sequences such as addition, 18

multiplication, scaling, shifting, folding, computation of

energy and average power.

4. Finding the even and odd parts of signal/sequence 22

and real and imaginary part of signal.

5. Convolution between signals and sequences. 26

6. Auto correlation and cross correlation between 29

signals and sequences.

7. Verification of linearity and time invariance 33

properties of a given continuous /discrete system.

8. Computation of unit sample, unit step and sinusoidal 40

response of the given LTI system and verifying its

physical Realizability and stability properties.

9. Gibbs phenomenon. 43

10. Finding the Fourier transform of a given

signal and plotting its magnitude and phase spectrum.

11. Waveform synthesis using Laplace Transform. 48

12. Locating the zeros and poles and plotting the

pole zero maps in s-plane and z-plane for the given 53

transfer function.

13. Generation of Gaussian Noise(real and complex), 54

computation of its mean, M.S. Value and its skew,

kurtosis, and PSD, probability distribution function.

14. Sampling theorem verification. 57

15. Removal of noise by auto correlation/cross correlation.

16. Extraction of periodic signal masked by noise 66

using correlation.

17. Verification of Weiner-Khinchine relations. 70

18. Checking a random process for stationarity in wide sense. 73

EXP.NO: 1

BASIC OPERATIONS ON MATRICES

Aim: To generate matrix and perform basic operation on matrices Using MATLAB Software.

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

MATLAB on Matrices

MATLAB treats all variables as matrices. For our purposes a matrix can be thought of as an array, in fact, that is how it is stored.

• Vectors are special forms of matrices and contain only one

row OR one column.

• Scalars are matrices with only one row AND one column.A matrix with only one row AND one column is a scalar. A scalar can be reated in MATLAB as follows:

» a_value=23

a_value =23

• A matrix with only one row is called a row vector. A row vector can be created in MATLAB as follows :

» rowvec = [12 , 14 , 63]

rowvec =

12 14 63

• A matrix with only one column is called a column vector. A column vector can be created in MATLAB as follows:

» colvec = [13 ; 45 ; -2]

colvec =

13

45

-2

• A matrix can be created in MATLAB as follows:

» matrix = [1 , 2 , 3 ; 4 , 5 ,6 ; 7 , 8 , 9]

matrix =

1 2 3

4 5 6

7 8 9

Extracting a Sub-Matrix

A portion of a matrix can be extracted and stored in a smaller matrix by specifying the names of both matrices and the rows and columns to extract. The syntax is:

sub_matrix = matrix ( r1 : r2 , c1 : c2 ) ;

Where r1 and r2 specify the beginning and ending rows and c1 and c2 specify the beginning and ending columns to be extracted to make the new matrix.

• A column vector can beextracted from a matrix.

• As an example we create a matrix below:

» matrix=[1,2,3;4,5,6;7,8,9]

matrix =

1 2 3

4 5 6

7 8 9

Here we extract column 2 of the matrix and make a column vector:

» col_two=matrix( : , 2)

col_two =

2 5 8

• A row vector can be extracted from a matrix.

As an example we create a matrix below:

» matrix=[1,2,3;4,5,6;7,8,9]

matrix =

1 2 3

4 5 6

7 8 9

• Here we extract row 2 of the matrix and make a row vector. Note that the 2:2 specifies the second row and the 1:3 specifies which columns of the row.

» rowvec=matrix(2 : 2 , 1 :3)

rowvec =4 5 6

» a=3;

» b=[1, 2, 3;4, 5, 6]

b =

1 2 3

4 5 6

» c= b+a % Add a to each element of b

c =

4 5 6

7 8 9

• Scalar - Matrix Subtraction

» a=3;

» b=[1, 2, 3;4, 5, 6]

b =

1 2 3

4 5 6

» c = b - a %Subtract a from each element of b

c =

-2 -1 0

1 2 3

• Scalar - Matrix Multiplication

» a=3;

» b=[1, 2, 3; 4, 5, 6]

b =

1 2 3

4 5 6

» c = a * b % Multiply each element of b by a

c =

3 6 9

12 15 18

• Scalar - Matrix Division

» a=3;

» b=[1, 2, 3; 4, 5, 6]

b =

1 2 3

4 5 6

» c = b / a % Divide each element of b by a

c =

0.3333 0.6667 1.0000

1.3333 1.6667 2.0000

a = [1 2 3 4 6 4 3 4 5]

a =

1 2 3 4 6 4 3 4 5

b = a + 2

b =

3 4 5 6 8 6 5 6 7

A = [1 2 0; 2 5 -1; 4 10 -1]

A =

1 2 0

2 5 -1

4 10 -1

B = A'

B =

1 2 4

2 5 10

0 -1 -1

C = A * B

C =

5 12 24

12 30 59

24 59 117

Instead of doing a matrix multiply, we can multiply the corresponding elements of two matrices or vectors using the .* operator.

C = A .* B

C =

1 4 0

4 25 -10

0 -10 1

Let's find the inverse of a matrix …

X = inv(A)

X =

5 2 -2

-2 -1 1

0 -2 1

and then illustrate the fact that a matrix times its inverse is the identity matrix.

I = inv(A) * A

I =

1 0 0

0 1 0

0 0 1

to obtain eigenvalues

eig(A)

ans =

3.7321

0.2679

1.0000

as the singular value decomposition.

svd(A)

ans =

12.3171

0.5149

0.1577

CONCLUSION: Inthis experiment basic operations on matrices Using MATLAB have been demonstrated.

[pic]

3.perform following operations on any two matrices

A+B

A-B

A*B

A.*B

A/B

A./B

A\B

A.\B

A^B,A.^B,A',A.

EXP.NO: 2

.

GENERATION ON VARIOUS SIGNALS AND SEQUENCES

(PERIODIC AND APERIODIC), SUCH AS UNIT IMPULSE, UNIT STEP, SQUARE, SAWTOOTH, TRIANGULAR, SINUSOIDAL, RAMP, SINC.

Aim: To generate different types of signals Using MATLAB Software.

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

THEORY :

UNIT IMPULSE: a) Continous signal:

And

[pic]

Also called unit impulse function. The value of delta function can also be defined in the sense of generalized function

[pic] ((t): Test Function

b) Unit Sample sequence: δ(n)={ 1, n=0

0, n≠0

i.e

[pic]

Matlab program:

%unit impulse generation

clc

close all

n1=-3;

n2=4;

n0=0;

n=[n1:n2];

x=[(n-n0)==0]

stem(n,x)

[pic]

d sxz2)Unit Step Function u(t):

[pic]

b)Unit Step Sequence u(n): )={ 1, n ≥ 0

0, n < 0

[pic]

% unit step generation

n1=-4;

n2=5;

n0=0;

[y,n]=stepseq(n0,n1,n2);

stem(n,y);

xlabel('n')

ylabel('amplitude');

title('unit step');

[pic]

Square waves: Like sine waves, square waves are described in terms of period, frequency and amplitude:

[pic]

Peak amplitude, Vp , and peak-to-peak amplitude, Vpp , are measured as you might expect. However, the rms amplitude, Vrms , is greater than that of a sine wave. Remember that the rms amplitude is the DC voltage which will deliver the same power as the signal. If a square wave supply is connected across a lamp, the current flows first one way and then the other. The current switches direction but its magnitude remains the same. In other words, the square wave delivers its maximum power throughout the cycle so that Vrms is equal to Vp . (If this is confusing, don't worry, the rms amplitude of a square wave is not something you need to think about very often.)

Although a square wave may change very rapidly from its minimum to maximum voltage, this change cannot be instaneous. The rise time of the signal is defined as the time taken for the voltage to change from 10% to 90% of its maximum value. Rise times are usually very short, with durations measured in nanoseconds (1 ns = 10-9 s), or microseconds (1 µs = 10-6 s), as indicated in the graph

% square wave wave generator

fs = 1000;

t = 0:1/fs:1.5;

x1 = sawtooth(2*pi*50*t);

x2 = square(2*pi*50*t);

subplot(2,2,1),plot(t,x1), axis([0 0.2 -1.2 1.2])

xlabel('Time (sec)');ylabel('Amplitude'); title('Sawtooth Periodic Wave')

subplot(2,2,2),plot(t,x2), axis([0 0.2 -1.2 1.2])

xlabel('Time (sec)');ylabel('Amplitude'); title('Square Periodic Wave');

subplot(2,2,3),stem(t,x2), axis([0 0.1 -1.2 1.2])

xlabel('Time (sec)');ylabel('Amplitude');

[pic]

SAW TOOTH:

The sawtooth wave (or saw wave) is a kind of non-sinusoidal waveform. It is named a sawtooth based on its resemblance to the teeth on the blade of a saw. The convention is that a sawtooth wave ramps upward and then sharply drops. However, there are also sawtooth waves in which the wave ramps downward and then sharply rises. The latter type of sawtooth wave is called a 'reverse sawtooth wave' or 'inverse sawtooth wave'. As audio signals, the two orientations of sawtooth wave sound identical. The piecewise linear function based on the floor function of time t, is an example of a sawtooth wave with period 1.

[pic]

A more general form, in the range −1 to 1, and with period a, is

This sawtooth function has the same phase as the sine function. A sawtooth wave's sound is harsh and clear and its spectrum contains both even and odd harmonics of the fundamental frequency. Because it contains all the integer harmonics, it is one of the best waveforms to use for synthesizing musical sounds, particularly bowed string instruments like violins and cellos, using subtractive synthesis.

Applications

The sawtooth and square waves are the most common starting points used to create sounds with subtractive analog and virtual analog music synthesizers.

The sawtooth wave is the form of the vertical and horizontal deflection signals used to generate a raster on CRT-based television or monitor screens. Oscilloscopes also use a sawtooth wave for their horizontal deflection, though they typically use electrostatic deflection.

On the wave's "ramp", the magnetic field produced by the deflection yoke drags the electron beam across the face of the CRT, creating a scan line.

On the wave's "cliff", the magnetic field suddenly collapses, causing the electron beam to return to its resting position as quickly as possible.

The voltage applied to the deflection yoke is adjusted by various means (transformers, capacitors, center-tapped windings) so that the half-way voltage on the sawtooth's cliff is at the zero mark, meaning that a negative voltage will cause deflection in one direction, and a positive voltage deflection in the other; thus, a center-mounted deflection yoke can use the whole screen area to depict a trace. Frequency is 15.734 kHz on NTSC, 15.625 kHz for PAL and SECAM)

[pic]

% sawtooth wave generator

fs = 10000;

t = 0:1/fs:1.5;

x = sawtooth(2*pi*50*t);

subplot(1,2,1);

plot(t,x), axis([0 0.2 -1 1]);

xlabel('t'),ylabel('x(t)')

title('sawtooth signal');

N=2; fs = 500;n = 0:1/fs:2;

x = sawtooth(2*pi*50*n);

subplot(1,2,2);

stem(n,x), axis([0 0.2 -1 1]);

xlabel('n'),ylabel('x(n)')

title('sawtooth sequence');

[pic]

Triangle wave

A triangle wave is a non-sinusoidal waveform named for its triangular shape.A bandlimited triangle wave pictured in the time domain (top) and frequency domain (bottom). The fundamental is at 220 Hz (A2).Like a square wave, the triangle wave contains only odd harmonics. However, the higher harmonics roll off much faster than in a square wave (proportional to the inverse square of the harmonic number as opposed to just the inverse).It is possible to approximate a triangle wave with additive synthesis by adding odd harmonics of the fundamental, multiplying every (4n−1)th harmonic by −1 (or changing its phase by π), and rolling off the harmonics by the inverse square of their relative frequency to the fundamental.This infinite Fourier series converges to the triangle wave:

[pic]

[pic]

[pic]

To generate a trianguular pulse

A=2; t = 0:0.0005:1;

x=A*sawtooth(2*pi*5*t,0.25); %5 Hertz wave with duty cycle 25%

plot(t,x);

grid

axis([0 1 -3 3]);

[pic]

%%To generate a trianguular pulse

fs = 10000;t = -1:1/fs:1;

x1 = tripuls(t,20e-3); x2 = rectpuls(t,20e-3);

subplot(211),plot(t,x1), axis([-0.1 0.1 -0.2 1.2])

xlabel('Time (sec)');ylabel('Amplitude'); title('Triangular Aperiodic Pulse')

subplot(212),plot(t,x2), axis([-0.1 0.1 -0.2 1.2])

xlabel('Time (sec)');ylabel('Amplitude'); title('Rectangular Aperiodic Pulse')

set(gcf,'Color',[1 1 1]),

[pic]

%%To generate a rectangular pulse

t=-5:0.01:5;

pulse = rectpuls(t,2); %pulse of width 2 time units

plot(t,pulse)

axis([-5 5 -1 2]);

grid

[pic]

Sinusoidal Signal Generation

The sine wave or sinusoid is a mathematical function that describes a smooth repetitive oscillation. It occurs often in pure mathematics, as well as physics, signal processing, electrical engineering and many other fields. Its most basic form as a function of time (t) is:

where:

• A, the amplitude, is the peak deviation of the function from its center position.

• ω, the angular frequency, specifies how many oscillations occur in a unit time interval, in radians per second

• φ, the phase, specifies where in its cycle the oscillation begins at t = 0.

A sampled sinusoid may be written as:

[pic]

where f is the signal frequency, fs is the sampling frequency, θ is the phase and A is the amplitude of the signal. The program and its output is shown below:

Note that there are 64 samples with sampling frequency of 8000Hz or sampling time

of 0.125 mS (i.e. 1/8000). Hence the record length of the signal is 64x0.125=8mS.

There are exactly 8 cycles of sinewave, indicating that the period of one cycle is 1mS

which means that the signal frequency is 1KHz.

[pic]

% sinusoidal signal

N=64; % Define Number of samples

n=0:N-1; % Define vector n=0,1,2,3,...62,63

f=1000; % Define the frequency

fs=8000; % Define the sampling frequency

x=sin(2*pi*(f/fs)*n); % Generate x(t)

plot(n,x); % Plot x(t) vs. t

title('Sinewave [f=1KHz, fs=8KHz]');

xlabel('Sample Number');

ylabel('Amplitude');

[pic]

% RAMP

clc

close all

n=input('enter the length of ramp');

t=0:n;

plot(t);

xlabel('t');

ylabel('amplitude');

title ('ramp')

1

[pic]

SINC FUNCTION:

The sinc function computes the mathematical sinc function for an input vector or matrix x. Viewed as a function of time, or space, the sinc function is the inverse Fourier transform of the rectangular pulse in frequency centered at zero of width 2π and height 1. The following equation defines the sinc function:

[pic]

The sinc function has a value of 1 whenx is equal to zero, and a value of[pic]

[pic]

% sinc

x = linspace(-5,5);

y = sinc(x);

subplot(1,2,1);plot(x,y)

xlabel(‘time’);

ylabel(‘amplitude’);

title(‘sinc function’);

subplot(1,2,2);stem(x,y);

xlabel(‘time’);

ylabel(‘amplitude’);

title(‘sinc function’);

[pic]

CONCLUSION: In this experiment various signals have been generated Using MATLAB

Exersize questions:generate following signals using MATLAB

1.x(t)=e-t

2.x(t)= t 2 / 2

3.generate rectangular pulse function

4.generate signum sunction sinc(t)= 1 t > 0

0 t=0

-1 t x')

ylabel('--> pdf')

figure(2)

plot(x,cum_Px);grid

axis([-3 3 0 1]);

title(['Gaussian Probability Distribution Function for mu_x=0 and sigma_x=', num2str(sig_x)]);

title('\ite^{\omega\tau} = cos(\omega\tau) + isin(\omega\tau)')

xlabel('--> x')

ylabel('--> PDF')

[pic]

[pic]

EXP.NO: 14

14. Sampling theorem verification

Aim: To detect the edge for single observed image using sobel edge detection and canny edge detection.

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

Sampling Theorem:

\A bandlimited signal can be reconstructed exactly if it is sampled at a rate atleast twice the maximum frequency component in it." Figure 1 shows a signal g(t) that is bandlimited.

[pic]

Figure 1: Spectrum of bandlimited signal g(t)

The maximum frequency component of g(t) is fm. To recover the signal g(t) exactly from its samples it has to be sampled at a rate fs ≥ 2fm.

The minimum required sampling rate fs = 2fm is called ' Nyquist rate

Proof: Let g(t) be a bandlimited signal whose bandwidth is fm

(wm = 2πfm).

[pic]

Figure 2: (a) Original signal g(t) (b) Spectrum G(w)

δ (t) is the sampling signal with fs = 1/T > 2fm.

[pic]Figure 3: (a) sampling signal δ (t) ) (b) Spectrum δ (w)

Let gs(t) be the sampled signal. Its Fourier Transform Gs(w) isgiven by

[pic]

[pic]

Figure 4: (a) sampled signal gs(t) (b) Spectrum Gs(w)

[pic]

To recover the original signal G(w):

1. Filter with a Gate function, H2wm(w) of width 2wm

Scale it by T.

[pic]

[pic]

Figure 5: Recovery of signal by filtering with a fiter of width 2wm

Aliasing

{ Aliasing is a phenomenon where the high frequency components of the sampled signal interfere with each other because of inadequate sampling ws < 2wm.

[pic]

Figure 6: Aliasing due to inadequate sampling

Aliasing leads to distortion in recovered signal. This is the

reason why sampling frequency should be atleast twice thebandwidth of the signal.

Oversampling

{ In practice signal are oversampled, where fs is signi_cantly

higher than Nyquist rate to avoid aliasing.

[pic]

Figure 7: Oversampled signal-avoids aliasing

t=-10:.01:10;

T=4;

fm=1/T;

x=cos(2*pi*fm*t);

subplot(2,2,1);

plot(t,x);

xlabel('time');ylabel('x(t)')

title('continous time signal')

grid;

n1=-4:1:4

fs1=1.6*fm;

fs2=2*fm;

fs3=8*fm;

x1=cos(2*pi*fm/fs1*n1);

subplot(2,2,2);

stem(n1,x1);

xlabel('time');ylabel('x(n)')

title('discrete time signal with fs2fm')

hold on

subplot(2,2,4);

plot(n3,x3)

grid;

[pic]

CONCLUSION: In this experiment the sampling theorem have been verified

using MATLAB

EXP.No:15

REMOVAL OF NOISE BY AUTO CORRELATION/CROSS CORRELATION

Aim: removal of noise by auto correlation/cross correlation

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

Detection of a periodic signal masked by random noise is of greate importance .The noise signal encountered in practice is a signal with random amplitude variations. A signal is uncorrelated with any periodic signal. If s(t) is a periodic signal and n(t) is a noise signal then

T/2

Lim 1/T ∫ S(t)n(t-T) dt=0 for all T

T--∞ -T/2

Qsn(T)= cross correlation function of s(t) and n(t) Then Qsn(T)=0

Detection by Auto-Correlation:

S(t)=Periodic Signal mixed with a noise signal n(t).Then f(t) is [s(t ) + n(t) ]

Let Qff(T) =Auto Correlation Function of f(t)

Qss(t) = Auto Correlation Function of S(t)

Qnn(T) = Auto Correlation Function of n(t)

T/2

Qff(T)= Lim 1/T ∫ f(t)f(t-T) dt

T--∞ -T/2

T/2

= Lim 1/T ∫ [s(t)+n(t)][s(t-T)+n(t-T)] dt

T--∞ -T/2

=Qss(T)+Qnn(T)+Qsn(T)+Qns(T)

The periodic signal s(t) and noise signal n(t) are uncorrelated

Qsn(t)=Qns(t)=0 ;Then Qff(t)=Qss(t)+Qnn(t)

The Auto correlation function of a periodic signal is periodic of the same frequency and the Auto correlation function of a non periodic signal is tends to zero for large value of T since s(t) is a periodic signal and n(t) is non periodic signal so Qss(T) is a periodic where as aQnn(T) becomes small for large values of T Therefore for sufficiently large values of T Qff(T) is equal to Qss(T).

Detection by Cross Correlation:

f(t)=s(t)+n(t)

c(t)=Locally generated signal with same frequencyas that of S(t)

T/2

Qfc (t) = Lim 1/T ∫ [s(t)+n(t)] [ c(t-T)] dt

T--∞ -T/2

= Qsc(T)+Qnc(T)

C(t) is periodic function and uncorrelated with the random noise signal n(t). Hence Qnc(T0=0) Therefore Qfc(T)=Qsc(T)

a)auto correlation

clear all

clc

t=0:0.1:pi*4;

s=sin(t);

k=2;

subplot(6,1,1)

plot(s);

title('signal s');

xlabel('t');

ylabel('amplitude');

n = randn([1 126]);

f=s+n;

subplot(6,1,2)

plot(f);

title('signal f=s+n');

xlabel('t');

ylabel('amplitude');

as=xcorr(s,s);

subplot(6,1,3)

plot(as);

title('auto correlation of s');

xlabel('t');

ylabel('amplitude');

an=xcorr(n,n);

subplot(6,1,4)

plot(an);

title('auto correlation of n');

xlabel('t');

ylabel('amplitude');

cff=xcorr(f,f);

subplot(6,1,5)

plot(cff);

title('auto correlation of f');

xlabel('t');

ylabel('amplitude');

hh=as+an;

subplot(6,1,6)

plot(hh);

title('addition of as+an');

xlabel('t');

ylabel('amplitude');

[pic]

B)CROSS CORRELATION :

clear all

clc

t=0:0.1:pi*4;

s=sin(t);

k=2;

%sk=sin(t+k);

subplot(7,1,1)

plot(s);

title('signal s');xlabel('t');ylabel('amplitude');

c=cos(t);

subplot(7,1,2)

plot(c);

title('signal c');xlabel('t');ylabel('amplitude');

n = randn([1 126]);

f=s+n;

subplot(7,1,3)

plot(f);

title('signal f=s+n');xlabel('t');ylabel('amplitude');

asc=xcorr(s,c);

subplot(7,1,4)

plot(asc);

title('auto correlation of s and c');xlabel('t');ylabel('amplitude');

anc=xcorr(n,c);

subplot(7,1,5)

plot(anc);

title('auto correlation of n and c');xlabel('t');ylabel('amplitude');

cfc=xcorr(f,c);

subplot(7,1,6)

plot(cfc);

title('auto correlation of f and c');xlabel('t');ylabel('amplitude');

hh=asc+anc;

subplot(7,1,7)

plot(hh);

title('addition of asc+anc');xlabel('t');ylabel('amplitude');

[pic]

CONCLUSION: in this experiment the removal of noise by auto correlation/cross correlation have been verified using MATLAB

EXP.No:16

EXTRACTION OF PERIODIC SIGNAL MASKED BY NOISE USING CORRELATION

Extraction Of Periodic Signal Masked By Noise Using Correlation

clear all;

close all;

clc;

n=256;

k1=0:n-1;

x=cos(32*pi*k1/n)+sin(48*pi*k1/n);

plot(k1,x)

%Module to find period of input signl

k=2;

xm=zeros(k,1);

ym=zeros(k,1);

hold on

for i=1:k

[xm(i) ym(i)]=ginput(1);

plot(xm(i), ym(i),'r*');

end

period=abs(xm(2)-xm(1));

rounded_p=round(period);

m=rounded_p

% Adding noise and plotting noisy signal

y=x+randn(1,n);

figure

plot(k1,y)

% To generate impulse train with the period as that of input signal

d=zeros(1,n);

for i=1:n

if (rem(i-1,m)==0)

d(i)=1;

end

end

%Correlating noisy signal and impulse train

cir=cxcorr1(y,d);

%plotting the original and reconstructed signal

m1=0:n/4;

figure

plot(m1,x(m1+1),'r',m1,m*cir(m1+1));

[pic]

[pic]

Application

The theorem is useful for analyzing linear time-invariant systems, LTI systems, when the inputs and outputs are not square integrable, so their Fourier transforms do not exist. A corollary is that the Fourier transform of the autocorrelation function of the output of an LTI system is equal to the product of the Fourier transform of the autocorrelation function of the input of the system times the squared magnitude of the Fourier transform of the system impulse response. This works even when the Fourier transforms of the input and output signals do not exist because these signals are not square integrable, so the system inputs and outputs cannot be directly related by the Fourier transform of the impulse response. Since the Fourier transform of the autocorrelation function of a signal is the power spectrum of the signal, this corollary is equivalent to saying that the power spectrum of the output is equal to the power spectrum of the input times the power transfer function.

This corollary is used in the parametric method for power spectrum estimation.

CONCLUSION: In this experiment the Weiner-Khinchine Relation have been verified using MATLAB

EXP.No:17

VERIFICATION OF WIENER–KHINCHIN RELATION

AIM: verification of wiener–khinchin relation

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

The Wiener–Khinchin theorem (also known as the Wiener–Khintchine theorem and sometimes as the Wiener–Khinchin–Einstein theorem or the Khinchin–Kolmogorov theorem) states that the power spectral density of a wide-sense-stationary random process is the Fourier transform of the corresponding autocorrelation function.[1][2][3]

Continuous case:

[pic]

Where

[pic]

is the autocorrelation function defined in terms of statistical expectation, and where is the power spectral density of the function . Note that the autocorrelation function is defined in terms of the expected value of a product, and that the Fourier transform of does not exist in general, because stationary random functions are not square integrable.

The asterisk denotes complex conjugate, and can be omitted if the random process is real-valued.

Discrete case:

[pic]

Where

[pic]

and where is the power spectral density of the function with discrete values . Being a sampled and discrete-time sequence, the spectral density is periodic in the frequency domain.

PROGRAM:

clc

clear all;

t=0:0.1:2*pi;

x=sin(2*t);

subplot(3,2,1);

plot(x);

au=xcorr(x,x);

subplot(3,2,2);

plot(au);

v=fft(au);

subplot(3,2,3);

plot(abs(v));

fw=fft(x);

subplot(3,2,4);

plot(fw);

fw2=(abs(fw)).^2;

subplot(3,2,5);

plot(fw2);

[pic]

EXP18.

CHECKING A RANDOM PROCESS FOR STATIONARITY IN WIDE SENSE.

AIM:Checking a random process for stationarity in wide sense.

EQUIPMENTS:

PC with windows (95/98/XP/NT/2000).

MATLAB Software

Theory:

| a stationary process (or strict(ly) stationary process or strong(ly) stationary process) is a stochastic process whose joint |

|probability distribution does not change when shifted in time or space. As a result, parameters such as the mean and variance, if |

|they exist, also do not change over time or position.. |

Definition

Formally, let Xt be a stochastic process and let[pic] represent the cumulative distribution function of the joint distribution of Xt at times t1…..tk. Then, Xt is said to be stationary if, for all k, for all τ, and for all t1…..tk

[pic]

Weak or wide-sense stationarity

A weaker form of stationarity commonly employed in signal processing is known as weak-sense stationarity, wide-sense stationarity (WSS) or covariance stationarity. WSS random processes only require that 1st and 2nd moments do not vary with respect to time. Any strictly stationary process which has a mean and a covariance is also WSS.

So, a continuous-time random process x(t) which is WSS has the following restrictions on its mean function

[pic]

and autocorrelation function

[pic]

The first property implies that the mean function mx(t) must be constant. The second property implies that the correlation function depends only on the difference between t1 and t2 and only needs to be indexed by one variable rather than two variables. Thus, instead of writing,

[pic]

we usually abbreviate the notation and write

[pic]

This also implies that the autocovariance depends only on τ = t1 − t2, since

[pic]

When processing WSS random signals with linear, time-invariant (LTI) filters, it is helpful to think of the correlation function as a linear operator. Since it is a circulant operator (depends only on the difference between the two arguments), its eigenfunctions are the Fourier complex exponentials. Additionally, since the eigenfunctions of LTI operators are also complex exponentials, LTI processing of WSS random signals is highly tractable—all computations can be performed in the frequency domain. Thus, the WSS assumption is widely employed in signal processing algorithms.

Applicatons: Stationarity is used as a tool in time series analysis, where the raw data are often transformed to become stationary, for example, economic data are often seasonal and/or dependent on the price level. Processes are described as trend stationary if they are a linear combination of a stationary process and one or more processes exhibiting a trend. Transforming these data to leave a stationary data set for analysis is referred to as de-trending

Stationary and Non Stationary Random Process:

A random X(t) is stationary if its statistical properties are unchanged by a time shift in the time origin.When the auto-Correlation function Rx(t,t+T) of the random X(t) varies with time difference T and the mean value of the random variable X(t1) is independent of the choice of t1,then X(t) is said to be stationary in the wide-sense or wide-sense stationary . So a continous- Time random process X(t) which is WSS has the following properties

1) E[X(t)]=μX(t)= μX(t+T)

2) The Autocorrelation function is written as a function of T that is

3) RX(t,t+T)=Rx(T)

If the statistical properties like mean value or moments depends on time then the random process is said to be non-stationary.

When dealing wih two random process X(t) and Y(t), we say that they are jointly wide-sense stationary if each pocess is stationary in the wide-sense.

Rxy(t,t+T)=E[X(t)Y(t+T)]=Rxy(T).

MATLAB PROGRAM:

clear all

clc

y = randn([1 40])

my=round(mean(y));

z=randn([1 40])

mz=round(mean(z));

vy=round(var(y));

vz=round(var(z));

t = sym('t','real');

h0=3;

x=y.*sin(h0*t)+z.*cos(h0*t);

mx=round(mean(x));

k=2;

xk=y.*sin(h0*(t+k))+z.*cos(h0*(t+k));

x1=sin(h0*t)*sin(h0*(t+k));

x2=cos(h0*t)*cos(h0*(t+k));

c=vy*x1+vz*x1;

%if we solve "c=2*sin(3*t)*sin(3*t+6)" we get c=2cos(6)

%which is a costant does not depent on variable 't'

% so it is wide sence stationary

1. Define Signal

2. Define determistic and Random Signal

3. Define Delta Function

4. What is Signal Modeling

5. Define Periodic and a periodic Signal

6. Define Symetric and Anti-Symmetric Signals

7. Define Continuous and Discrete Time Signals

8. What are the Different types of representation of discrete time signals

9. What are the Different types of Operation performed on signals

10. What is System

11. What is Causal Signal

12. What are the Different types of Systems

13. What is Linear System

14. What is Time Invariant System

15. What is Static and Dynamic System

16. What is Even Signal

17. What is Odd Signal

18. Define the Properties of Impulse Signal

19. What is Causality Condition of the Signal

20. What is Condition for System Stability

21. Define Convolution

22. Define Properties of Convolution

23. What is the Sufficient condition for the existence of F.T

24. Define the F.T of a signal

25. State Paeseval’s energy theorem for a periodic signal

26. Define sampling Theorem

27. What is Aliasing Effect

28. what is Under sampling

29. What is Over sampling

30. Define Correlation

31. Define Auto-Correlation

32. Define Cross-Correlation

33. Define Convolution

34. Define Properties of Convolution

35. What is the Difference Between Convolution& Correlation

36. What are Dirchlet Condition

37. Define Fourier Series

38. What is Half Wave Symmetry

39. What are the properties of Continuous-Time Fourier Series

40. Define Laplace-Transform

41. What is the Condition for Convergence of the L.T

42. What is the Region of Convergence(ROC)

43. State the Shifting property of L.T

44. State convolution Property of L.T

45. Define Transfer Function

46. Define Pole-Zeros of the Transfer Function

47. What is the Relationship between L.T & F.T &Z.T

48. Fined the Z.T of a Impulse and step

49. What are the Different Methods of evaluating inverse z-T

50. Explain Time-Shifting property of a Z.T

51. what are the ROC properties of a Z.T

52. Define Initial Value Theorem of a Z.T

53. Define Final Value Theorem of a Z.T

54. Define Sampling Theorem

55. Define Nyquist Rate

56. Define Energy of a Signal

57. Define Power of a signal

58. Define Gibbs Phenomena

59. Define the condition for distortionless transmission through the system

60. What is signal band width

61. What is system band width

62. What is Paley-Winer criterion?

63. Derive relationship between rise time and band width

64.

-----------------------

[pic]

[pic]

[pic]

[pic]

[pic]

[pic]

................
................

In order to avoid copyright disputes, this page is only a partial summary.

Google Online Preview   Download