0% found this document useful (0 votes)
137 views21 pages

ICT 306 Lab Reports

Experiment 03 calculates parameters for step index fibers using MATLAB, including: 1) Numerical aperture (NA) 2) Acceptance angle (θa) 3) Solid acceptance angle (Ω) 4) Propagation constant (β) The MATLAB code takes inputs like core and cladding indices, wavelength, and calculates the above parameters using formulas based on those inputs and predefined boundary limits. Plots and important values are displayed.

Uploaded by

Rana
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)
137 views21 pages

ICT 306 Lab Reports

Experiment 03 calculates parameters for step index fibers using MATLAB, including: 1) Numerical aperture (NA) 2) Acceptance angle (θa) 3) Solid acceptance angle (Ω) 4) Propagation constant (β) The MATLAB code takes inputs like core and cladding indices, wavelength, and calculates the above parameters using formulas based on those inputs and predefined boundary limits. Plots and important values are displayed.

Uploaded by

Rana
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/ 21

​INDEX 

Experiment Name of the experiment


no:
01 Calculate for Graded Index Fiber( Using Matlab)
a) Numerical aperture (NA)
b) V number (V)
c) Check whether the fiber is single or multi-mode.
d) Graph between V number and Wavelength​(λ)
e) Cut-off wavelength (𝝀c)
f) Number of modes traveling in the fiber (Ms)

02 Calculate for Graded Index Fiber( Using Matlab)


a) Graphical representation of core refractive index n​1​[r] w.r.t. radius(a)
b) Of core for different profile parameters
c) Graphical representation of numerical aperture NA[r] w.r.t. radius of
d) core (r) for different profile parameters
e) Acceptance Angle (θa) for given value of radius
f) Where 0 < r <= a , ∆ = refractive index difference

03 Calculate for Step Index Fiber( Using Matlab):


a) Numerical aperture
b) Acceptance angle
c) Solid acceptance angle
d) Propagation constant

04 Calculate for Step Index Fiber( Using Matlab):


a) Propagation constant (𝛽)
b) Normalized propagation constant (b)
c) V number (V)
d) Check whether the fiber is single or multi-mode
e) Graph between normalized propagation constant and V number
f) Cut-off wavelength (𝝀c)
g) Number of modes traveling in the fiber (Ms)

05 To study and analyze FDM using MATLAB

06 To study and analyze TDM using MATLAB


Experiment no: 01
Name of the experiment: Calculate for Graded Index Fibers
(using MATLAB):
a) Numerical aperture (NA)
c) V number (V)
d) Check whether the fiber is single mode or multi mode.
e) Graph between V number and wavelength (λ)
f) Cut off wavelength (λc)
g) Number of modes traveling in fiber (Ms)
 
Solved​: 
Experimental table: 
Input Boundary limits for Formula Expected Units
inputs output

NA n​1 1.4 < (n​1 ,​ n​2​) < 1.5 (n​1​2 ​- n​2​2 ​)​1/ 2
and and 0.14 to unit
n​2 n​1 >​ n​2 0.20 less

V (a 1.4 < (n​1 ,​ n​2​) < 1.5 (2πa/λ)[(n​1​2 ​- n​2​2​)​1/ 2 0 to 12 unit


and and or and less
λ and n​1 ​> n​2​ and (2πa/λ)*NA V<=2.405
n​1 and
​ 1.1μm < λ< 1.7μm for single
n​2​) 0.3 μm < 2a < 25 mode
or μm and
(a and V>2.405
NA for
and multimode
λ) fiber

2w a and 0.8< V< 2.5 2a * [0.65+(1.619/ V​3/2​)+(2.879/ V​6​)] w<a μm


V

 
The Matlab Code:

clc;

clear all;

d=input('diameter of core in micrometer=');

n1=input('index of core=');

n2=input('index of cladding=');

%NA=((n1^2)-(n2^2))^(1/2);

NA = 0.13;

d=d*1000;% convert diameter micrometer to nanometer

Lamda = input('operating Wavelength at which number of modes to be calculated in


nanometer=');%800 to 1600 nanometer

Vnumber = pi*d*NA/Lamda;

disp('Numerical Aperture = ');

disp(NA);

disp('V number = ');

disp(Vnumber);

if Vnumber < 2.405

disp('The fiber is singe-mode');

else

disp('The fiber is multi-mode');

end

MFD = 2*(d/2)*(0.65+(1.619/(Vnumber^(3/2)))+2.879/(Vnumber^6));

MFD = round(MFD);

MFD = MFD/1000;%convert MFD to micrometer

disp('mode field diameter in micrometer = ');

disp(MFD);
Experiment no: 02
Name of the experiment: Calculate for Graded Index
Fibers(using MATLAB):
a) Graphical representation of core refractive index n1[r] w.r.t. radius(a)

of core for different profile parameters.

b) Graphical representation of numerical aperture NA[r] w.r.t. radius of

core (r) for different profile parameters.

c) Acceptance Angle (θa) for given value of radius

Where 0 < r <= a , ∆ = refractive index difference

​ ​Solved​: 

Experimental table:
Input Boundary limits Formula Expected Units
output
for inputs

∆ n​1​[0] 1.4 < (n​1​[0] , n​2​) < 1.5 (n​1​[0]​ 2​ ​- n​2​2​) ​/ (​ 2 n​1​2​) 0.001 to 0.10 unit
less
and and

n​2 n​1​[0] ​ >​ n​2

n​1​[r] n​1​[0] 1.4 < (n​1​[0] , n​2​) < 1.5 n​1​[0] * (1-2∆(r/a)​α​)​1/2 n​1​[0]​ ​ < n​1​[r] <
n​2
and and unit
less
∆ n​1​[0] ​ >​ n​2

and and

a 0.3 μm < 2a < 25 μm

and and

α 0 < r <= a

1< α < ∞
NA[0] n​1​[0] 1.4 < (n​1​[0] , n​2​) < 1.5 (n​1​[0]​2 ​- n​2​2​)​1/ 2 0.14 to 0.20 unit
less
and and

n​2 n​1​[0] ​ ​> n​2

NA[r] NA[0] 0.3 μm < 2a < 25 μm NA[0] * (1-(r/a)​α​)​1/2 unit


less
and and

a 0 < r <= a

θa (n​1​[0] 1.4 < (n​1​[0] , n​2​) < 1.5 Sin​-1​ [NA[0] *


(1-(r/a)​α​)​1/2​]
and and 0​0​ to 25​0 degree
or
n​2 n​1​[0] ​ ​> n​2
Sin​-1​(NA[r])
and r)

or

NA[r]

The Matlab Code:


clc;

clear all;

disp ('fundamentals of graded index fibers');

d = input('enter the diameter of core in micrometer =');

d = d*1000; %converting micrometer to nanometer

n1axis = input ('enter the index at core axis =');

n2 = input ('enter the index of cladding =');


alpha = input ('enter profile parameter =');

r = input ('enter the radius in micrometer at which acceptance angle is to be fined =');

a = d/2;

del = ((n1axis^2)-(n2^2))/(2*(n1axis^2));

NAaxis = (((n1axis) ^2)-(n2^2)) ^ (1/2);

R = [0:1:a];

n1r = n1axis;

NA = NAaxis;

l = a+1;

for i = R (1, 2): R(1,l)

    n1r = [n1r, n1axis*((1-(2*del*((i/a) ^alpha))) ^ (1/2))];

    NA = [NA, NAaxis*((1- (i/a) ^alpha) ^ (1/2))];

end

theta = asind (NAaxis*((1- (r/a) ^alpha) ^ (1/2)));

disp ('the value of acceptance angle in degree is =');

disp (theta);                        

subplot (1, 2, 1);

plot(R, n1r);

title ('refractive index in graded index fiber w.r.t. radius');

xlabel (‘radius (nm) ---->');

ylabel ('refractive index (unitless) ---->');

grid;

subplot (1, 2, 2);

plot(R, NA);

title ('Numerical Aperture in graded index fiber w.r.t. radius');

xlabel (‘radius (nm) ---->');

ylabel ('numerical aperture (unitless) ---->'); 

grid; 
Experiment no: 03
Name of the experiment: Calculate for Step Index Fibers(using
MATLAB):
a)Numerical aperture 
b)Acceptance angle 
c)Solid acceptance angle 
d)Propagation constant​  

Solved​: 
Experimental table:
Input Boundary limits for Formula Expected Units
required inputs output

NA n​1 ​and n​2 1.4 < (n​1 ​, n​2​) < 1.5 (n​1​2 ​- n​2​2 ​)​1/ 2

and 0.14 to 0.20 unit

n​1 >​ n​2 less

θa (n​1 ​and n​2 ​) 1.4 < (n​1 ​, n​2​) < 1.5 Sin​-1​[(n​1​2 ​- n​2​2​)​1/ 2​]
or
and or 0​0​ to 25​0 degree
NA
n​1 >​ n​2 Sin​-1​(NA)

Ω (n​1 ​and n​2 ​) 1.4 < (n​1 ​, n​2​) < 1.5 π(n​1​2 ​- n​2​2​)
or
and or
NA
n​1 >​ n​2 π(NA)​2 radian
or
or
θa
πθa​2
β (n​1 ,​ n​2 ,λ)
​ 1.4 < (n​1 ,​ n​2​) < 1.5 (2π n​1 /​ λ)Cos(θa)

or and or

(n​1​ ,θa , λ) n​1 ​> n​2 (2π n​1​ / (2πn​1​/ λ) < degree/μm
λ)Cos(Sin​-1​[(n​1​2 ​-n​2​2​)​1/2​]) β<
and (2πn​2 /λ)

1.1μm < λ< 1.7μm

The matlab Code:

clc;

clear all;

disp('fundamental of step index fibers');

n1 = input('enter the index of core =');

n2 = input('enter the index of cladding =');

lamda = input('enter the operating wavelength of fiber in micrometer


=');

NA = ((n1^2)-(n2^2))^(1/2);

disp('numerical aperture of fiber is =');

disp(NA);

theta = asind(NA);

disp('Acceptance angle of fiber in degree is =');

disp(theta);

ohm = pi*(NA^2);

disp('solid acceptance angle of fiber in radian is =');

disp(ohm);

beta = (2*pi*n1/lamda)*cos(theta);

disp('Propagation constant of fiber in degree per micrometer is =');

disp(beta);
Experiment no: 04
Name of the experiment: Calculate for Step Index Fibers(using
MATLAB):
 

a) Propagation constant (β) 


b) Normalized propagation constant (b) 
c) V number (V) 
d) Check whether the fiber is single mode or multi mode. 
e) Graph between normalized propagation constant (b) and V number 
f) Cut off wavelength (λc) 
g) Number of modes traveling in fiber (Ms)
Solved​: 
Experimental table:
Input Boundary limits for Formula Expected Units
required inputs output

NA n​1 ​and n​2 1.4 < (n​1 ​, n​2​) < 1.5 (n​1​2 ​- n​2​2 ​)​1/ 2

and 0.14 to 0.20 unit less

n​1 >​ n​2

θ (n​1 ​and n​2​) 1.4 < (n​1 ​, n​2​) < 1.5 Sin​-1​[(n​1​2 ​- n​2​2​)​1/ 2​]
a or
and or 0​0​ to 25​0 degree
NA
n​1 >​ n​2 Sin​-1​(NA)

β (n​1 ,​ n​2 ,λ)


​ 1.4 < (n​1 ,​ n​2​) < 1.5 (2π n​1 /​ λ)Cos(θa)

or and or

(n​1​ ,θa , n​1 >​ n​2 (2π n​1​ / λ)Cos(Sin​-1​[(n​1​2 ​-n​2​2​)​1/2​]) (2πn​2​/λ) degree/μm
λ) < β<
and (2πn​1​/λ)
1.1μm < λ< 1.7μm
b n​1 and
​ 1.4 < (n​1 ,​ n​2​) < 1.5 k=2 π / λ 0 to 10 unit less

n​2 and
​ and and

β and n​1 ​> n​2 [(β​ 2​/ k​2​)- n​2​2​]/( n​1​2 ​- n​2​2​)

λ and

1.1μm < λ< 1.7μm

and

(2πn​2​/ λ) < β<


(2πn​1 ​/λ)

V (a and λ 1.4 < (n​1 ​, n​2​) < 1.5 (2πa/λ)[(n​1​2 ​- n​2​2​)​1/ 2 0 to 12 unit less
and n​1 ​and
n​2​) and or And

or n​1 >​ n​2​ and (2πa/λ)*NA V<=2.405


for single
(a and NA 1.1μm < λ< 1.7μm mode fiber
and λ) 0.3 μm < 2a < 25 and
μm
V>2.405 for
multimode
fiber

Relation between b b = 1-[{a​2​(n​1​2​k​2​- β​ 2​)}/ V​2 ​]


and V

λ (a and Vc 1.4 < (n​1 ,​ n​2​) < 1.5 Vc=2.405(fixed value) μm


c and n​1 and

n​2​) and and

or n​1 ​> n​2 (2πa/Vc)[(n​1​2 ​- n​2​2​)​1/ 2

(a and NA and or
and Vc) 0.3 μm < 2a < 25 (2πa/Vc) * NA
μm

Ms V V>=10 V​2​/2 unit less


The Matlab Code:

%calculation of Vc,cutoff wavelength,MFD and their graphical


representation

clc;

clear all;

d = input('diameter of core in micrometer=');

n1 = input('enter the index of core =');

n2 = input('enter the index of cladding =');

lamda = input('enter the operating wavelength of fiber in micrometer


=');

NA = ((n1^2)-(n2^2))^(1/2);

disp('numerical aperture of fiber is = ');

disp(NA);

theta = asind(NA);

d = d*1000;% convert diameter micrometer to nanometer

a = d/2;%radius of core

k = 2*pi/lamda;

beta = k*n1*cos(theta);%calculation of propogation constant

disp('propagation constant of fiber is = ');

disp(beta);

b = (((beta^2)/(k^2))-(n2^2))/((n1^2)-(n2^2)); %normalized
propogation constant

disp('Normalized propagation constant of fiber is = ');

disp(b);

Vnumber = pi*d*NA/lamda;

disp('V number = ');

disp(Vnumber);

%find wether fiber is single mode or multi mode


if Vnumber <=2.405

disp('fiber is single mode fiber at given wavelength');

else

disp('fiber is multimode fiber at given wavelength');

end

%graphical representation of V verses normalized propogation


constant(b)

x = [1:1:12];% X-axis b- 1 to 12

y = 1-(((a^2)*(((n1^2)*(k^2))-(beta^2)))/(1^2))

for i = x(1,2):x(1,12)

y = [y,1-(((a^2)*(((n1^2)*(k^2))-(beta^2)))/(i^2))];

end

figure(1);

plot(x,y);

grid;

xlabel('Vnumber(unitless)--->');

ylabel('normalized propogatio constant(b)unitless--->');

%graphical representation of V with wavelength

x1=[800:1:2000];% X-axis wavelength from 100 to 4000 range in


nanometer

y1=[(pi*d*NA)/800];

for j=x1(1,2):x1(1,1201)

k=2*pi/j;

y1=[y1,(k*d*NA/2)];

end

Vc = 2.405;

CutoffWavelength = pi*d*NA/Vc;

CutoffWavelength = round(CutoffWavelength);

disp('cutoff wavlength(nm) = ');


disp(CutoffWavelength);

figure(2);

plot(x1,y1);

hold on

h = stem(CutoffWavelength,Vc,'LineWidth',1);

set(h,'MarkerFaceColor','red');

hold off

annotation('textbox', 'Position',[0.6271 0.7976 0.2021


0.0524], 'FitHeightToText','off','BackgroundColor',[1 0.6431
1], 'String',{sprintf('Cutoff wavelength= %s',...

int2str(CutoffWavelength))});

title('variation of normalized frequency with wavelength in step


index fibers');

xlabel('wavelength(nm)--->');

ylabel('V(unitless)--->');

grid;

Lamda = input('operating Wavelength at which number of modes to be


calculated in nanometer=');

Vnumber = pi*d*NA/Lamda;

disp('V number=');

disp(Vnumber);

annotation('textbox', 'Position',[0.6271 0.6976 0.1021


0.0424], 'FitHeightToText', 'off','BackgroundColor',[1 0.6431
1],'String',{sprintf('Vnumber= %s' ,int2str(Vnumber))})

Ms = (Vnumber^2)/2;

disp('number of modes at operating wavelength=');

Ms = round(Ms);

disp(Ms);
Experiment no: 05
Name of the experiment: To study and analyze FDM using
MATLAB .

Solved:

The Matlab code:


% Design and simulation of Frequency Division Multiplexing in MATLAB
clc;

clear all

close all

samples=1000;

% number of users

nos=3;

% modulating signal frequency in Hz

mfreq=[30 40 50 ];

% carrier frequency allocated to the different users in Hz

cfreq=[ 1800 2100 2400];

% choose frequency deviation

freqdev=10;

% generate modulating signal

t=linspace(0,1000,samples);

parfor i=1:nos

m(i,:)=sin(2*pi*mfreq(1,i)*t)+2*sin(pi*8*t);

end

% Generate the modulated signal

parfor i=1:nos

y(i,:)=fmmod(m(i,:),cfreq(1,i),10*cfreq(1,i),freqdev);

end
% pass the modulated signal through the channel

ch_op=awgn(sum(y),0,'measured');

% demodulate the received signal at the base station

parfor i=1:nos

16

z(i,:)=fmdemod(y(i,:),cfreq(1,i),10*cfreq(1,i),freqdev);

end

% display the transmitted signal and received signal at the base station

% figure

C = {'k','b','r','g','y',[.5 .6 .7],[.8 .2 .6],[.3 .2 .2]}; % Cell array of colros.

for i=1:nos

figure (1)

hold on

plot(y(i,:),'color',C{i});

xlabel('time index'); ylabel('amplitude'); title('Signal from different users combined in the channel');

figure

subplot(3,1,1)

plot(m(i,:)) % modulating signal

xlabel('time index'); ylabel('amplitude'); title('modulating Signal from user');

subplot(3,1,2)

plot(y(i,:),'color',C{i}); % modulated signal

xlabel('time index'); ylabel('amplitude'); title('modulated Signal from user');

subplot(3,1,3)

plot(z(i,:),'color',C{i}); % demodulated signal

xlabel('time index'); ylabel('amplitude'); title('demodulated Signal from user at the base station');

end

figure

plot(ch_op) % combination of all modulated signals passed through the channel

xlabel('time index'); ylabel('amplitude'); title('Signal after passing through the channel');


The output:

Signal 1:
Signal 2:

Signal 3:
Combined Signal:
Experiment no: 06
Name of the experiment: To study and analyze TDM using
MATLAB .

Solved​:

The Matlab Code:


clc;
close all;
clear all;
% Signal generation
x=0:.5:4*pi; % siganal taken upto 4pi
sig1=8*sin(x); % generate 1st sinusoidal signal
l=length(sig1);
sig2=8*triang(l); % Generate 2nd traingular Sigal
% Display of Both Signal
subplot(2,2,1);
plot(sig1);
title('Sinusoidal Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
subplot(2,2,2);
plot(sig2);
title('Triangular Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
% Display of Both Sampled Signal
subplot(2,2,3);
stem(sig1);
title('Sampled Sinusoidal Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
subplot(2,2,4);
stem(sig2);
title('Sampled Triangular Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
l1=length(sig1);
l2=length(sig2);
for i=1:l1
sig(1,i)=sig1(i); % Making Both row vector to a matrix
sig(2,i)=sig2(i);
end
% TDM of both quantize signal
tdmsig=reshape(sig,1,2*l1);
% Display of TDM Signal
figure
stem(tdmsig);
title('TDM Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
% Demultiplexing of TDM Signal
demux=reshape(tdmsig,2,l1);
for i=1:l1
sig3(i)=demux(1,i); % Converting The matrix into row vectors
sig4(i)=demux(2,i);
end
% display of demultiplexed signal
figure
subplot(2,1,1)
plot(sig3);
title('Recovered Sinusoidal Signal');
ylabel('Amplitude--->');
xlabel('Time--->');
subplot(2,1,2)
plot(sig4);
title('Recovered Triangular Signal');
ylabel('Amplitude--->');
xlabel('Time--->');

The Output:

You might also like