diff options
author | priyanka | 2015-06-24 15:03:17 +0530 |
---|---|---|
committer | priyanka | 2015-06-24 15:03:17 +0530 |
commit | b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b (patch) | |
tree | ab291cffc65280e58ac82470ba63fbcca7805165 /296 | |
download | Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.tar.gz Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.tar.bz2 Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.zip |
initial commit / add all books
Diffstat (limited to '296')
34 files changed, 420 insertions, 0 deletions
diff --git a/296/CH1/EX1.1/eg1_1.sce b/296/CH1/EX1.1/eg1_1.sce new file mode 100755 index 000000000..947def86d --- /dev/null +++ b/296/CH1/EX1.1/eg1_1.sce @@ -0,0 +1,10 @@ +a = 5; // lattice constant
+b = 0.5*sqrt(a^2 + a^2 +a^2); //separation between nearest atoms
+r = 0.5*b; //radius of each atom
+V = 4/3*%pi*r*r*r; //Volume of each atom
+n = 1+8*0.125; //number of atoms per cube
+pf = V*n/(a*a*a); //packing fraction
+disp("1)")
+disp(a,"lattice constant (in armstrong)=")
+disp(r,"radius of atoms (in armstrong) =")
+disp(pf,"maximum packing fraction =")
\ No newline at end of file diff --git a/296/CH1/EX1.2/eg1_2.sce b/296/CH1/EX1.2/eg1_2.sce new file mode 100755 index 000000000..a879d15c8 --- /dev/null +++ b/296/CH1/EX1.2/eg1_2.sce @@ -0,0 +1,10 @@ +disp("The plane illustrated in Fig. 1-5 has intercepts at 2a, 4b and lc along the three crystal axes. Taking the reciprocals of these intercepts, we get 1/4, 1/2,and 1. These three fractions have the same relationship to each other as the integers 2,1, and 4 (obtained by multiplying each fraction by 4).Thus the plane can be referred to as a (214) plane. The only exception is if the intercept is a fraction of the lattice constant a. In that case, we do not reduce it to the lowest set of integers.")
+x = 0:0.05:2;
+y = 0:0.1:4;
+a=2;
+b=4;
+c=1;
+deff('[z]=fs(x,y)','z = (1-(0.5*x)-(0.25*y))');
+//z = (1-(0.5*x)-(0.25*y));
+fplot3d(x,y,fs);
+
diff --git a/296/CH1/EX1.3/eg1_3.sce b/296/CH1/EX1.3/eg1_3.sce new file mode 100755 index 000000000..ad956ff42 --- /dev/null +++ b/296/CH1/EX1.3/eg1_3.sce @@ -0,0 +1,8 @@ +a = 5.43*10^-8; // lattice constant
+d = (1+4*0.25)/(a*a); //areal density on (100) plane
+n = 2*(6*0.5+8*0.125); //number of atoms per cube
+V = n/(a*a*a); //volume density
+disp("3)")
+disp(a,"lattice constant (in cm)=")
+disp(d,"areal density on (100) plane (in per cm square) =")
+disp(V,"volume density (in per cm cube) =")
\ No newline at end of file diff --git a/296/CH1/EX1.4/eg1_4.sce b/296/CH1/EX1.4/eg1_4.sce new file mode 100755 index 000000000..19a3d9d40 --- /dev/null +++ b/296/CH1/EX1.4/eg1_4.sce @@ -0,0 +1,16 @@ +n = 10^16; // desired density of P atoms
+k = 0.35;
+l = 5000; //initial load of Si in grams
+w =31;//atomic weight of P
+d = 2.33; //density of Si
+i = n/k; //initial concentration of P in melt, assuming C(S)=kC(L)
+V = l/d; //volume of Si
+N = i*V; //number of P atoms
+W = N*w/(6.02*10^23)
+disp("4.a)")
+disp(n,"desired density of P atoms (per cubic centimeter)=")
+disp(i,"initial concentration of P in melt (in per cubic cm )=")
+disp("4.b)")
+disp(V,"Volume of Si (in cubic cm) =")
+disp(N,"number of P atoms =")
+disp(W,"weight of phosphorus to be added(in grams) =")
\ No newline at end of file diff --git a/296/CH2/EX2.1/eg2_1.sce b/296/CH2/EX2.1/eg2_1.sce new file mode 100755 index 000000000..d83d6b4bd --- /dev/null +++ b/296/CH2/EX2.1/eg2_1.sce @@ -0,0 +1,4 @@ +//j=complex(0,1);
+//psi = A*exp(j*k*x);
+disp("px = h_cross*k(x)");
+disp("If we try to evaluate these integrals directly, we run into the problem that both numerator and denominator tend to infinity, because an ideal plane wave is strictly not a normalizable wave function. The trick to use is to choose the limits of integration from, say, -L/2 to +L/2 in a region of length L.The factor L cancels out in the numerator and denominator. Then we can consider L approaches infinity. For wave functions that are normalizable, such a mathematical trickdoes not have to be used.")
\ No newline at end of file diff --git a/296/CH3/EX3.1/eg3_1.sce b/296/CH3/EX3.1/eg3_1.sce new file mode 100755 index 000000000..baa0da668 --- /dev/null +++ b/296/CH3/EX3.1/eg3_1.sce @@ -0,0 +1,4 @@ +//j=complex(0,1);
+//psi = U*exp(j*k*x);
+disp("px = h_cross*k(x)");
+disp("With infinite limits of integration, both the numerator and denominator are infinite. For problems of this type, one integrates between the finite limits -LI2 and +L/2 and, in the final result, then assumes that L approaches infinity. This result implies that (E, k) diagrams can be considered plots of electron energy vs. momentum, with a scaling factor h_cross.")
\ No newline at end of file diff --git a/296/CH3/EX3.2/eg3_2.png b/296/CH3/EX3.2/eg3_2.png Binary files differnew file mode 100755 index 000000000..99af937bc --- /dev/null +++ b/296/CH3/EX3.2/eg3_2.png diff --git a/296/CH3/EX3.2/eg3_2.sce b/296/CH3/EX3.2/eg3_2.sce new file mode 100755 index 000000000..3c94cbc98 --- /dev/null +++ b/296/CH3/EX3.2/eg3_2.sce @@ -0,0 +1,7 @@ +//p = m*v
+//p = h*k; //electron momentum, where h is constant
+//E = 0.5*p*p/m
+//E = 0.5*h*k*k/m; //electron energy
+k = -10:0.01:10; //limits on wave vector k
+E = k^2; // E is proportional to square of wave vector
+plot(k,E)
\ No newline at end of file diff --git a/296/CH3/EX3.3/eg3_3.sce b/296/CH3/EX3.3/eg3_3.sce new file mode 100755 index 000000000..e1fcdf665 --- /dev/null +++ b/296/CH3/EX3.3/eg3_3.sce @@ -0,0 +1,10 @@ +n = 1;
+epsilonr = 11.8; //relative dielectric constant for silicon
+epsilon = 8.85*10^-12; //dielectric constant
+m = 9.11*10^-31; //mass of electron
+mn = 0.26*m; //for silicon
+h = 6.63*10^-34;
+q = 1.6*10^-19; //electronic charge
+r = 10^10*(epsilonr*epsilon*h*h)/(mn*q*q*%pi); //radius in armstrong
+disp(r,"radius of electron orbit around donor (in armstrong) =")
+disp("This is more than 4 lattice spacings a = 5.43 armstrong.")
\ No newline at end of file diff --git a/296/CH3/EX3.4/eg3_4.sce b/296/CH3/EX3.4/eg3_4.sce new file mode 100755 index 000000000..1a85a4c45 --- /dev/null +++ b/296/CH3/EX3.4/eg3_4.sce @@ -0,0 +1,7 @@ +m = 9.11*10^-31; //mass of electron
+ml = 0.98*m;
+ms = 0.19*m;
+mn = 6^(2/3)*(ml*ms*ms)^(1/3); //density of states effective mass calculation
+mn0 = mn/m;
+disp(mn,"density of states effective mass (in kilogram)=")
+disp(mn0,"density of states effective mass in proportion to mass of electron= ")
\ No newline at end of file diff --git a/296/CH3/EX3.5/eg3_5.sce b/296/CH3/EX3.5/eg3_5.sce new file mode 100755 index 000000000..0f38190c2 --- /dev/null +++ b/296/CH3/EX3.5/eg3_5.sce @@ -0,0 +1,8 @@ +n0 = 10^17; //concentration of electrons
+ni = 1.5*10^10; //intrinsic concentration
+T = 300; //(temperature in Kelvin)
+p0 = ni*ni/n0; // concentration of holes
+k = 0.0259; //Boltzmann's constant multiplied with T = 300
+E = k*log(n0/ni);
+disp(p0,"concentration of holes (in per cubic centimeter)=")
+disp(E,"Fermi level energy with respect to intrinsic level energy (in electron volt)=")
\ No newline at end of file diff --git a/296/CH3/EX3.6/eg3_6.sce b/296/CH3/EX3.6/eg3_6.sce new file mode 100755 index 000000000..071e10a6e --- /dev/null +++ b/296/CH3/EX3.6/eg3_6.sce @@ -0,0 +1,7 @@ +m = 9.11*10^-31; //mass of electron
+ml = 0.98*m;
+mt = 0.19*m;
+mninverse = (1/3) * ((1/ml)+(2/mt));
+mn = 1/mninverse;
+mn0 = mn/m;
+disp(mn0,"Conductivity effective mass in proportion to mass of an electron =")
\ No newline at end of file diff --git a/296/CH3/EX3.7/eg3_7.sce b/296/CH3/EX3.7/eg3_7.sce new file mode 100755 index 000000000..ae5719c89 --- /dev/null +++ b/296/CH3/EX3.7/eg3_7.sce @@ -0,0 +1,14 @@ +un= 700;
+q = 1.6*10^-19;
+n0 = 10^17;
+L = 0.1;
+A = 10^-6;
+V = 10;
+sigma = q*un*n0;
+rho = 1/sigma;
+R = rho*L/A;
+I = V/R;
+disp(sigma,"Conductivity (in per ohm-cm)=")
+disp(rho,"resistivity (in ohm-cm)=")
+disp(R,"resistance (in ohm)=")
+disp(I,"current (in ampere)=")
\ No newline at end of file diff --git a/296/CH3/EX3.8/eg3_8.sce b/296/CH3/EX3.8/eg3_8.sce new file mode 100755 index 000000000..531daf87b --- /dev/null +++ b/296/CH3/EX3.8/eg3_8.sce @@ -0,0 +1,16 @@ +w = 0.01;
+w1 = w*10^-3
+t = 10^-3;
+L = 0.5;
+B = 10*10^-5;
+I = 10^-3;
+Vab = -2 *10^-3;
+Vcd = 0.1;
+q = 1.6*10^-19;
+q1 = q*10^-3
+n0 = I*B/(q1*-Vab);
+rho = (Vcd/I)/(L/w1);
+u = 1/(rho*q*n0);
+disp(n0,"electron concentration (in per cubic centimeter)=")
+disp(rho,"resisitivity (in ohm-cm)=")
+disp(u,"mobility (in square cm per volt-sec)=")
\ No newline at end of file diff --git a/296/CH4/EX4.1/eg4_1.sce b/296/CH4/EX4.1/eg4_1.sce new file mode 100755 index 000000000..526991062 --- /dev/null +++ b/296/CH4/EX4.1/eg4_1.sce @@ -0,0 +1,12 @@ +t = 0.46 *10^-4;
+hv = 2;
+alpha = 5*10^4;
+I0 = 10^-2;
+It = I0*exp(-alpha*t);
+Pabs = I0 - It;
+f = (2-1.43)/2;
+P = f*Pabs;
+n = Pabs/(1.6*10^-19*hv);
+disp(Pabs,"total energy absorbed per second (in watt)=")
+disp(P,"amount of energy converted to heat per second (in watt)=")
+disp(n,"number of photons per second given off form recombination events =")
\ No newline at end of file diff --git a/296/CH4/EX4.2/eg4_2.png b/296/CH4/EX4.2/eg4_2.png Binary files differnew file mode 100755 index 000000000..6168978d8 --- /dev/null +++ b/296/CH4/EX4.2/eg4_2.png diff --git a/296/CH4/EX4.2/eg4_2.sce b/296/CH4/EX4.2/eg4_2.sce new file mode 100755 index 000000000..b38f9f8cf --- /dev/null +++ b/296/CH4/EX4.2/eg4_2.sce @@ -0,0 +1,19 @@ +p0 = 10^15;
+ni = 10^6;
+n0 = ni^2/p0;
+disp(n0,"Minority electron concentration (in per cubic centimeter)=" )
+dn = 10^14;
+dp = 10^14;
+tn = 10; //in nanoseconds
+tp = tn;
+t = 0:10:50;
+del_n = dn*exp(-t/tn);
+del_p = dp*exp(-t/tp);
+p = p0 + del_p;
+n = del_n; //since n0 is negligible
+subplot(121);
+plot(t,log(p));
+plot(t,log(n));
+subplot(122);
+plot(t,p);
+plot(t,n);
\ No newline at end of file diff --git a/296/CH4/EX4.2/eg4_2_log.png b/296/CH4/EX4.2/eg4_2_log.png Binary files differnew file mode 100755 index 000000000..cf47561e7 --- /dev/null +++ b/296/CH4/EX4.2/eg4_2_log.png diff --git a/296/CH4/EX4.3/eg4_3.sce b/296/CH4/EX4.3/eg4_3.sce new file mode 100755 index 000000000..9da55f89b --- /dev/null +++ b/296/CH4/EX4.3/eg4_3.sce @@ -0,0 +1,7 @@ +n0 = 10^14;
+ni = 1.5*10^10;
+Tn = 2 *10^-6;
+Tp = 2 *10^-6;
+p = 2*10^13;
+p0 = ni^2/n0;
+disp(p0,"hole concentration (per cubic centimeter)=")
\ No newline at end of file diff --git a/296/CH4/EX4.4/eg4_4.sce b/296/CH4/EX4.4/eg4_4.sce new file mode 100755 index 000000000..1bb8d4982 --- /dev/null +++ b/296/CH4/EX4.4/eg4_4.sce @@ -0,0 +1,11 @@ +n0 = 10^14;
+dn = 2*10^13;
+n = n0+dn;
+kT = 0.0259;
+ni = 1.5*10^10;
+Ei = kT*log(n0/ni);
+Fn = Ei + kT*log(n/ni);
+E = Fn-Ei;
+disp(n,"steady state electron concentration=")
+disp(Ei,"equilibrium Fermi level (in eV)=")
+disp(E,"electron quasi Fermi level position(in eV)=")
\ No newline at end of file diff --git a/296/CH4/EX4.5/eg4_5.sce b/296/CH4/EX4.5/eg4_5.sce new file mode 100755 index 000000000..6fcf32355 --- /dev/null +++ b/296/CH4/EX4.5/eg4_5.sce @@ -0,0 +1,23 @@ +A = 0.5;
+Na = 10^17;
+p0 = Na;
+ni = 1.5*10^10;
+dp = 5*10^16;
+x = 10^-5;
+up = 500;
+Tp = 10^-10;
+kT = 0.0259;
+q0 = 1;
+q = 1.6*10^-19;
+Dp = kT*up/q0;
+Lp = sqrt(Dp*Tp);
+p = p0 + dp*exp(-x/Lp);
+E = kT*log(p/ni);
+E0 = 1.1/2 + E;
+Ip = q*A*Dp*dp*exp(-x/Lp)/Lp;
+Qp = q*A*dp*Lp;
+Qp0 = Qp*10^6;
+disp(E0,"steady state separation between Fp and Ec (in eV)=")
+disp(Ip,"hole current (in ampere)=")
+disp(Qp,"excess stored hole charge (in coulomb)=")
+disp(Qp0,"excess stored hole charge (in micro-coulomb)=")
\ No newline at end of file diff --git a/296/CH4/EX4.6/eg4_6.sce b/296/CH4/EX4.6/eg4_6.sce new file mode 100755 index 000000000..0ee3d1c66 --- /dev/null +++ b/296/CH4/EX4.6/eg4_6.sce @@ -0,0 +1,13 @@ +l = 1;
+d = 0.95;
+E0 = 2;
+t = 0.25*10^-3;
+dt = 117*10^-6;
+up = (d/t)/(E0/l);
+Dp = dt^2*d^2/(16*t^3);
+C = Dp/up;
+kT = 0.0259;
+disp(up,"hole mobility (in square cm per Volt-second)=")
+disp(Dp,"diffusion coefficient (in square cm per second)=")
+disp(C,"Diffisuion coefficient/Hole mobility (in volts) = ")
+disp("Verified according to Einstein Relation")
\ No newline at end of file diff --git a/296/CH5/EX5.1/eg5_1.sce b/296/CH5/EX5.1/eg5_1.sce new file mode 100755 index 000000000..44ad3afda --- /dev/null +++ b/296/CH5/EX5.1/eg5_1.sce @@ -0,0 +1,13 @@ +Na = 10^18;
+Nd = 5*10^15;
+ni = 1.5*10^10;
+kT = 0.0259;
+E1 = kT*log(Na/ni);
+E2 = kT*log(Nd/ni);
+qV1 = E1+E2;
+qV2 = kT*log(Na*Nd/ni^2);
+disp(E1,"Fermi level position in p region (in eV)=")
+disp(E2,"Fermi level position in n region (in eV)=")
+disp(qV1,"Contact potential (in eV)=")
+disp(qV2,"Contact potential (in eV)=")
+disp("Contact potential value verified")
\ No newline at end of file diff --git a/296/CH5/EX5.2/eg5_2.sce b/296/CH5/EX5.2/eg5_2.sce new file mode 100755 index 000000000..c00ad2d16 --- /dev/null +++ b/296/CH5/EX5.2/eg5_2.sce @@ -0,0 +1,23 @@ +Na = 10^18;
+Nd = 5*10^15;
+ni = 1.5*10^10;
+kT = 0.0259;
+epsilon0 = 8.85*10^-14;
+epsilon = 11.8;
+q = 1.6*10^-19;
+E1 = kT*log(Na/ni);
+E2 = kT*log(Nd/ni);
+qV1 = E1+E2;
+qV2 = kT*log(Na*Nd/ni^2);
+d = 10*10^-4; //in centimetre
+A = %pi*d^2/4;
+W = sqrt(2*epsilon*epsilon0*qV1/q *(Na^-1 + Nd^-1));
+xn0 = W/(1+(Nd/Na));
+xp0 = W/(1+(Na/Nd));
+Q = q*A*xn0*Nd;
+E0 = -q*xn0*Nd/(epsilon*epsilon0);
+disp(W*10^4,"width of the transition region(in micron)=")
+disp(xn0*10^4,"penetration of the space charge region into the n material (in micron)=")
+disp(xp0*10^4,"penetration of the space charge region into the p material (in micron)=")
+disp(Q,"total uncompensated charge (in coulomb)=")
+disp(E0,"maximum electric field(in V per cm)=")
\ No newline at end of file diff --git a/296/CH5/EX5.4/eg5_4.sce b/296/CH5/EX5.4/eg5_4.sce new file mode 100755 index 000000000..7de5a544e --- /dev/null +++ b/296/CH5/EX5.4/eg5_4.sce @@ -0,0 +1,29 @@ +A = 10^-4;
+kT = 0.0259;
+ni = 1.5*10^10;
+q = 1.6*10^-19;
+q0 = 1;
+Na = 10^17;
+Nd = 10^15;
+Tn = 10^-7;
+Tp = 10^-5;
+upp = 200;
+unn = 1300;
+unp = 700;
+upn = 450;
+V1 = 0.5;
+V2 = -0.5;
+pn = ni^2/Nd;
+np = ni^2/Na;
+Dp = kT*upn/q0;
+Dn = kT*unp/q0;
+Lp = sqrt(Dp*Tp);
+Ln = sqrt(Dn*Tn);
+I1 = q*A*((Dp*pn/Lp)+(Dn*np/Ln))*(exp(q0*V1/kT)-1);
+I2 = -q*A*((Dp*pn/Lp)+(Dn*np/Ln));
+disp(pn,"hole concentration (per cubic centmeter)=")
+disp(np,"electron concentration (per cubic centmeter)=")
+disp(Dp,"diffusion coefficient on n side(in square centimter per second)=")
+disp(Dn,"diffusion coefficient on p side(in square centimter per second)=")
+disp(I1*10^6,"current at forward bias (in microampere)=")
+disp(I2*10^6,"current at reverse bias (in microampere)=")
diff --git a/296/CH5/EX5.6/eg5_6.sce b/296/CH5/EX5.6/eg5_6.sce new file mode 100755 index 000000000..19db12109 --- /dev/null +++ b/296/CH5/EX5.6/eg5_6.sce @@ -0,0 +1,15 @@ +A = 10^-4;
+kT = 0.0259;
+ni = 1.5*10^10;
+q = 1.6*10^-19;
+Na = 10^17;
+Nd = 10^15;
+epsilon0 = 8.85*10^-14;
+epsilon = 11.8;
+E1 = kT*log(Na/ni);
+E2 = kT*log(Nd/ni);
+V0 = E1+E2;
+V = -4;
+Cj = sqrt(epsilon*epsilon0)*A*sqrt(q*Nd*Na/(2*(V0-V)*(Na+Nd)));
+disp(V0,"V0 (in volt)=")
+disp(Cj,"total depletion constant (in farad)=")
diff --git a/296/CH5/EX5.7/eg5_7.sce b/296/CH5/EX5.7/eg5_7.sce new file mode 100755 index 000000000..7c7c528a7 --- /dev/null +++ b/296/CH5/EX5.7/eg5_7.sce @@ -0,0 +1,7 @@ +dEtg = 1.85;
+band_gap = 1.43; //for GaAs-AlGaAs system
+dEg = dEtg - band_gap;
+dEc = dEg*2/3;
+dEv = dEg/3;
+disp(dEc, "Conduction band offset(in eV) =")
+disp(dEv, "Valence band offset(in eV) =")
\ No newline at end of file diff --git a/296/CH6/EX6.1/eg6_1.sce b/296/CH6/EX6.1/eg6_1.sce new file mode 100755 index 000000000..737e5c9d9 --- /dev/null +++ b/296/CH6/EX6.1/eg6_1.sce @@ -0,0 +1,28 @@ +kT = 0.0259;
+ni = 1.5*10^10;
+q = 1.6*10^-19;
+q0 = 1;
+epsilon0 = 8.85*10^-14;
+epsilon = 11.8;
+epsiloni = 3.9;
+Na = 5*10^15;
+d = 10^-6;
+Qi = 4*10^10*q;
+Vf = kT*log(Na/ni)/q0;
+Wm = 2*sqrt(epsilon*epsilon0*Vf/(q*Na));
+Vms = -0.95;
+Ci = epsiloni*epsilon0/d;
+Vfb = Vms -(Qi/Ci);
+Qd = -q*Na*Wm;
+Vt = Vfb-Qd/Ci+2*Vf;
+Cd = epsilon*epsilon0/Wm;
+Cmin = Ci*Cd/(Ci+Cd);
+disp(Vf,"Phi(F) (in eV)=")
+disp(Wm*10^4,"W(m) (in micron)=")
+disp(Qi,"effective interface charge (in coulomb per square cm)=")
+disp(Ci*10^6,"C(i) (in microfarad per square cm)=")
+disp(Vfb,"V(fb)(in V)=")
+disp(Qd,"Q(d)(in coulomb per square cm)=")
+disp(Vt,"V(T) (in V)=")
+disp(Cd*10^6,"C(d) (in microfarad per square cm)=")
+disp(Cmin,"C(min) (in farad per square cm)=")
\ No newline at end of file diff --git a/296/CH6/EX6.2/eg6_2.sce b/296/CH6/EX6.2/eg6_2.sce new file mode 100755 index 000000000..2011d528a --- /dev/null +++ b/296/CH6/EX6.2/eg6_2.sce @@ -0,0 +1,26 @@ +kT = 0.0259;
+ni = 1.5*10^10;
+q = 1.6*10^-19;
+q0 = 1;
+epsilon0 = 8.85*10^-14;
+epsilon = 11.8;
+epsiloni = 3.9;
+Na = 5*10^15;
+d = 10^-6;
+Vt = 0.6;
+Z = 25*10^-4;
+L = 10^-4;
+Vg1 = 5;
+Vd1 = 0.1;
+Vg2=3;
+Vd2=5;
+Vdsat = Vg2-Vt;
+Vd3=7;
+un = 200;
+Ci = epsiloni*epsilon0/d;
+Id1 = (Z*un*Ci/L)*((Vg1-Vt)*Vd1-0.5*Vd1^2); //linear region
+Id2 = (Z*un*Ci/L)*((Vg2-Vt)*Vdsat-0.5*Vdsat^2); //saturation region
+disp(Ci*10^6,"C(i) (in microfarad per square cm)=")
+disp(Id1*10^3,"For V(G)=5V and V(D)=0.1V, we are in the linear region and drain current (in miliampere)=")
+disp(Id2*10^3,"For V(G)=3V and V(D)=5V, we are in the saturation region and drain current (in miliampere)=")
+disp("For VD = 7 V, ID will not increase, because we are in the saturation region.")
\ No newline at end of file diff --git a/296/CH6/EX6.3/eg6_3.sce b/296/CH6/EX6.3/eg6_3.sce new file mode 100755 index 000000000..39bf50c06 --- /dev/null +++ b/296/CH6/EX6.3/eg6_3.sce @@ -0,0 +1,16 @@ +q = 1.6*10^-19;
+q0 = 1;
+epsilon0 = 8.85*10^-14;
+epsilon = 11.8;
+epsiloni = 3.9;
+d = 10^-6;
+Vt1 = -1.1;
+Vt2 = -0.5;
+I = 10^-5;
+A = 650;
+Ci = epsiloni*epsilon0/d;
+Fb = (Vt2-Vt1)*Ci/q;
+t = Fb*q*A/I;
+disp(Ci*10^6,"C(i) (in microfarad per square cm)=")
+disp(Fb,"boron ion dose required (in per square cm)=")
+disp(t,"implant time (in second)=")
\ No newline at end of file diff --git a/296/CH7/EX7.1/eg7_1.sce b/296/CH7/EX7.1/eg7_1.sce new file mode 100755 index 000000000..c9693895d --- /dev/null +++ b/296/CH7/EX7.1/eg7_1.sce @@ -0,0 +1,8 @@ +tp = 10^-5;
+ts = 10^-7;
+ib = 10^-4;
+ic = 10^-2;
+Qn = ic*ts;
+Qp = ib*tp;
+disp(Qp,"steady state charge due to excess holes (in coulomb)=")
+disp(Qn,"steady state charge due to excess electrons (in coulomb)=")
\ No newline at end of file diff --git a/296/CH7/EX7.4/eg7_4.sce b/296/CH7/EX7.4/eg7_4.sce new file mode 100755 index 000000000..ed9a96dca --- /dev/null +++ b/296/CH7/EX7.4/eg7_4.sce @@ -0,0 +1,40 @@ +A=10^-4;
+q = 1.6*10^-19;
+kT = 0.0259;
+Wb = 10^-4;
+ni = 1.5*10^10;
+Na = 10^17;
+Tn = 10^-7;
+upe=200;
+une=700;
+Nd = 10^15;
+Tp=10^-5;
+unb=1300;
+upb=450;
+Veb = 0.3;
+Vcb = -40;
+pn = ni^2/Nd;
+Dp = upb*kT;
+Lp = sqrt(Dp*Tp);
+Ies = q*A*Dp*pn/Lp*(csch(Wb/Lp)+tanh(Wb/Lp));
+dpe = pn*exp(Veb/kT);
+Ib = q*A*Dp*dpe/Lp*tanh(Wb/2*Lp);
+Ib1 = q*A*Wb*dpe/(2*Tp);
+Dn = kT*une;
+Ln = sqrt(Dn*Tn);
+gamma1 = (1+((Dn*Lp*Nd)/(Dp*Ln*Na))*tanh(Wb/Lp))^-1;
+B = sech(Wb/Lp);
+alpha = B*gamma1;
+beta1 = alpha/(1-alpha);
+disp(pn,"hole concentration (in per cubic centimeter)=")
+disp(Dp,"Dp (in sqaure centimeter per second)=")
+disp(Lp*10,"Lp(in micrometer) =")
+disp(dpe,"dp(E)(in per cubic centimeter) =")
+disp(Ies,"I(ES) (in ampere)=")
+disp(Ib1,"I(B) (in ampere)=")
+disp(Dn,"Dn (in sqaure centimeter per second)=")
+disp(Ln*10,"Ln (in micrometer)=")
+disp(gamma1,"gamma =")
+disp(B,"B =")
+disp(alpha,"alpha =")
+disp(beta1,"beta =")
diff --git a/296/CH8/EX8.2/eg8_2.sce b/296/CH8/EX8.2/eg8_2.sce new file mode 100755 index 000000000..b2f66d2e9 --- /dev/null +++ b/296/CH8/EX8.2/eg8_2.sce @@ -0,0 +1,5 @@ +Isc=100;
+Voc=0.8;
+ff = 0.7;
+Pmax = ff*Isc*Voc;
+disp(Pmax,"maximum power delivered(in miliwatt)=")
\ No newline at end of file diff --git a/296/CH8/EX8.3/eg8_3.sce b/296/CH8/EX8.3/eg8_3.sce new file mode 100755 index 000000000..a54e81295 --- /dev/null +++ b/296/CH8/EX8.3/eg8_3.sce @@ -0,0 +1,4 @@ +wavelength = 0.68;
+Eg = 1.24/wavelength;
+disp(Eg,"band gap (in eV)=")
+disp("From Fig, 3-6, we get Al(0.32)Ga(0.68)As. From Fig. 8-11, we get GaAs(0.68)P(0.32)")
\ No newline at end of file |