diff options
author | prashantsinalkar | 2017-10-10 12:27:19 +0530 |
---|---|---|
committer | prashantsinalkar | 2017-10-10 12:27:19 +0530 |
commit | 7f60ea012dd2524dae921a2a35adbf7ef21f2bb6 (patch) | |
tree | dbb9e3ddb5fc829e7c5c7e6be99b2c4ba356132c /374 | |
parent | b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b (diff) | |
download | Scilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.tar.gz Scilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.tar.bz2 Scilab-TBC-Uploads-7f60ea012dd2524dae921a2a35adbf7ef21f2bb6.zip |
initial commit / add all books
Diffstat (limited to '374')
53 files changed, 706 insertions, 0 deletions
diff --git a/374/CH1/EX1.1/11.sci b/374/CH1/EX1.1/11.sci new file mode 100644 index 000000000..903863145 --- /dev/null +++ b/374/CH1/EX1.1/11.sci @@ -0,0 +1,19 @@ +//Chapter 1 Example1//
+//core refractive index of silica optical fibre =n1,cladding refractive index of silica optical fibre =n2,critical angle =p,angle of obliqueness=pm//
+n1=1.5;n2=1.450;
+p=asind(n2/n1);
+pm=90-p;
+printf("\n a)angle of obliqueness=%f\n",pm);
+//refractive index for air=na,acceptance angle in air=a//
+na=1;
+h=sind(pm);
+k=(n1*h)/(na);
+a=asind(k);
+printf("\n b) acceptance angle of fibre=%f\n",a);
+//numerical aperture=NA,percentage of light collected=x//
+NA=sqrt((n1+n2)*(n1-n2));
+x=(NA^2)*100;
+printf("\n.c) numerical aprture of fibre=%f\n",NA);
+printf("\n.d) percentage of light collected=%f\n",x);
+
+
diff --git a/374/CH1/EX1.2/12.sci b/374/CH1/EX1.2/12.sci new file mode 100644 index 000000000..e954ebb52 --- /dev/null +++ b/374/CH1/EX1.2/12.sci @@ -0,0 +1,11 @@ +//Chapter 1 Example2//
+//refractive index of air=na,acceptance angle=a,numerical aperture=NA//
+clc;
+clear;
+NA=0.3;
+a=asind(NA);
+printf("\n a) acceptance angle=%f\n",a);
+//direction of screw rays=s,acceptance angle of screw rays=as//
+s=45;
+as=(asind(NA))/(cosd(s));
+printf("\n b) acceptance angle of screw rays=%f\n",as);
diff --git a/374/CH1/EX1.3/13.sci b/374/CH1/EX1.3/13.sci new file mode 100644 index 000000000..10f89d78b --- /dev/null +++ b/374/CH1/EX1.3/13.sci @@ -0,0 +1,16 @@ +//Chapter 1 Example3//
+clc;
+clear;
+//refractive index of W step index fibre=n1,refractive index difference between core and cladding=d,numerical aperture=NA//
+d=0.02;
+n1=1.46;
+n2=n1-(n1*d);
+v=n1+n2;
+b=n1-n2;
+NA=sqrt(v*b);
+printf("\n a) numerical aperture=%f,n\",NA);
+//solid acceptance angle in air=as,critical angle of core cladding interface=p//
+as=%pi*(NA^2);
+printf("\n b) solid acceptance angle in air=%f,n\",as);
+p=asind(n2/n1);
+printf("\n c) critical angle of core cladding interface=%f,n\",p);
\ No newline at end of file diff --git a/374/CH11/EX11.1/111.sci b/374/CH11/EX11.1/111.sci new file mode 100644 index 000000000..e6f0a7048 --- /dev/null +++ b/374/CH11/EX11.1/111.sci @@ -0,0 +1,11 @@ +//chapter 11 example 1// +clc +clear +//material dispersion delay=dtmax,value of parameter=p,length of link-L,spectral width=d,speed of light=c,wavelength=l// +L=1.25*(10^3);//in mts// +c=3*(10^8);//speed of light// +dl=45;//in nm// +p=0.023; +l=850;//in nm// +dtmax=(L*dl*p)/(c*l)*(10^9); +printf("\n material dispersion delay=%f ns\n",dtmax)
\ No newline at end of file diff --git a/374/CH11/EX11.2/112.sci b/374/CH11/EX11.2/112.sci new file mode 100644 index 000000000..100feb8b0 --- /dev/null +++ b/374/CH11/EX11.2/112.sci @@ -0,0 +1,12 @@ +//chapter 11 example 2//
+clc
+clear
+//value of parameter=p,wavelength=l,spectral width=dl,speed of light=c,material dispersion limited transmission distance=Lmax,bit rate=Br//
+c=3*(10^8);//in mts/sec//
+l=850;//in nm//
+dl=45;//in nm//
+Br=10*(10^6);//in bits per sec//
+p=0.023;
+Tb=(1/Br);//bit time//
+Lmax=(0.35*Tb*c*l)/(dl*p);
+printf("\n material dispersion limited transmission distance=%f m\n",Lmax)
\ No newline at end of file diff --git a/374/CH11/EX11.3/113.sci b/374/CH11/EX11.3/113.sci new file mode 100644 index 000000000..666b6631e --- /dev/null +++ b/374/CH11/EX11.3/113.sci @@ -0,0 +1,12 @@ +//chapter 11 example 3// +clc +clear +//refractive index of core=n1,relative difference=n1-n2=d,Data rate=Br,modal dispersion limited transmission distance=Lmax,speed of light=c// +d=(0.01*1.45); +Br=50*(10^6);//bit rate// +n1=1.45; +c=3*(10^8);//in mts/sec// +Lmaxs1=(0.35*c)/(d*Br);//for step index fibre// +printf("\n material dispersion limited transmission distance for step index fibre=%f m\n",Lmaxs1) +Lmaxg1=(1.4*c*n1)/(d*Br); +printf("\n material dispersion limited transmission distance=%f m\n",Lmaxg1)
\ No newline at end of file diff --git a/374/CH11/EX11.5/115.sci b/374/CH11/EX11.5/115.sci new file mode 100644 index 000000000..c090f24dd --- /dev/null +++ b/374/CH11/EX11.5/115.sci @@ -0,0 +1,20 @@ +//chapter 11 example 5//
+clc
+clear
+//value of parameter=p,length of link=L,speed of light=c,wavelength=l,spectral width=dl,rise time=dtr//
+c=3*(10^8);//in mts per sec//
+l=830;//in nm//
+dl=40;//in nm//
+L=2.5*(10^3);//in mts//
+p=0.024;//value of parameter//
+dtmat=(-L*dl*p)/(c*l)*(10^9);
+dtmodal=(2.5*3.5);
+dtr=10;//in ns//
+dts=8;//in ns//
+g=sqrt((dts^2)+(dtr^2)+(dtmat^2)+(dtmodal^2));
+dtsys=1.1*g;
+printf("\n material dispersion delay time=%f m\n",dtsys)
+Btmax=(0.75/dtsys)*(10^9);
+printf("\n a)Btmax for RZ format=%f m\n",Btmax)
+Btmax1=(0.35/dtsys)*(10^9);
+printf("\n b)Btmax for NRZ format=%f m\n",Btmax1)
\ No newline at end of file diff --git a/374/CH2/EX2.1/21.sci b/374/CH2/EX2.1/21.sci new file mode 100644 index 000000000..7b79d7045 --- /dev/null +++ b/374/CH2/EX2.1/21.sci @@ -0,0 +1,15 @@ +//chapter2.example.1//
+//core radius of multimode fibre=r,relative refractive difference=d,refractive index of the fibre=n1,refractive indexof cladding=n2,wavelength=l//
+r=35*(10^-6);//in metres//
+n1=1.46;
+d=0.015;
+n2=n1-(n1*d);
+printf("\nrefractive indexof cladding=%f\n",n2);
+l=0.85*(10^-6);//in metres//
+//expression of v number=V,total number of guided modes in the stepindex motor=M//
+j=(2*%pi*r)/l;
+q=sqrt((n1^2)-(n2^2));
+V=j*q;
+printf("\nexpression of v number =%f\n",V);
+M=(V^2)/2;
+printf("\ntotal number of guided modes in the stepindex motor=%f modes\n",M);
diff --git a/374/CH2/EX2.2/22.sci b/374/CH2/EX2.2/22.sci new file mode 100644 index 000000000..d3170ae46 --- /dev/null +++ b/374/CH2/EX2.2/22.sci @@ -0,0 +1,17 @@ +//chapter2.example.2//
+//core refractive index of step index fibre=n1,relative index difference between core and cladding=d,wavelength=l,core diameter of step index fibre=a,v parameter for single mode operation=V//
+clc
+clear
+n1=1.48;
+d=0.015;
+l=0.85*(10^-6);//in metres//
+h=sqrt(2*d);
+V=2.405;
+z=(V*l)/(2*%pi*n1);
+a=(z/h)*(10^6)*2;
+printf("\maximum core diameter for single mode operation=%f*(10^-6)mts.\n",a);
+//new maximum core diameter for single mode operation=a1,new relative index difference between core and cladding=d1//
+d1=0.0015;
+h1=sqrt(2*d1);
+a1=(z/h1)*(10^6)*2;
+printf("\n new maximum core diameter for single mode operation=%f*(10^-6)mts.\n",a1);
\ No newline at end of file diff --git a/374/CH2/EX2.3/23.sci b/374/CH2/EX2.3/23.sci new file mode 100644 index 000000000..720b60fb5 --- /dev/null +++ b/374/CH2/EX2.3/23.sci @@ -0,0 +1,11 @@ +//chapter2.example.3//
+clc
+clear
+//core refractive indices of stepindex fibre=n1,cladding refractive indices of stepindex fibre=n2,wavelength=l,phase constant=b,maximum value of phase constant=b1,minimum value of phase constant=b2;//
+n1=1.6;
+n2=1.44;
+l=0.8*(10^-3);
+b1=(2*%pi*n1)/(l*(10^3));//in rad/mm//
+b2=(2*%pi*n2)/(l*(10^3));//in rad/mm//
+printf("\nmaximum value of phase constant=%f rad/mm\n",b1);
+printf("\nminimum value of phase constant=%f rad/mm\n",b2);
\ No newline at end of file diff --git a/374/CH2/EX2.4/24.sci b/374/CH2/EX2.4/24.sci new file mode 100644 index 000000000..ce79231c4 --- /dev/null +++ b/374/CH2/EX2.4/24.sci @@ -0,0 +1,12 @@ +//chapter2.example.4//
+//core refractive index=n1,cut off value of V parameter for single mode operation=Vc,radius=a,cladding refractive index=n2,relative index difference between core and cladding=d,cut off wavelength=lc//
+clc
+clear
+Vc=2.405;
+n1=1.46;
+d=0.0025;
+a=5*(10^-6);//in metres//
+h=sqrt(2*d);
+x=(2*%pi*a*n1)/Vc;
+lc=x*h*(10^6);
+printf("\ncut off wavelength of the fibre=%f*(10^-6)mts.\n",lc);
diff --git a/374/CH2/EX2.5/25.sci b/374/CH2/EX2.5/25.sci new file mode 100644 index 000000000..b68334e9b --- /dev/null +++ b/374/CH2/EX2.5/25.sci @@ -0,0 +1,16 @@ +//chapter2.example.5//
+clc
+clear
+//core refractive index=n1,cladding refractive index=n2,radius of core=a,operating wavelength=l,number of guided modes=M,ratio of power flow in the core and cladding=z//
+n1=1.50;
+n2=1.49;
+a=30*(10^-6);
+l=0.85*(10^-6);
+h=(2*%pi*a)/l;
+x=(n1^2)-(n2^2);
+M=((h^2)*x)/2;
+printf("\n number of guided modes=M=%f modes\n",M);
+y=(4*(M^-0.5))/3;
+g=1-y;
+z=g/y;
+printf("\n ratio of power flow in the core and cladding=%f\n",z);
diff --git a/374/CH3/EX3.0/3.sci b/374/CH3/EX3.0/3.sci new file mode 100644 index 000000000..15d08d742 --- /dev/null +++ b/374/CH3/EX3.0/3.sci @@ -0,0 +1,11 @@ +//chapter 3 example//
+clc
+clear
+//spectrum width=W,laser source emits ligth at=D,bandwidth distance product=fZ,speed of light=C//
+W=0.003//in micro meters//
+D=0.85//in micro meters//
+x=W/D;
+Ym=0.021//obtained from graph//
+C=3*(10^8);//in mts per second//
+fZ=C/(4*x*Ym)*(10^-12);
+printf("\n bandwidth distance product=%f GHz Km \n",fZ);
\ No newline at end of file diff --git a/374/CH3/EX3.1/31.sci b/374/CH3/EX3.1/31.sci new file mode 100644 index 000000000..bc8bab50b --- /dev/null +++ b/374/CH3/EX3.1/31.sci @@ -0,0 +1,18 @@ +//chapter 3 example 1//
+//length of fibre=l,average optical power=Pin,average output power=Pout,signal attenuation per km=A//
+clc
+clear
+Pin=100*(10^-6);//in watts//
+Pout=2.5*(10^-6);//in watts//
+l=10//in kilometers//
+A=(10*(log10(Pin/Pout)))/l;//per km//
+printf("\n a) signal attenuation per km=%f per km.\n",A);
+//sigmal attenuaion in db=Adb,total attenuation for 11kms=A1,attenuation for 3 splice each with 0.8db=A2,overall attenuation in the link=Anet,ratio between input and output power=x//
+Adb=(A*10);
+printf("\n b) signal attenuation in decibels=%f db.\n",Adb);
+A1=(A*11);
+A2=2.4;
+Anet=A1+A2;
+printf("\n c) overall signal attenuation in decibels=%f db.\n",Anet);
+x=(10^(Anet/10));
+printf("\n d) ratio between input and output power=%f\n",x);
\ No newline at end of file diff --git a/374/CH3/EX3.2/32.sci b/374/CH3/EX3.2/32.sci new file mode 100644 index 000000000..934b38cc8 --- /dev/null +++ b/374/CH3/EX3.2/32.sci @@ -0,0 +1,15 @@ +//chapter 3 example 2//
+//temperature of silica glass=T,isothermal compressebility=Bc,refractive index of silica=n1,photoelastic coeffcient of silica=P,boltzmann constant=Kb,optical wavelength=l,rayleigh scattering coeffcient=Tr,attenuation in km=Akm,attenuation in db=Adb//
+clc
+clear
+n1=1.46;
+P=0.286;
+Bc=7*(10^-11);//in meter sqr per newton//
+l=(10^-6)// in meters//
+T=1400//in kelvin//
+Kb=1.38*(10^-23)//in joules per kelvin//
+Tr=((8*(%pi^3))*(n1^8)*(P^2)*Bc*Kb*T)/(3*(l^4));
+printf("\n rayleigh scattering constant=%f per metre.\n",Tr);
+Akm=exp(-1*Tr*(10^3));
+Adb=10*(log10(1/Akm));
+printf("\n attenuation in db=%f db per Km.\n",Adb);
diff --git a/374/CH3/EX3.3/33.sci b/374/CH3/EX3.3/33.sci new file mode 100644 index 000000000..05ad22d0e --- /dev/null +++ b/374/CH3/EX3.3/33.sci @@ -0,0 +1,16 @@ +//chapter 3 example 3//
+clc
+clear
+//core refractive index=n1,cladding refractive index=n2,refractive index of air=na,numerical aperture=NA,acceptance angle=A,multiple time dispersion=M,relative refractive index difference=d,speed of light=C//
+n1=1.55;
+n2=1.51;
+d=n1-n2;
+n=(n1+n2)/2;
+NA=sqrt(2*d*n);
+printf("\n 1) numerical aperture=%f.\n",NA);
+A=asind(NA);
+printf("\n 2) acceptance angle=%f.\n",A);
+C=(3*(10^8));//in mts per sec//
+M=((n1*d)/(n2*C))*(10^12);
+printf("\n 3) multiple time dispersion=%f ns/km \n",M);
+
diff --git a/374/CH3/EX3.4.b/34b.sci b/374/CH3/EX3.4.b/34b.sci new file mode 100644 index 000000000..41816bdcc --- /dev/null +++ b/374/CH3/EX3.4.b/34b.sci @@ -0,0 +1,10 @@ +//chapter 3 example 4 b//
+clc
+clear
+//core refractive index=n1,relative refractive index difference=d,operating wavelength=l,critical radius of curvature=Rc,cladding refractive index=n2//
+d=0.03;
+n1=1.500;
+n2=sqrt((n1^2)-(2*d*(n1^2)));
+l=0.8*(10^-6);
+Rc=((3*(n1^2)*l)/(4*%pi*((n1^2)-(n2^2))^1.5))*(10^6);//critical radius of curvature//
+printf("\n critical radius of curvature=%f*(10^-6).\n",Rc);
\ No newline at end of file diff --git a/374/CH3/EX3.4/34.sci b/374/CH3/EX3.4/34.sci new file mode 100644 index 000000000..1852ad81c --- /dev/null +++ b/374/CH3/EX3.4/34.sci @@ -0,0 +1,16 @@ +//chapter 3 example 4//
+clc
+clear
+//core radius of monomode fibre=a,core refractive index=n1,refractive index difference between core and cladding=d,operating wavelength=l,critical radius of curvature=Rc,cutoff wavelength=Lc//
+a=4*(10^-6);//in mts//
+n1=1.500;
+d=0.003;
+l=1.55*(10^-6);//in mts//
+Lc=(((2*%pi*a*n1)*(sqrt(2*d)))/2.405)*(10^6);//cutoff wavelength//
+printf("\n cutoff wavelength=%f*(10^-6)m.\n",Lc);
+lc1=Lc*(10^-6);
+h=(2.748-(0.996*(l/lc1)));
+k=h^-3;
+v=(20*l)/(d^1.5);
+Rc=k*v;
+printf("\n critical radius=%f .\n",k);
\ No newline at end of file diff --git a/374/CH3/EX3.5/35.sci b/374/CH3/EX3.5/35.sci new file mode 100644 index 000000000..99c81cf8d --- /dev/null +++ b/374/CH3/EX3.5/35.sci @@ -0,0 +1,12 @@ +//chapter 3 example 5//
+clc
+clear
+//wavelength of single mode fibre=l,attenuation=A,core diameter of fibre=d,laser sourcr bandwidth=BW,threshold optical power for brillouin=Pb,threshold optical power for raman scattering=Pr//
+d=6;//in micrometer//
+l=1.3;//in micrometer//
+A=0.5;//in db per km//
+BW=0.6//in GHz//
+Pb=(4.4*(10^-3))*(d^2)*(l^2)*(A*BW)*1000;//in watts//
+printf("\n threshold optical power for brillouin=%f mW.\n",Pb);
+Pr=(5.9*(10^-2))*(d^2)*l*A;
+printf("\n threshold optical power for raman scattering=%f W.\n",Pr);
\ No newline at end of file diff --git a/374/CH3/EX3.6/36.sci b/374/CH3/EX3.6/36.sci new file mode 100644 index 000000000..e7f13281f --- /dev/null +++ b/374/CH3/EX3.6/36.sci @@ -0,0 +1,14 @@ +//chapter 3 example 6//
+clc
+clear
+//core refractive index=n1,relative refractive index difference=d,core radius=a,operating wavelength=l;waveguide dispersion=W.speed of light=C//
+l=1.3*(10^-6);//in meters//
+a=4.5*(10^-6);//in meters//
+d=0.0022;
+n1=1.48;
+V=((2*%pi*a*n1)*(sqrt(2*d)))/l;
+n2=n1*(1-d);
+C=(3*(10^8));
+S=0.480;//product of V and its double differentiation wrt v//
+W=(-1*n2*d*S)/(C*l)*(10^6);//wave guide dispersion//
+printf("\n wave guide dispersion=%f ps Km-1 nm-1\n",W);
diff --git a/374/CH3/EX3.7/37.sci b/374/CH3/EX3.7/37.sci new file mode 100644 index 000000000..11d8f12e1 --- /dev/null +++ b/374/CH3/EX3.7/37.sci @@ -0,0 +1,12 @@ +//chapter 3 example 7//
+clc
+clear
+//operating wavelength=l,total material dispersion=dtm,total waveguide dispersion=dtw,received pulse duration=Tr,transmitted pulse duration=T,approximate bit rate=Bmax,total dispersion=dtt,total intermodal dispersion=dtimd//
+dtm=2.81;//in nanoseconds//
+dtw=0.495;//in nanoseconds//
+T=0.5;//in nanoseconds//
+dtimd=0;
+dtt=sqrt((dtimd^2)+(dtm^2)+(dtw^2));//in nanoseconds//
+Tr=T+dtt;//in nanoseconds//
+Bmax=(1/(5*Tr))*1000;
+printf("\n approximate bit rate=%fMHz \n",Bmax);
diff --git a/374/CH4/EX4.1/41.sci b/374/CH4/EX4.1/41.sci new file mode 100644 index 000000000..a41770da7 --- /dev/null +++ b/374/CH4/EX4.1/41.sci @@ -0,0 +1,17 @@ +//chapter 4 example 1//
+clc
+clear
+//recombination life time=Tr,drive current=I,wavelength=l,total carrier life time=Tp,efficicency=E,internal generated power=Pint//
+Tr=50;//in nano seconds//
+Tnr=100;//in nano seconds//
+Tp=(Tr*Tnr)/(Tr+Tnr);
+printf("\n Total carrier combination life time=%fns \n",Tp);
+E=Tp/Tr;
+printf("\n efficiency=%f \n",E);
+h=6.62*(10^-34);//plancks constant//
+c=3*(10^8);//speed of light//
+I=50*(10^-3);//current in amperes//
+l=0.85*(10^-6);//wavelength in metres//
+e=1.6*(10^-19)//charge of electron//
+Pint=((E*I*h*c)/(e*l)*10^(3));//in milli watts//
+printf("\n Internal generated power=%f*mW \n",Pint);
diff --git a/374/CH4/EX4.2/42.sci b/374/CH4/EX4.2/42.sci new file mode 100644 index 000000000..95fd212c0 --- /dev/null +++ b/374/CH4/EX4.2/42.sci @@ -0,0 +1,11 @@ +//chapter 4 example 2//
+clc
+clear
+//core radius=r,radiance of the device=Rd,numerical aperture=NA,reflection coeffcient at index matched filter=R,optical power coupled to the fibre=Pc,area=A//
+r=25*(10^-4);
+A=%pi*(r*r);
+R=0.01;//frencel reflection coeffcient//
+Rd=30//in W sr-1 cm-2//
+NA=0.18;//numerical aperture//
+Pc=%pi*(1-R)*A*Rd*NA*NA*(10^6);
+printf("\n optical power coupled to the fibre=%f microwatt \n",Pc);
\ No newline at end of file diff --git a/374/CH5/EX5.1.b/51b.sci b/374/CH5/EX5.1.b/51b.sci new file mode 100644 index 000000000..149c1f005 --- /dev/null +++ b/374/CH5/EX5.1.b/51b.sci @@ -0,0 +1,9 @@ +//chapter 5 example 1//
+clc
+clear
+//band gap energy=Eg,voltage applied=V,total effeciency of an injection laser=nT//
+Eg=1.43;//in ev//
+V=2.5;//in volts//
+nT=0.18;
+ne=((nT*Eg)/V)*100;
+printf("\n external power efficiency=%f percent\n",ne)
\ No newline at end of file diff --git a/374/CH5/EX5.1/51.sci b/374/CH5/EX5.1/51.sci new file mode 100644 index 000000000..2e18db8fb --- /dev/null +++ b/374/CH5/EX5.1/51.sci @@ -0,0 +1,15 @@ +//chapter 5 example 1//
+clc
+clear
+//length of optical cavity=l,widt=w,refractive index=n,gain factor=B,loss coeffcient=A,threshold current density=Jth,threshold current required=Ith,refractive index of Ga As-air interface=R1//
+n=3.8;//refractive index//
+R1=((n-1)^2)/((n+1)^2);
+B=20*(10^-3);//in area by centimeter cube//
+A=10;//per cm//
+l=200*(10^-4);//in cm//
+w=100*(10^-4);//in cm//
+k=1/R1;
+Jth=(A+(log(k))/l)/B;
+printf("\n threshold current density=%f A cm-2\n",Jth);
+Ith=Jth*l*w;
+printf("\n threshold current required=%f mA\n",Ith);
\ No newline at end of file diff --git a/374/CH5/EX5.2.a/52a.sci b/374/CH5/EX5.2.a/52a.sci new file mode 100644 index 000000000..1518fabd3 --- /dev/null +++ b/374/CH5/EX5.2.a/52a.sci @@ -0,0 +1,9 @@ +//chapter 5 example 2//
+clc
+clear
+//band gap energy=Eg,total efficiency=nT,voltage applied=V,external efficiency=ne//
+Eg=1.43;//in ev//
+V=2.5;//in volts//
+nT=0.20;
+ne=((nT*Eg)/V)*100;//external efficiency//
+printf("\n external efficiency=%f percent\n",ne)
diff --git a/374/CH5/EX5.2/52.sci b/374/CH5/EX5.2/52.sci new file mode 100644 index 000000000..29732231d --- /dev/null +++ b/374/CH5/EX5.2/52.sci @@ -0,0 +1,9 @@ +//chapter 5 example 2//
+clc
+clear
+//hole concentration=Pn,minority carrier life time=Tr//
+Br=7.21*(10^-10);
+Pn=10^18;//in per cm cube//
+Tr=((Br*Pn)^-1)*(10^9);//minority carrier life time//
+printf("\n minority carrier life time=%f *(10^-9) sec \n",Tr);
+
diff --git a/374/CH5/EX5.3.a/53a.sci b/374/CH5/EX5.3.a/53a.sci new file mode 100644 index 000000000..1d555b353 --- /dev/null +++ b/374/CH5/EX5.3.a/53a.sci @@ -0,0 +1,16 @@ +//chapter 5 example 3a//
+clc
+clear
+//threshold temperature=To,ratio of current densities=R,current density=Jth,curren density at 20 deg =J1,current density at 80deg=J2//
+//J1=Jth*(exp((273+20)/160))//
+//J2=Jth*(exp((273+80)/160))//
+K1=(exp((273+20)/160));
+K2=(exp((273+80)/160));
+R=K2/K1;//for AlGaAs//
+printf("\n ratio of current densities for AlGaAs=%f\n",R)
+//J1=Jth0*exp(273+20)/55/
+//J2=Jtho(exp((273+80)/55//
+K1a=(exp((273+20)/55));
+K2a=(exp((273+80)/55));
+R1=K2a/K1a;//for AlGaAsp//
+printf("\n ratio of current densities for AlGaAsp=%f\n",R1)
\ No newline at end of file diff --git a/374/CH5/EX5.4.a/54a.sci b/374/CH5/EX5.4.a/54a.sci new file mode 100644 index 000000000..85612bfc9 --- /dev/null +++ b/374/CH5/EX5.4.a/54a.sci @@ -0,0 +1,11 @@ +//chapter 5 exmaple 4a//
+clc
+clear
+//number of longitudnal modes=K,refractive index=n1,length of the cavity in the laser=L,wavelength of the device=l,seperation wavelength between two modes=dl//
+K=1700;
+n1=3.6;
+l=0.85*(10^-6);//in mts//
+L=((K*l)/(2*n1))*(10^6);
+printf("\n length of the cavity in the laser=%f micro meters\n",L)
+dl=((l^2)/(2*n1*L))*(10^15);//seperation wavelength between modes//
+printf("\n seperation wavelength between modes=%f micro meters\n",dl)
\ No newline at end of file diff --git a/374/CH5/EX5.4/54.sci b/374/CH5/EX5.4/54.sci new file mode 100644 index 000000000..bd73fa4b8 --- /dev/null +++ b/374/CH5/EX5.4/54.sci @@ -0,0 +1,9 @@ +//chapter 5 example 4//
+clc
+clear
+//length of cavity=L,refractive index of GaAs=n1,wavelength=l,seperation wavelength between two mode=dl//
+n1=3.6;//refractive index//
+l=0.85*(10^-6);//wavelength//
+L=200*(10^-6);//length of cavity//
+dl=(l^2)/(2*n1*L)*(10^9);//seperation wavelength between two mode//
+printf("\n seperation wavelength between two mode=%f nm\n",dl)
\ No newline at end of file diff --git a/374/CH6/EX6.1/61.sci b/374/CH6/EX6.1/61.sci new file mode 100644 index 000000000..47252d685 --- /dev/null +++ b/374/CH6/EX6.1/61.sci @@ -0,0 +1,16 @@ +//chapter 6 example 1// +clc +clear +//energy=E,efficiency=n,wavelength=l,plancks constant=h,speed of light=c,incident power required=R,incident power required=Po// +h=6.62*(10^-34); +c=3*(10^8);//in mts/sec// +E=2.2*(10^-19);//in joules// +l=((h*c)/E)*(10^6);//operating wavelength// +printf("\n a) operating wavelength required=%f micro meter\n",l) +f=c/l; +n=0.7;//efficiency// +e=1.6*(10^-19);//charge of electron// +R=((n*e)/(h*f))*(10^-6); +Ip=2.0*(10^-6); +Po=(Ip/R)*(10^6); +printf("\n b) incident power required=%f m\n",Po)
\ No newline at end of file diff --git a/374/CH6/EX6.10/610.sci b/374/CH6/EX6.10/610.sci new file mode 100644 index 000000000..8f7d7a557 --- /dev/null +++ b/374/CH6/EX6.10/610.sci @@ -0,0 +1,9 @@ +//chapter 6 example 10//
+clc
+clear
+//plancks constant=h,speed of light=c,energy gay=Eg,critical wavelength=lc//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts per sec//
+Eg=1.15*1.6*(10^-19);
+lc=((h*c)/Eg)*(10^9);
+printf("\n critical wavelength=%f nm\n",lc)
\ No newline at end of file diff --git a/374/CH6/EX6.2/62.sci b/374/CH6/EX6.2/62.sci new file mode 100644 index 000000000..acb0beeb8 --- /dev/null +++ b/374/CH6/EX6.2/62.sci @@ -0,0 +1,14 @@ +//chapter 6 example 2//
+clc
+clear
+//quantum efficiency=n,number of hole pairs generated=re,number of incident photon=rp,responsivity=R,charge of the electron=e,speed of the light=c//
+re=1.5*(10^11);
+rp=3*(10^11);
+n=re/rp;//quantum efficiency//
+printf("\n quantum efficiency=%f m\n",n)
+e=1.6*(10^-19);
+l=0.85*(10^-6);//in mts//
+c=3*(10^8);//in mts/sec//
+h=6.62*(10^-34);
+R=(n*e*l)/(h*c);
+printf("\n responsivity of the photo diode=%f AW-1\n",R)
diff --git a/374/CH6/EX6.3/63.sci b/374/CH6/EX6.3/63.sci new file mode 100644 index 000000000..75873e6bf --- /dev/null +++ b/374/CH6/EX6.3/63.sci @@ -0,0 +1,15 @@ +//chapter 6 example 3//
+clc
+clear
+//energy=E,plancks constant=h,speed of light=c,frequency=f,responsivity=R,incident optical power=Po//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts/sec//
+E=1.5*(10^-19);//in joules//
+l=((h*c)/E)*(10^6);
+printf("\n a) wavelength at which photodiode is operating=%f micro meter\n",l)
+n=0.65;//efficiency//
+e=1.6*(10^-19);
+R=((n*e*l)/(h*c))*(10^-6);
+Ip=3*(10^-6);
+Po=(Ip/R)*(10^6);
+printf("\n b) Responsivity=%fo micro watts \n",Po)
\ No newline at end of file diff --git a/374/CH6/EX6.4/64.sci b/374/CH6/EX6.4/64.sci new file mode 100644 index 000000000..e66d708c9 --- /dev/null +++ b/374/CH6/EX6.4/64.sci @@ -0,0 +1,9 @@ +//chapter 6 example 4//
+clc
+clear
+//energy gap=Eg,cut off wavelength=lc,plancks constant=h,speed of light=c//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts/sec//
+Eg=1.43*1.6*(10^-19);
+lc=((h*c)/Eg)*(10^6);
+printf("\n cut off wavelength=%f micro meterc\n",lc)
\ No newline at end of file diff --git a/374/CH6/EX6.5/65.sci b/374/CH6/EX6.5/65.sci new file mode 100644 index 000000000..8eaabed86 --- /dev/null +++ b/374/CH6/EX6.5/65.sci @@ -0,0 +1,16 @@ +//chapter 6 example 5//
+clc
+clear
+//absorption coeffcient=a,refractive index=n1,reflection coeffcient=Rf,fraction of the incident power absorbed=K,distance=d//
+n1=3.5;
+d=3*(10^-6);
+a=10^5;
+W=3*(10^-6);
+Rf=((n1-1)^2)/((n1+1)^2);
+K=exp(-a*d)*(1-(exp(-a*W)))*(1-Rf);
+printf("\n fraction of incident power absorbed=%f \n",K)
+a1=(10^6);
+W1=(10^-6);
+d1=(10^-6);
+K1=exp(-a1*d1)*(1-(exp(-a1*W1)))*(1-Rf);
+printf("\n fraction of incident power absorbed=%f \n",K1)
diff --git a/374/CH6/EX6.6/66.sci b/374/CH6/EX6.6/66.sci new file mode 100644 index 000000000..56f85f4e0 --- /dev/null +++ b/374/CH6/EX6.6/66.sci @@ -0,0 +1,16 @@ +//chapter 6 example 6//
+clc
+clear
+//effeciency=n,charge of electron=e,wavwlength=l,plancks constant=h,speed of light=c,diode current=Ip,multiplication factor=M//
+n=0.7;
+e=1.6*(10^-19);
+l=0.8*(10^-6);//in meters//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts per sec//
+R=(n*e*l)/(h*c);//responsivity//
+printf("\n Responsivity=%f AW-1\n",R)
+Po=0.8*(10^-6);//in watts//
+Ip=(Po*R)*(10^6);//diode current//
+I=10;//in micro amperes//
+M=I/Ip;
+printf("\n Multiplication factor=%f \n",M)
\ No newline at end of file diff --git a/374/CH6/EX6.7/67.sci b/374/CH6/EX6.7/67.sci new file mode 100644 index 000000000..31dfe2cb5 --- /dev/null +++ b/374/CH6/EX6.7/67.sci @@ -0,0 +1,15 @@ +//chapter 6 example 7//
+clc
+clear
+//charge of electron=e,diode current=Id,plancks constant=h,effeciency=n,wavelength=l,area=A,noise equivalent power=NEP,directivity=D//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts per sec//
+e=1.6*(10^-19);//charge of the electron//
+l=1.2*(10^-6);//in mts//
+Id=10*(10^-9);//in amperes//
+n=0.6;
+NEP=((h*c*sqrt(2*e*Id))/(n*e*l))*(10^14);
+printf("\n noise equivalent power=%f*(10^-14) W\n",NEP)
+A=100*50*(10^-12);
+D=(A^0.5)/(NEP*(10^-14));
+printf("\n directivity=%f mHz1/2W-1\n",D)
diff --git a/374/CH6/EX6.8/68.sci b/374/CH6/EX6.8/68.sci new file mode 100644 index 000000000..0ce0599fb --- /dev/null +++ b/374/CH6/EX6.8/68.sci @@ -0,0 +1,15 @@ +//chapter 6 example 8//
+clc
+clear
+//optical gain=Go,charge of the electron=e,speed of the light=c,current supplied=Ic,wavelength=l,common emitter current gain=hFE,effeciency=n//
+h=6.62*(10^-34);
+c=3*(10^8);//in mts per sec//
+e=1.6*(10^-19);//charge of the electron//
+l=1.25*(10^-6);//in mts//
+Po=130*(10^-6);//in watts//
+Ic=16*(10^-3);//in ampers//
+Go=(h*c*Ic)/(e*l*Po);
+printf("\n a) optical gain of the transistor=%f \n",Go)
+n=0.45;
+hFE=Go/n;
+printf("\n b) common emitter current gain=%f \n",hFE)
\ No newline at end of file diff --git a/374/CH6/EX6.9/69.sci b/374/CH6/EX6.9/69.sci new file mode 100644 index 000000000..a851b15c8 --- /dev/null +++ b/374/CH6/EX6.9/69.sci @@ -0,0 +1,8 @@ +//chapter 6 example 9//
+clc
+clear
+//electron transit time=tf,bandwidth=Bm,photoconductive gain=G,//
+tf=8*(10^-12);//in seconds//
+G=60;
+Bm=(1/(2*%pi*tf*G))*(10^-8);
+printf("\n maximum 3dB bandwidth=%f MHz\n",Bm)
\ No newline at end of file diff --git a/374/CH7/EX7.2/72.sci b/374/CH7/EX7.2/72.sci new file mode 100644 index 000000000..a9343cad8 --- /dev/null +++ b/374/CH7/EX7.2/72.sci @@ -0,0 +1,11 @@ +//chapter 7 example 2//
+clc
+clear
+//longitudnal displacement=S,numerical aperure=NA,core radius=a,coupling efficiency=ns1.critical angle=Am//
+NA=0.2;
+Am=asind(NA);//in deg//
+printf("\n critical angle=%f deg\n",Am)
+a=25*(10^-6);//in mts//
+S=2.5*(10^-6);//in mts//
+ns1=((a/(a+(S*tand(Am))))^2)*100;
+printf("\n coupling efficiency=%f percent\n",ns1)
diff --git a/374/CH8/EX8.1/81.sci b/374/CH8/EX8.1/81.sci new file mode 100644 index 000000000..64eea11e0 --- /dev/null +++ b/374/CH8/EX8.1/81.sci @@ -0,0 +1,21 @@ +//chapter 8 example 1//
+clc
+clear
+//photo current of the dode=Ip,quantam efficiency=n,wavelength=l,plancks constant=h,speed of light=c,power at given wave length=Po,total shot noise=i2,thermal noise in the load resistor=i2th,dark current=Id,post detection bandwidth of the receiver=B//
+n=0.50;//quantam efficiency//
+e=1.6*(10^-19);//charge of the electron//
+l=0.85*(10^-6);//in mts//
+h=6.63*(10^-34);//plancks constant//
+c=3*(10^8);
+Po=250*(10^-9);
+Ip=((n*e*Po*l)/(h*c))*(10^9);
+printf("\n a) photo current in the dode=%f nA\n",Ip)
+Id=4;//in nano amperes//
+B=8*(10^6);
+i2=sqrt((2*e*B*(Ip+Id))*(10^11));
+printf("\n b) total shot noise=%f*(10^-10) A\n",i2)
+Kb=1.38*(10^-23);
+T=300;
+Rl=6000;
+ith=sqrt(((4*Kb*T*B)/Rl)*(10^18));
+printf("\n c) thermal noise generated=%f*(10^-9) A\n",ith)
\ No newline at end of file diff --git a/374/CH8/EX8.2/82.sci b/374/CH8/EX8.2/82.sci new file mode 100644 index 000000000..226036a18 --- /dev/null +++ b/374/CH8/EX8.2/82.sci @@ -0,0 +1,11 @@ +//chapter 8 example //
+clc
+clear
+//capacitance of photodoide=Cd,load resistance=Rl,maximum bandwidth=B,bandwidth when system is connected to amplifier=B1//
+B=10*(10^6);//in Hz//
+Cd=5*(10^-12);//in farads//
+Rl=1/(2*%pi*B*Cd);
+printf("\n load resistance=%f \n",Rl)
+Cd1=(5+5)*(10^-12);
+B1=1/(2*%pi*Rl*Cd1);
+printf("\n Bandwidth after amplifier is connected=%f Hz\n",B1)
diff --git a/374/CH8/EX8.3/83.sci b/374/CH8/EX8.3/83.sci new file mode 100644 index 000000000..fa06d5003 --- /dev/null +++ b/374/CH8/EX8.3/83.sci @@ -0,0 +1,18 @@ +//chapter 8 example 3//
+clc
+clear
+//capacitance=Cd,band width=B,temperature=T,current=I,load resistance=Rl,signal to noise ratio=S/N=R,optimum value of multiplication factor=Mopt//
+Cd=6*(10^-12);//in farads//
+B=40*(10^6);//in Hz//
+Rl=1/(2*%pi*Cd*B);//load rsistance//
+printf("\n a) load resistance=%f ohms\n",Rl)
+Kb=1.38*(10^-23);
+T=300;//in kelvin//
+e=1.6*(10^-19);//charge of the electron//
+x=0.3;
+Rl=666;//in ohms//
+Ip=2*(10^-7);
+Mopt=((4*Kb*T)/(e*x*Rl*Ip))^(1/2.3);
+printf("\n b) optimum value of multiplication factor=%f \n",Mopt)
+R=((Mopt*Ip)^2)/((2*e*B*Ip*(Mopt^2.3))+(4*Kb*T*B/Rl))*(0.01089);
+printf("\n c) signal to noise ratio=%f \n",R)
diff --git a/374/CH8/EX8.4.a/84a.sci b/374/CH8/EX8.4.a/84a.sci new file mode 100644 index 000000000..83c59edbb --- /dev/null +++ b/374/CH8/EX8.4.a/84a.sci @@ -0,0 +1,14 @@ +//chapter 8 example 4a//
+clc
+clear
+//bit error=BER,temperature=T,load resistance=R,noise bandwidth=B,ratio=R,minimum power required=Pmin//
+R1=19.6;//in db//
+R2=10^(R1/20);
+R=50;
+K=1.38*(10^-23);
+T=400;//in kelvin//
+B=(10^7);//in Hz//
+is=R2*(sqrt((4*K*T*B)/R))*(10^9);
+R3=0.4;
+Pmin=(is/R3)*(10^-3);
+printf("\n minimum power required to maintain bit error=%f micro watts\n",Pmin)
diff --git a/374/CH8/EX8.4/84.sci b/374/CH8/EX8.4/84.sci new file mode 100644 index 000000000..3e6205f9d --- /dev/null +++ b/374/CH8/EX8.4/84.sci @@ -0,0 +1,20 @@ +//chapter 8 example 4//
+clc
+clear
+//effective input resistance =Ra,maximum band width=B,total capacitance=Ct,mean thermal energy noise current=ith,open loop gain =A,total effective load resistance=Rtl//
+Ra=5*(10^6);//in ohms//
+Rb=5*(10^6);//in ohms//
+Rtl=(Ra*Rb)/(Ra+Rb);//total effective load resistance//
+Ct=5*(10^-12);//in farads//
+B=1/(2*%pi*Rtl*Ct);
+printf("\n a) maximum bandwidth=%f Hz\n",B)
+T=300;//in kelvin//
+Kb=1.38*(10^-23);
+ith=((4*Kb*T)/Rtl)*(10^27);
+printf("\n b) mean thermal energy noise current per unit band width=%f *(10^-27) A2Hz-1\n",ith)
+A=400;//open loop gain//
+Rf=(10^5);//in ohms//
+B1=A/(2*%pi*Rf*Ct);
+printf("\n C) a) maximum bandwidth without eualization for the transimpedance configuration=%f Hz\n",B1)
+ith=((4*Kb*T)/Rf)*(10^25);
+printf("\n C) b) mean square thermal noise current=%f*(10^-25) Hz\n",ith)
\ No newline at end of file diff --git a/374/CH9/EX9.1/91.sci b/374/CH9/EX9.1/91.sci new file mode 100644 index 000000000..f65733c0b --- /dev/null +++ b/374/CH9/EX9.1/91.sci @@ -0,0 +1,11 @@ +//chapter 9 example 1// +clc +clear +//length of multimode fibre=L1,measured output voltage=Vf,measured output voltage after adding=Vn,fibre cut back to a length=L2,attenuation=adB// +L1=2;//in km// +L2=0.002;//in km// +Vn=10;//in volts// +Vf=2.1;//in volts// +p=log(Vn/Vf)*0.43; +adB=(10*p)/(L1-L2); +printf("\n attenuation per km=%f m\n",adB)
\ No newline at end of file diff --git a/374/CH9/EX9.2/92.sci b/374/CH9/EX9.2/92.sci new file mode 100644 index 000000000..35f05e329 --- /dev/null +++ b/374/CH9/EX9.2/92.sci @@ -0,0 +1,11 @@ +//chapter 9 example 2// +clc +clear +//length of multimode fibre=L1,measured output optical pwer at far end=Pf,measured output optical power at near end=Pn,fibre cut back to a length=L2,attenuation=adB// +L1=1.5;//in km// +L2=0.002;//in km// +Pn=385.4;//in microwatts// +Pf=50.1;//in micro watts// +k=log(Pn/Pf)*0.43; +adB=(10*k)/(L1-L2); +printf("\n attenuation per km=%f m\n",adB)
\ No newline at end of file diff --git a/374/CH9/EX9.3/93.sci b/374/CH9/EX9.3/93.sci new file mode 100644 index 000000000..0473588a8 --- /dev/null +++ b/374/CH9/EX9.3/93.sci @@ -0,0 +1,10 @@ +//chapter 9 example 3//
+clc
+clear
+//fibre bandwidth length product=Bopt,3dB pulse dispersion for the fibre in ns km-1=T,time at which output pulses are found=To,time at which input optical pulses are found=Ti//
+To=12.7;//in nano seconds//
+Ti=0.4;//in nano seconds//
+T=(sqrt((To^2)-(Ti^2)))/1.2;//time at which 3dB pulse boardaning is obtained//
+printf("\n a) time at which 3dB pulse boardaning is obtained=%f ns/km\n",T)
+Bopt=(0.44/T)*1000;//optical bandwidth of the fibre//
+printf("\n b) fibre bandwidth length product=%f MHz Km\n",Bopt)
\ No newline at end of file diff --git a/374/CH9/EX9.4.a/94a.sci b/374/CH9/EX9.4.a/94a.sci new file mode 100644 index 000000000..67b4728df --- /dev/null +++ b/374/CH9/EX9.4.a/94a.sci @@ -0,0 +1,11 @@ +//chapter 9 example 4a//
+clc
+clear
+//angular velocity=A,llength at which rotating mirror from the photo detector=L,shadow pulse of width=We,shadow velocity=V,outer diametetr=do//
+L=0.1;//in mts//
+A=4;//in rad sec-1//
+V=L*A;//in mts/sec//
+printf("\n shadow velocity=%f m/sec\n",V)
+We=250;//in micro seconds//
+do=We*V;//outer diameter of the fibre//
+printf("\n outer diamter of the fibre=%f micro meter\n",do)
\ No newline at end of file diff --git a/374/CH9/EX9.4/94.sci b/374/CH9/EX9.4/94.sci new file mode 100644 index 000000000..00b609fbf --- /dev/null +++ b/374/CH9/EX9.4/94.sci @@ -0,0 +1,10 @@ +//chapter 9 example 4//
+clc
+clear
+//angular limit of the far field pattern=Am,length of the picture=l,numerical aperture=NA,distance of the fibre output end face from the screen=L//
+Am=26.1;//in degrees//
+NA=sind(Am);//numerical aperture//
+printf("\n numerical aperture=%f \n",NA)
+l=16.7;//in cm//
+L=(l/2)/(tand(Am));
+printf("\n distance from the screen=%f cm\n",L)
\ No newline at end of file diff --git a/374/CH9/EX9.5.a/95a.sci b/374/CH9/EX9.5.a/95a.sci new file mode 100644 index 000000000..d5a5ca2e1 --- /dev/null +++ b/374/CH9/EX9.5.a/95a.sci @@ -0,0 +1,15 @@ +//chapter 9 example5a//
+clc
+clear
+//input power=P1,output power=P2,output power at the end of added fibre=P3,insertion loss of the connector=Ls,excess loss of the conductor=dLs//
+Po=83.2;//in micro watts//
+Pi=100;//in micro watts//
+Ls=-10*(log(Po/Pi)*0.43)
+printf("\n insertion loss of the connector=%f m\n",Ls)
+Ls=0.8;//in km//
+L=1.8;//in km//
+a=1.9;//constant//
+P3=35.5;//in micro watts//
+k=-(10*(log(P3/Pi)*0.43));
+dLs=k-Ls-(a*L);
+printf("\n loss of the conductor=%f dB\n",dLs)
diff --git a/374/CH9/EX9.5/95.sci b/374/CH9/EX9.5/95.sci new file mode 100644 index 000000000..f36f5f59a --- /dev/null +++ b/374/CH9/EX9.5/95.sci @@ -0,0 +1,8 @@ +//chapter 9 example 5//
+clc
+clear
+//numerical aperture=NA,distance from the screen to fibre end space=D,measured output pattern size=A//
+A=6;//in cm//
+D=10;//in cm//
+NA=A/(sqrt((A^2)+4*(D^2)));
+printf("\n numerical aperture=%f m\n",NA)
\ No newline at end of file |