You are on page 1of 46

clc;

clear all;
close all;
clf;

QUESTION 1&2

Classification of signal parameters

Rsym = 500; % symbol rate


Tsym = 1/Rsym; % symbol duration
Fs = 8*Rsym; % sampling frequency(let)
N = 100; % give an N value from {50,100,500} which is already g
N1 = 10000; % give an N value from {50,500,10000}
T0 = N1*Tsym;
time = (-50:50)/Fs; % time axis is taken as discrete with interval 1/Fs
fc = 2/Tsym;
t=1;
rect = zeros(1,length(time));
sinc0 = zeros(1,length(time)); % sinc0 means sinc(t/T)
sinc1 = zeros(1,length(time)); % sinc1 means sinc(3*t/T)
sinc2 = zeros(1,length(time)); % sinc2 means sinc(t/(4*T))
raisedCosine0 = zeros(1,length(time));% raisedCosine0 means roll-off factor = 0
raisedCosine1 = zeros(1,length(time)); % raisedCosine1 means roll-off factor = 0.5
raisedCosine2 = zeros(1,length(time));% raisedCosine2 means roll-off factor = 0.7

Generating the signalling pulse

for i=time
if i<-Tsym/2 || i>Tsym/2 % generate one rectangular pulse with
rect(t) = 0 ; % pulse width T/4
else
rect(t) = 1;
end
sinc0(t) = sinc(i/Tsym);
t=t+1;
end

t=1;
for i=time
sinc1(t) = sinc(3*i/Tsym);
t=t+1;
end

t=1;
for i=time
sinc2(t) = sinc(i/(4*Tsym));
t=t+1;
end

1
plotting of the pulse shaping signals

figure;
plot(time,rect,'r','Linewidth',2);hold on;
plot(time,sinc0,'g','Linewidth',2);hold on;
plot(time,sinc1,'b','Linewidth',2);hold on;
plot(time,sinc2,'y','Linewidth',2);hold on;
title('PULSE SHAPPING SIGNAL');
legend('RECT','SINCPULSE0','SINCPULSE1','SINCPULSE2');
xlabel('TIME');
ylabel('AMPLITUDE');

t=1;
alpha=0; %Roll Off Factor
for i=time + 10^-8
raisedCosine0(t) = sinc(i/Tsym).*cos(3.14*alpha*i/Tsym)/(1-(2*alpha*i/Tsym).^2);
t=t+1;
end

t=1;
alpha=0.5; %Roll Off Factor
for i=time + 10^-8
% if(i==T || i==-T)
% raisedCosinePulse1(t)=0;

2
% else
raisedCosine1(t) = sinc(i/Tsym).*(cos(3.14*alpha*i/Tsym)/(1-(2*alpha*i/Tsym).^2));
t=t+1;
% end
end
t=1;
alpha=0.7; %Roll Off Factor
for i=time + 10^-8
raisedCosine2(t) = sinc(i/Tsym).*cos(3.14*alpha*i/Tsym)/(1-(2*alpha*i/Tsym).^2);
t=t+1;
end
figure;
plot(time,raisedCosine0,'c','Linewidth',2);hold on;
plot(time,raisedCosine1,'m','Linewidth',2);hold on;
plot(time,raisedCosine2,'k','Linewidth',2);hold on;
title('PULSE SHAPING WITH RAISED COSINE SIGNAL ');
legend('with alpha = 0','with alpha = 0.5','with alpha = 0.7');
xlabel('TIME');
ylabel('AMPLITUDE');

generation of bits

SYMDURATION = ceil(Tsym*Fs);
disp("Bits")

3
Bits

bits = 2* [rand(1,N)>0.5] - 1 %generate random bits

bits = 1×100
1 1 1 1 1 1 1 1 -1 1 1 1 1

disp("Upsampled bits");

Upsampled bits

UPSAMPB = upsample(bits, SYMDURATION);

Linear modulation of the pulse shaping signals with the generated bits by
Convolution

pulshape_rect = conv(UPSAMPB, rect);


pulshape_Sinc0 = conv(UPSAMPB,sinc0);
pulshape_Sinc1 = conv(UPSAMPB,sinc1);
pulshape_Sinc2 = conv(UPSAMPB,sinc2);
pulshape_RC0 = conv(UPSAMPB,raisedCosine0);
pulshape_RC1 = conv(UPSAMPB,raisedCosine1);
pulshape_RC2 = conv(UPSAMPB,raisedCosine2);

plotting the linearly modulated waveforms in time domain


figure;
plot(pulshape_rect,'Linewidth',2);
grid on; title('LM with RECT PULSE SHAPPING')
xlabel('t');
ylabel('Amplitude');

4
figure;
plot(pulshape_Sinc0,'Linewidth',2);
grid on; title('LM with SINC0 PULSE SHAPING');
xlabel('t');
ylabel('Amplitude');

5
figure;
plot(pulshape_Sinc1,'Linewidth',2);
grid on; title('LM with SINC1 PULSE SHAPING');
xlabel('t');
ylabel('Amplitude');

6
figure;
plot(pulshape_Sinc2,'Linewidth',2);
grid on; title('LM with SINC2 PULSE SHAPING');
xlabel('t');
ylabel('Amplitude');

7
figure;
plot(pulshape_RC0,'Linewidth',2);
grid on; title('LM with RAISEDCOSINE0 PULSE SHAPING');
xlabel('t');
ylabel('Amplitude');

8
figure;
plot(pulshape_RC1,'Linewidth',2);
grid on; title('LM with RAISEDCOSINE1 PULSE SHAPING');
xlabel('t');
ylabel('Amplitude');

9
figure;
plot(pulshape_RC2,'Linewidth',2);
grid on; title('LM with RAISEDCOSINE2 PULSE SHAPPING');
xlabel('t');
ylabel('Amplitude');

10
plotting the spectra of pulse shaping signals

Ts=1/Fs;
L=length(sinc0);
df = 1 / (L * Ts);
f = [ -(ceil((L-1)/2):-1:1), 0, (1:floor((L-1)/2)) ] * df;
rectspectrum=(1/L)*fftshift (fft (rect));
sinc0spectrum=(1/L)*fftshift (fft (sinc0));
sinc1spectrum=(1/L)*fftshift (fft (sinc1));
sinc2spectrum=(1/L)*fftshift (fft (sinc2));

L=length(raisedCosine1);
df = 1 / (L * Ts);
f = [ -(ceil((L-1)/2):-1:1), 0, (1:floor((L-1)/2)) ] * df;
f1=f; %% related to the PSD of the LM pulse
RaisedCosine0spectrum=(1/L)*fftshift (fft (raisedCosine0));
RaisedCosine1spectrum=(1/L)*fftshift (fft (raisedCosine1));
RaisedCosine2spectrum=(1/L)*fftshift (fft (raisedCosine2));

figure;
plot(f,abs(rectspectrum),'r','Linewidth',2);hold on;
plot(f,abs(sinc0spectrum),'g','Linewidth',2);hold on;

11
plot(f,abs(sinc1spectrum),'b','Linewidth',2);hold on;
plot(f,abs(sinc2spectrum),'y','Linewidth',2);hold on;
title('SPECTRA OF PULSE SHAPPING SIGNALS');
xlabel('FREQUENCY F in Hz');
ylabel('MAGNITUDE');
legend('RECTPULSE','SINCPULSE0','SINCPULSE1','SINCPULSE2');

figure;
plot(f,abs(RaisedCosine0spectrum),'c','Linewidth',2);hold on;
plot(f,abs(RaisedCosine1spectrum),'m','Linewidth',2);hold on;
plot(f,abs(RaisedCosine2spectrum),'k','Linewidth',2);hold on;
title('SPECTRA OF RAISED COSINE SIGNALS');
xlabel('FREQUENCY F in Hz');
ylabel('MAGNITUDE');
legend('with alpha = 0','with alpha = 0.5','with alpha = 0.7');

12
plotting the spectra of linearly modulated signals

Ts=1/Fs;
M=length(pulshape_Sinc0);
df = 1 / (M * Ts);
f = [ -(ceil((M-1)/2):-1:1), 0, (1:floor((M-1)/2)) ] * df;
rectmodspectrum=(1/M)*fftshift (fft (pulshape_rect));
sinc0modspectrum=(1/M)*fftshift (fft (pulshape_Sinc0));
sinc1modspectrum=(1/M)*fftshift (fft (pulshape_Sinc1));
sinc2modspectrum=(1/M)*fftshift (fft (pulshape_Sinc2));
RC0modspectrum=(1/M)*fftshift (fft (pulshape_RC0));
RC1modspectrum=(1/M)*fftshift (fft (pulshape_RC1));
RC2modspectrum=(1/M)*fftshift (fft (pulshape_RC2));

figure;
plot(f,abs(rectmodspectrum),'r','Linewidth',2);hold on;
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH RECT');
xlabel('FREQUENCY F IN HZ');
ylabel('MAGNITUDE');

13
figure;
plot(f,abs(sinc0modspectrum),'g','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH SINC0');
xlabel('frequency f in Hz');
ylabel('MAGNITUDE');

14
figure;
plot(f,abs(sinc1modspectrum),'b','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH SINC1');
xlabel('FREQUENCY F IN HZ');
ylabel('MAGNITUDE');

15
figure;
plot(f,abs(sinc2modspectrum),'y','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH SINC2');
xlabel('FREQUENCY F IN HZ');
ylabel('MAGNITUDE');

16
QUESTION 3

OBSERVATION

The minimum bandwidth pulse is sinc 2. Here symbol duration is t/4T, therefore bandwidth reduces to
Expansion in time domain leads to compression in frequency domain

figure;
plot(f,abs(RC0modspectrum),'c','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH RAISED COSINE (ALPHA = 0)');
xlabel('FREQUENCY F IN HZ');
ylabel('MAGNITUDE');

17
figure;
plot(f,abs(RC1modspectrum),'m','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH RAISED COSINE (ALPHA = 0.5)');
xlabel('FREQUENCY F IN HZ');
ylabel('MAGNITUDE');

18
figure;
plot(f,abs(RC2modspectrum),'k','Linewidth',2);
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS WITH RAISED COSINE (ALPHA = 0.7)');
xlabel('FREQUENCY F in Hz');
ylabel('MAGNITUDE');

19
QUESTION 4:-

Sampling the recieved signal at kT+ offset & Plotting the Sampled signals
centeridx_sinc0 = 51;
centeridx_sinc1 = 51;
centeridx_sinc2 = 51;
centeridx_rect = 51;
centeridx_RC1 = 51;
centeridx_RC2 = 51;

offset = 4; % choose offset from {0,1,2,4} for 0,T/8,T/4,T/2 respectively as given in t

symdur=Tsym*Fs;

peakvalues_sinc0 = pulshape_Sinc0(centeridx_sinc0 + offset: symdur:end);


peakvalues_sinc1 = pulshape_Sinc1(centeridx_sinc1 + offset: symdur:end);
peakvalues_sinc2 = pulshape_Sinc2(centeridx_sinc2 + offset: symdur:end);
sampledvalues_sinc0 = peakvalues_sinc0(1:N);
sampledvalues_sinc1 = peakvalues_sinc1(1:N);
sampledvalues_sinc2 = peakvalues_sinc2(1:N);

peak_rect = pulshape_rect(centeridx_rect + offset: symdur:end);


sampled_rect = peak_rect(1:N);

peak_RC1 = pulshape_RC1(centeridx_RC1 + offset: symdur:end);


sampled_RC1 = peak_RC1(1:N);

20
peak_RC2 = pulshape_RC2(centeridx_RC2 + offset: symdur:end);
sampled_RC2 = peak_RC2(1:N);

figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampled_rect,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH RECT PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS', 'RXD SAMPLES');

figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampledvalues_sinc0,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH SINC0 PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS', 'RXD SAMPLES');

21
figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampledvalues_sinc1,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH SINC1 PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS', 'RXD SAMPLES');

22
figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampledvalues_sinc2,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH SINC2 PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS', 'RXD SAMPLES');

23
figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampled_RC1,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH (OFFSET = 0) RAISED COSINE(A = 0.5) PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS', 'RXD SAMPLES');

24
figure;
stem(bits,'b','Linewidth',2);hold on;
stem(sampled_RC2,'r','Linewidth',2);hold on;
title('SAMPLED SIGNAL WITH (OFFSET = 0) RAISED COSINE(A = 0.7) PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');
legend('TXD SYMBOLS','RXD SAMPLES');

25
OBSERVATIONS:-

It is observed that sinc is not the best pulse to use in practical scenarios where perfect sampling is not possible.

The 1 / t decay of sinc pulse can lead to unbounded ISI.

Pulses with faster decay of sidelobes are preferred.(SRRC- 1/t^3 decay)

Pulse x(t) is Nyquist at rate 1/T if and only if it satisfies Nyquist criteria for ISI avoidance. The minimum
bandwidth required is 1/T .

p(t) = sinc( t/2T) gives ISI even for zero offset as its value at t = T is non zero

QUESTION 5 :-
t=1;
Inphasecomp= zeros(1,length(time));
Quadraturecomp= zeros(1,length(time));
Passband= zeros(1,length(time));
sinc0 = zeros(1,length(time)); % sinc0 means sinc(t/T)

Generating signalling pulse


for i=time
sinc0(t) = sinc(i/Tsym); %generating sinc pulse
t=t+1;
end

26
% plotting pulse shaping signals
figure;

plot(time,sinc0,'b','Linewidth',2);hold on;
title('Sinc Pulse0');
xlabel('time');
ylabel('amplitude');

Generation of real and imaginary bits


symbol_duration = ceil(Tsym*Fs);
disp("Bits")

Bits

RealBits = 2* [rand(1,N)>0.5] - 1 %generate random real bits

RealBits = 1×100
1 1 -1 -1 -1 -1 1 -1 1 -1 1 1 1

ImgBits = 2* [rand(1,N)>0.5] - 1 %generate random imaginary bits

ImgBits = 1×100
1 -1 1 -1 -1 1 -1 1 1 1 1 -1 1

%disp("Upsampled bits");
RB = upsample(RealBits, symbol_duration);
IB = upsample(ImgBits, symbol_duration);

27
Linear modulation of Inphase and Quadrature Components
Inphasecomp= conv(RB,sinc0); % pulse shaping
Quadraturecomp= conv(IB,sinc0); % pulse shaping

plotting the linearly modulated waveforms in time domain using sinc0 pulse
figure;
plot(Inphasecomp,'r','Linewidth',2);
title('LM OF IN-PHASE COMPONENT WITH SINC0 PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');

figure;
plot(Quadraturecomp,'b','Linewidth',2);
title('LM OF QUADRATURE COMPONENT WITH SINC0 PULSE SHAPING');
xlabel('t');
ylabel('AMPLITUDE');

28
Upconverting from Baseband to Passband
t_up=1:length(Inphasecomp);
inphasecomp_up = 1.414*Inphasecomp.*cos(2*pi*fc*t_up/Fs);
quadcomp_up = -1.414*Quadraturecomp.*sin(2*pi*fc*t_up/Fs);
Passband = inphasecomp_up+quadcomp_up;

Plotting Up converted Inphase and Quadrature signals


figure;
plot(inphasecomp_up,'r','Linewidth',2);hold on;
title('UP CONVERTED IN-PHASE COMPONENT');
xlabel('t');
ylabel('AMPLITUDE');
legend('UPCONVERTED INPHASE')

29
figure;
plot(quadcomp_up,'b','Linewidth',2);hold on;
title('UP CONVERTED QUADRATURE COMPONENT');
xlabel('t');
ylabel('AMPLITUDE');
legend('UPCONVERTED QUADRATURE')

30
Plotting the Passband signal and Spectra of the Pulse happing Signal
figure;
plot(Passband,'y','Linewidth',2);hold on;
title('PASSBAND SIGNAl');
xlabel('t');
ylabel('AMPLITUDE');

31
%Plotting the spectra of pulse shaping signals
dt=1/Fs;
LN=length(sinc0);
df = 1 / (LN * dt);
f = [ -(ceil((LN-1)/2):-1:1), 0, (1:floor((LN-1)/2)) ] * df;
sinc0spectrum=(1/LN)*fftshift (fft (sinc0));
figure;
plot(f,abs(sinc0spectrum),'b','Linewidth',2);hold on;
title('SPECTRA OF THE PULSE SHAPING SIGNAL');
xlabel('FREQUENCY F in Hz');
ylabel('MAGNITUDE');

32
Downconversion of Passband signal and plotting of the downconverted
passband signal
theta1= pi/6; % given in the question (pi/6,pi/3,pi/2)
theta2= pi/3;
theta3= pi/2;
fpass = 1200;% let

Inphase_DC = lowpass(1.414*Passband.*cos(2*pi*fc*t_up/Fs + theta1),fpass,Fs);


Quadrature_DC = lowpass(1.414*Passband.*sin(2*pi*fc*t_up/Fs + theta1),fpass,Fs);
figure;
plot(Inphase_DC,'r','Linewidth',2);hold on;
title('IN-PHASE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/6');
xlabel('t');
ylabel('AMPLITUDE');

33
figure;
plot(Quadrature_DC,'b','Linewidth',2);hold on;
title('QUADRATURE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/6');
xlabel('t');
ylabel('AMPLITUDE');

34
Inphase_DC = lowpass(1.414*Passband.*cos(2*pi*fc*t_up/Fs + theta2),fpass,Fs);
Quadrature_DC = lowpass(1.414*Passband.*sin(2*pi*fc*t_up/Fs + theta2),fpass,Fs);
figure;
plot(Inphase_DC,'r','Linewidth',2);hold on;
title('IN-PHASE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/3');
xlabel('t');
ylabel('AMPLITUDE');

35
figure;
plot(Quadrature_DC,'b','Linewidth',2);hold on;
title('QUADRATURE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/3');
xlabel('t');
ylabel('AMPLITUDE');

36
Inphase_DC = lowpass(1.414*Passband.*cos(2*pi*fc*t_up/Fs + theta3),fpass,Fs);
Quadrature_DC = lowpass(1.414*Passband.*sin(2*pi*fc*t_up/Fs + theta3),fpass,Fs);
figure;
plot(Inphase_DC,'r','Linewidth',2);hold on;
title('IN-PHASE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/2');
xlabel('t');
ylabel('Amplitude');

37
figure;
plot(Quadrature_DC,'b','Linewidth',2);hold on;
title('QUADRATURE SIGNAL AFTER DOWNCONVERSION WITH THETA = PI/2');
xlabel('t');
ylabel('AMPLITUDE');

38
Plotting the spectra of Passband signal
dt=1/Fs;
K=length(Passband);
df = 1 / (K * dt);
f = [ -(ceil((K-1)/2):-1:1), 0, (1:floor((K-1)/2)) ] * df;

Passband_spectrum=(1/K)*fftshift (fft (Passband));

figure;
plot(f,abs(Passband_spectrum),'m','Linewidth',2);hold on;

title('SPECTRA OF THE PASSBAND SIGNAL');


xlabel('FREQUENCY F in Hz');
ylabel('MAGNITUDE');

39
OBSERVATION

Now instead of b[n] being real, consider that b[n] has both in-phase and quadrature components. Linear

modulation of in-phase and quadrature components with sinc pulse are shown above.

While down conversion, instead of using cos(2πf ct ) and sin(2πf ct ), we use cos(2πf ct + 0) and sin(2πf ct + 0)
is used,

then we cannot retrieve the correct signal

QUESTION 6 :-

Computation of the PSD of the LM waveform & verify that it is a scaled


version of the PSD of the pulse p(t):-
Ts=1/Fs;
M=length(pulshape_Sinc0);
df = 1 / (M * Ts);
f = [ -(ceil((M-1)/2):-1:1), 0, (1:floor((M-1)/2)) ] * df;
sinc0modspectrum=(1/M)*fftshift (fft (pulshape_Sinc0));
%%
figure;
plot(f,abs(sinc0modspectrum),'g','Linewidth',2);
title('Spectrum of the linearly modulated signal');
xlabel('frequency f in Hz');
ylabel('magnitude');

40
legend('Linear modulated');

Ssf = abs(sinc0modspectrum).^2./T0; %PSD of linearly modulated signal STo(t)


Psf = abs(sinc0spectrum).^2; %PSD of p(t) = sinc0
figure;
plot(f,Ssf,'g','Linewidth',2);hold on;
plot(f1,Psf,'r','Linewidth',2);hold on;
title('Power spectral density for N = 50,500,10000');
xlabel('frequency f in Hz');
ylabel('magnitude');
legend('Linear modulated','sinc');

41
OBSERVATION

Power spectral density (PSD) of sinc T/ t and the finite energy finite power linearly modulated waveform are

shown above. it is verified that the PSD of a linearly modulated signal scales as the magnitude

squared of the spectrum of the modulating pulse. So we can conclude that for uncorrelated symbols the shape

of a linearly modulated signal is determined by the spectrum of modulating pulse

QUESTION 7:-

Calculating and plotting Power spectral density for Bits Sequence without
any Randomness

symbol_duration = ceil(Tsym*Fs);
disp("Bits")

Bits

bits = ones(1,N); %generate deterministic bits


disp("Upsampled bits");

Upsampled bits

b = upsample(bits, symbol_duration);

42
%% Linear modulation
pul_shape_Sinc0 = conv(b,sinc0); % pulse shaping

%% plotting the spectra of pulse shaping signals


dt=1/Fs;
M=length(sinc0);
df = 1 / (M * dt);
f = [ -(ceil((M-1)/2):-1:1), 0, (1:floor((M-1)/2)) ] * df;
f1=f;
sinc0spectrum=(1/M)*fftshift (fft (sinc0));
%
figure;
plot(f,abs(sinc0spectrum),'r','Linewidth',2);hold on;
title('SPECTRA OF THE SINC0');
xlabel('frequency f in Hz');
ylabel('MAGNITUDE');

%% plotting the spectra of linearly modulated signals


dt=1/Fs;
K=length(pul_shape_Sinc0);
df = 1 / (K * dt);
f = [ -(ceil((K-1)/2):-1:1), 0, (1:floor((K-1)/2)) ] * df;
sinc0modspectrum=(1/K)*fftshift (fft (pul_shape_Sinc0));
figure;
plot(f,abs(sinc0modspectrum),'b','Linewidth',2);hold on;
title('SPECTRA OF THE LINEARLY MODULATED SIGNALS');
xlabel('frequency f in Hz');

43
ylabel('MAGNITUDE');

%legend('with rect','with Sinc0');

%%Calculating and plotting Power spectral density


t0 = N*Tsym;
Psf = abs(sinc0spectrum).^2;%PSD of p(t) = sinc0
Ssf = abs(sinc0modspectrum).^2./t0;%PSD of linearly modulated signal STo(t)

figure;
plot(f1,Psf,'r','Linewidth',2);hold on;
title('POWER SPECTRAL DENSITY OF SINC0');
xlabel('frequency f in Hz');
ylabel('MAGNITUDE');

44
figure;
plot(f,Ssf,'b','Linewidth',2);hold on;
title('POWER SPECTRAL DENSITY OF LINEAR MODULATED SIGNAL W/O RANDOMNESS FOR N = 10000')
xlabel('frequency f in Hz');
ylabel('MAGNITUDE');

45
OBSERVATION

Power spectral density (PSD) of the finite energy finite power linearly modulated waveform without randomness
is shown above. The time average of the PSD is not same as the PSD we found before with a random
sequence.

Here, with b[n] as a sequence of all ones, we obtained a delta function as the PSD i.e. the amplitude of DC
component is more than other frequencies in the linearly modulated waveform

46

You might also like