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 /539 | |
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 '539')
83 files changed, 1839 insertions, 0 deletions
diff --git a/539/CH10/EX10.1.a/Example_10_1a.sce b/539/CH10/EX10.1.a/Example_10_1a.sce new file mode 100755 index 000000000..15c91ed5c --- /dev/null +++ b/539/CH10/EX10.1.a/Example_10_1a.sce @@ -0,0 +1,22 @@ +//Computation of Critical Nuclear Radius
+
+clear;
+clc;
+
+printf("\tExample 10.1\n");
+
+printf("\n\tPart A");
+Hf=-1.16*10^9; // in J/m^3 latent heat of fusion
+Y=0.132; // in J/m^2 Surface energy
+Tm=1064+273; // in K Melting point of gold
+T=1064+273-230; // in K 230 is supercooling value
+
+r=-2*Y*Tm/(Hf*(Tm-T));
+
+printf("\nCritical Radius is : %.2f nm\n",r/10^-9);
+
+G=16*%pi*Y^3*Tm^2/(3*Hf^2*(Tm-T)^2);
+
+printf("\nActivation free energy is : %.2e J\n",G);
+
+//end
\ No newline at end of file diff --git a/539/CH10/EX10.1.b/Example_10_1b.sce b/539/CH10/EX10.1.b/Example_10_1b.sce new file mode 100755 index 000000000..04e505679 --- /dev/null +++ b/539/CH10/EX10.1.b/Example_10_1b.sce @@ -0,0 +1,25 @@ +//Activation Free Energy
+
+clear;
+clc;
+
+printf("\tExample 10.1\n");
+
+Hf=-1.16*10^9; // in J/m^3 latent heat of fusion
+Y=0.132; // in J/m^2 Surface energy
+Tm=1064+273; // in K Melting point of gold
+T=1064+273-230; // in K 230 is supercooling value
+r=-2*Y*Tm/(Hf*(Tm-T));
+
+printf("\n\tPart B");
+a=0.413*10^-9; // in m Unit Cell edge length
+
+//unit cells per paticle
+u_c=4*%pi*r^3/(3*a^3);
+
+printf("\nUnit cells per paricle are : %d",u_c);
+printf("\nIn FCC there are 4 atoms per unit cell.\n");
+
+printf("\nTotal no. of atoms per critical nucleus are : %d\n",int(u_c)*4);
+
+//End
\ No newline at end of file diff --git a/539/CH10/EX10.2/Example_10_2.sce b/539/CH10/EX10.2/Example_10_2.sce new file mode 100755 index 000000000..33ffe94dc --- /dev/null +++ b/539/CH10/EX10.2/Example_10_2.sce @@ -0,0 +1,20 @@ +//Determination the rate of recrystallization
+
+clear;
+clc;
+
+printf("\tExample 10.2\n");
+n=5;
+y=0.3;
+t=100; //in min
+
+
+k=-log(1-y)/t^n;
+
+thalf=(-log(1-0.5)/k)^(1/n);
+
+rate=1/thalf;
+
+printf("\nRate is %.2e (min)^-1\n",rate);
+
+//End
\ No newline at end of file diff --git a/539/CH12/EX12.1/Example_12_1.sce b/539/CH12/EX12.1/Example_12_1.sce new file mode 100755 index 000000000..0cafe2f4d --- /dev/null +++ b/539/CH12/EX12.1/Example_12_1.sce @@ -0,0 +1,16 @@ +//Computation of Minimum Caion-to-Anion Radius Ratio forCo-ordination No. of 3
+
+clear;
+clc;
+
+printf("\tExample 12.1\n");
+
+printf("\nFor equilateral triangle after joining centres of the atoms \nAngle = 30\n");
+
+a=30;
+
+ratio=(1-cos(30*%pi/180))/cos(30*%pi/180);
+
+printf("\nCation to anion raio is : %.3f\n",ratio);
+
+//End
\ No newline at end of file diff --git a/539/CH12/EX12.2/Example_12_2.sce b/539/CH12/EX12.2/Example_12_2.sce new file mode 100755 index 000000000..3d1070ca2 --- /dev/null +++ b/539/CH12/EX12.2/Example_12_2.sce @@ -0,0 +1,19 @@ +//Ceramic Crystal structure prediction
+
+clear;
+clc;
+
+printf("\tExample 12.2\n");
+
+r_Fe=0.077; // in nm Radius of iron cation Fe++
+
+r_O=0.140; //in nm Radius of Oxygen anion O--
+
+ratio=r_Fe/r_O;
+
+printf("\nRatio is : %0.3f",ratio);
+
+if ratio>0.414 & ratio<0.732 then
+ printf("\nCo-ordinaton no. is 6");
+ printf("\nStructure is Rock Salt type\n");
+end
\ No newline at end of file diff --git a/539/CH12/EX12.3/Example_12_3.sce b/539/CH12/EX12.3/Example_12_3.sce new file mode 100755 index 000000000..6b2c383a3 --- /dev/null +++ b/539/CH12/EX12.3/Example_12_3.sce @@ -0,0 +1,25 @@ +//Theoretical Density Determination for NaCl
+
+clear;
+clc;
+
+printf("\tExample12.3\n");
+
+A_Na=22.99; // in g/mol
+A_Cl=35.45; //in g/mol
+
+r_Na=0.102*10^-7; //in cm Radius of Na+ ion
+r_Cl=0.181*10^-7; //in cm Radius of Cl- ion
+
+a=2*(r_Na+r_Cl);
+V=a^3;
+
+n=4; //For FCC, no. of atoms are 4 per crystal
+
+Na=6.023*10^23; //Avogadro number
+
+density=n*(A_Na+A_Cl)/(V*Na);
+
+printf("\nDensity is : %0.2f g/cm^3\n",density);
+
+//End
\ No newline at end of file diff --git a/539/CH12/EX12.4/Example_12_4.sce b/539/CH12/EX12.4/Example_12_4.sce new file mode 100755 index 000000000..874891e57 --- /dev/null +++ b/539/CH12/EX12.4/Example_12_4.sce @@ -0,0 +1,26 @@ +//Computation of the No. of Schottky Defects in KCl
+
+clear;
+clc;
+
+printf("\tExample 12.4\n");
+
+Na=6.023*10^23; //Avogadro number
+density=1.955; //in g/cm^3
+
+A_K=39.1; //in g/mol
+A_Cl=35.45; //in g/mol
+
+N=Na*density*10^6/(A_K+A_Cl);
+
+printf("\nNo. of lattice points are : %0.2f * 10 ^ 28 /m^3\n",N/10^28);
+
+Qs=2.6; // in eV
+k=8.62*10^-5; // in eV/K Boltzmann Constant
+T=500+273; // in K
+
+Ns=N*%e^(-Qs/(2*k*T));
+
+printf("\nSchottky Defects are : %0.2f * 10 ^ 19 /m^3\n",Ns/10^19);
+
+//End
\ No newline at end of file diff --git a/539/CH12/EX12.5/Example_12_5.sce b/539/CH12/EX12.5/Example_12_5.sce new file mode 100755 index 000000000..ad53f44bf --- /dev/null +++ b/539/CH12/EX12.5/Example_12_5.sce @@ -0,0 +1,16 @@ +//Determination of Possible Point Defect Types
+
+clear;
+clc;
+
+printf("\tExample 12.5\n");
+
+disp("Replacement of Na+ by a Ca++ ion introduces one extra positive charge");
+
+disp("Removal of a positive charge is accomplished by the formation of one Na+ vacancy");
+
+disp("Alternatively, a Cl- interstitial will supply an additional negative charge, negating the effect of each Ca++ ion.");
+
+disp("The formation of this defect is highly unlikely.");
+
+//End
\ No newline at end of file diff --git a/539/CH14/EX14.2.a/Example_14_2a.sce b/539/CH14/EX14.2.a/Example_14_2a.sce new file mode 100755 index 000000000..d214aea7a --- /dev/null +++ b/539/CH14/EX14.2.a/Example_14_2a.sce @@ -0,0 +1,24 @@ +//Computations of the Density
+
+clear;
+clc;
+
+printf("\tExample 14.2\n");
+
+printf("\n\tPart A");
+Ac=12.01; //in g/mol Molecular weight of Carbon
+Ah=1.008; //in g/mol molecular weight of hydrogen
+a=7.41*10^-8; //in cm
+b=4.94*10^-8; //in cm
+c=2.55*10^-8; //in cm
+Na=6.023*10^23;
+
+Vc=a*b*c;
+n=2;
+A=(2*Ac)+(4*Ah);
+
+density_c=n*A/(Vc*Na);
+
+printf("\nDensity is : %f g/cm^3\n",density_c);
+
+//End
\ No newline at end of file diff --git a/539/CH14/EX14.2.b/Example_14_2b.sce b/539/CH14/EX14.2.b/Example_14_2b.sce new file mode 100755 index 000000000..03a985f99 --- /dev/null +++ b/539/CH14/EX14.2.b/Example_14_2b.sce @@ -0,0 +1,29 @@ +//Percent Crystallinity of Polyethylene
+
+clear;
+clc;
+
+printf("\tExample 14.2\n");
+
+printf("\n\tPart B");
+density_a=0.870; // in g/cm^3
+density_s=0.925; // in g/cm^3
+
+Ac=12.01; //in g/mol Molecular weight of Carbon
+Ah=1.008; //in g/mol molecular weight of hydrogen
+a=7.41*10^-8; //in cm
+b=4.94*10^-8; //in cm
+c=2.55*10^-8; //in cm
+Na=6.023*10^23;
+
+Vc=a*b*c;
+n=2;
+A=(2*Ac)+(4*Ah);
+
+density_c=n*A/(Vc*Na);
+
+pc=density_c*(density_s-density_a)*100/(density_s*(density_c-density_a));
+
+printf("\npercentage crystallinity is : %.1f %%\n",pc);
+
+//End
\ No newline at end of file diff --git a/539/CH14/EX14.3.a/Example_14_3a.sce b/539/CH14/EX14.3.a/Example_14_3a.sce new file mode 100755 index 000000000..add1a5de5 --- /dev/null +++ b/539/CH14/EX14.3.a/Example_14_3a.sce @@ -0,0 +1,23 @@ +//Computations of Diffusion Flux of Carbon dioxide through Plasic Beverage Container
+
+clear;
+clc;
+
+function[A]= approx(V,n)
+ A= round(V*10^n)/10^n;
+ funcprot(0)
+endfunction
+
+printf("\tExample 14.3\n");
+
+printf("\n\tPart A");
+P1=400000; // in Pa Pressure inside the bottle
+P2=400; // in Pa Pressure outside the bottle
+Pm=0.23*10^-13; //Solubility Coefficient
+dx=0.05; // in cm Thickness of wall
+
+J=approx(-Pm*(P2-P1)/dx,8);
+printf("\nDiffusion flux is : %.2f * 10 ^ -6 ",J/10^-6);
+printf("cm^3 STP/cm^2-s\n");
+
+//End
\ No newline at end of file diff --git a/539/CH14/EX14.3.b/Example_14_3b.sce b/539/CH14/EX14.3.b/Example_14_3b.sce new file mode 100755 index 000000000..3ff38ddcf --- /dev/null +++ b/539/CH14/EX14.3.b/Example_14_3b.sce @@ -0,0 +1,30 @@ +//Beverage Shell Life
+
+clear;
+clc;
+
+function[A]= approx(V,n)
+ A= round(V*10^n)/10^n;
+ funcprot(0)
+endfunction
+
+printf("\tExample 14.3\n");
+
+P1=400000; // in Pa Pressure inside the bottle
+P2=400; // in Pa Pressure outside the bottle
+Pm=0.23*10^-13; //Solubility Coefficient
+dx=0.05; // in cm Thickness of wall
+
+J=approx(-Pm*(P2-P1)/dx,8);
+
+printf("\n\tPart B");
+A=500; //surface area of bottle in cm^2
+V_lose=750; //cm^3 STP
+
+V=J*A;
+t=V_lose/V;
+time=t/(3600*24);
+
+printf("\nTime to escape is : %.2e sec or %d days\n",t,time);
+
+//End
\ No newline at end of file diff --git a/539/CH16/EX16.1.a/Example_16_1a.sce b/539/CH16/EX16.1.a/Example_16_1a.sce new file mode 100755 index 000000000..b3165dc9d --- /dev/null +++ b/539/CH16/EX16.1.a/Example_16_1a.sce @@ -0,0 +1,16 @@ +clear;
+clc;
+
+x=poly([0],'x');
+printf("\tExample 16.1\n");
+
+printf("\n\tPart A");
+E_gf=69; // in GPa Elasticity of glass fibre
+mf_gf=0.4; //Vol % of glass fibre
+E_pr=3.4; // in GPa Elasticity of poyester resin
+mf_pr=0.6; //Vol % of polyester resin
+
+E_cl=(E_pr*mf_pr)+(E_gf*mf_gf);
+printf("\nModulus of elasticity of composite is : %f GPa\n",E_cl);
+
+//End
\ No newline at end of file diff --git a/539/CH16/EX16.1.b/Example_16_1b.sce b/539/CH16/EX16.1.b/Example_16_1b.sce new file mode 100755 index 000000000..ca8f6a244 --- /dev/null +++ b/539/CH16/EX16.1.b/Example_16_1b.sce @@ -0,0 +1,23 @@ +clear;
+clc;
+
+x=poly([0],'x');
+printf("\tExample 16.1\n");
+
+E_gf=69; // in GPa Elasticity of glass fibre
+mf_gf=0.4; //Vol % of glass fibre
+E_pr=3.4; // in GPa Elasticity of poyester resin
+mf_pr=0.6; //Vol % of polyester resin
+
+printf("\n\tPart B");
+Ac=250; //mm^2
+sigma=50; //MPa
+f=(E_gf*mf_gf)/(E_pr*mf_pr);
+Fc=Ac*sigma; //N
+Fm=roots(f*x+x-Fc); //N
+printf("\nFm is : %f N\n",Fm);
+
+Ff=Fc-Fm;
+printf("\nLoad carried by each of fiber and matrix phase is : %f N\n",Ff);
+
+//End
\ No newline at end of file diff --git a/539/CH16/EX16.1.c/Example_16_1c.sce b/539/CH16/EX16.1.c/Example_16_1c.sce new file mode 100755 index 000000000..8066ebdec --- /dev/null +++ b/539/CH16/EX16.1.c/Example_16_1c.sce @@ -0,0 +1,32 @@ +clear;
+clc;
+
+x=poly([0],'x');
+printf("\tExample 16.1\n");
+
+E_gf=69; // in GPa Elasticity of glass fibre
+mf_gf=0.4; //Vol % of glass fibre
+E_pr=3.4; // in GPa Elasticity of poyester resin
+mf_pr=0.6; //Vol % of polyester resin
+
+Ac=250; //mm^2
+sigma=50; //MPa
+f=(E_gf*mf_gf)/(E_pr*mf_pr);
+Fc=Ac*sigma; //N
+Fm=roots(f*x+x-Fc); //N
+
+Ff=Fc-Fm;
+
+printf("\n\tPart C");
+Am=mf_pr*Ac;
+Af=mf_gf*Ac;
+sigma_m=Fm/Am;
+sigma_f=Ff/Af;
+
+e_m=sigma_m/E_pr; //Strain for matrix phase
+e_f=sigma_f/E_gf; //Strain for fiber phase
+
+printf("\nStrain for matrix phase is : %f\n",e_m);
+printf("\nStrain for fiber phase is : %f\n",e_f);
+
+//End
\ No newline at end of file diff --git a/539/CH16/EX16.2/Example_16_2.sce b/539/CH16/EX16.2/Example_16_2.sce new file mode 100755 index 000000000..61f618d10 --- /dev/null +++ b/539/CH16/EX16.2/Example_16_2.sce @@ -0,0 +1,16 @@ +//Elastic Modulus Determination for a Glass Fiber-Reinforced Composite—Transverse Direction
+
+clear;
+clc;
+
+printf("\tExample 16.2\n");
+E_gf=69; // in GPa Elasticity of glass fibre
+mf_gf=0.4; //Vol % of glass fibre
+E_pr=3.4; // in GPa Elasticity of poyester resin
+mf_pr=0.6; //Vol % of polyester resin
+
+E_ct=E_pr*E_gf/((E_pr*mf_gf)+(E_gf*mf_pr)); //GPa
+
+printf("\nIn transverse direction, modulus of elaticity is : %f GPa\n",E_ct);
+
+//End
\ No newline at end of file diff --git a/539/CH17/EX17.1/Example_17_1.sce b/539/CH17/EX17.1/Example_17_1.sce new file mode 100755 index 000000000..f9047f214 --- /dev/null +++ b/539/CH17/EX17.1/Example_17_1.sce @@ -0,0 +1,26 @@ +//Determination of Electrochemical Cell Characteristics
+
+clear;
+clc;
+
+printf("\tExample 17.1\n");
+
+V_Cd=-0.403; //Half Cell Potential of Cd++|Cd
+V_Ni=-0.250; //Half Cell Potential of Ni++|Ni
+dV=V_Ni-V_Cd;
+printf("\nStandard Cell potential is : %f V\n",dV);
+
+C_Ni=10^-3;
+C_Cd=0.5;
+n=2; //Net electron exchange in Redox reaction
+V=-dV-(0.0592*log10(C_Ni/C_Cd)/n);
+printf("\nNet EMF is : %f V\n",V);
+printf("\nHence\n");
+
+if V<0 then
+ printf("\nNi is reduced & Cd is oxidised\n");
+else
+ printf("\nCd is reduced & Ni is oxidised\n");
+end
+
+//End
\ No newline at end of file diff --git a/539/CH17/EX17.2.a/Example_17_2a.sce b/539/CH17/EX17.2.a/Example_17_2a.sce new file mode 100755 index 000000000..e13b391f7 --- /dev/null +++ b/539/CH17/EX17.2.a/Example_17_2a.sce @@ -0,0 +1,28 @@ +//Rate of Oxidation Computation
+
+clear;
+clc;
+
+printf("\tExample 17.2a\n");
+
+//Activation polarisation data
+VH_H2=0;
+VZn_Zn2=-0.763;
+iZn=10^-7;
+iH2=10^-10;
+beta_Zn=0.09;
+beta_H2=-0.08;
+
+//Part i
+ic=10^[(VH_H2-VZn_Zn2-(beta_H2*log10(iH2))+(beta_Zn*log10(iZn)))/(beta_Zn-beta_H2)];
+
+disp(ic,'ic is ');
+
+n=2; //Exchange of 2 electrons
+F=96500; //Faradays constant
+
+r=ic/(n*F);
+printf("\ni) Rate of oxiadation is %.1f * 10^-10 mol/cm^2-s\n",r/10^-10);
+
+
+//End
\ No newline at end of file diff --git a/539/CH17/EX17.2.b/Example_17_2b.sce b/539/CH17/EX17.2.b/Example_17_2b.sce new file mode 100755 index 000000000..59603bc74 --- /dev/null +++ b/539/CH17/EX17.2.b/Example_17_2b.sce @@ -0,0 +1,20 @@ +clear;
+clc;
+
+printf("\tExample 17.2b\n");
+
+//Activation polarisation data
+VH_H2=0;
+VZn_Zn2=-0.763;
+iZn=10^-7;
+iH2=10^-10;
+beta_Zn=0.09;
+beta_H2=-0.08;
+
+ic=10^[(VH_H2-VZn_Zn2-(beta_H2*log10(iH2))+(beta_Zn*log10(iZn)))/(beta_Zn-beta_H2)];
+
+//Part ii
+Vc=VH_H2+(beta_H2*log10(ic/iH2));
+printf("\nii) Corrosion potential is %.3f V\n",Vc);
+
+//End
\ No newline at end of file diff --git a/539/CH17/EX17.3/Example_17_3.sce b/539/CH17/EX17.3/Example_17_3.sce new file mode 100755 index 000000000..cc3464163 --- /dev/null +++ b/539/CH17/EX17.3/Example_17_3.sce @@ -0,0 +1,23 @@ +//Temperature Computation
+
+clear;
+clc;
+
+printf("\tExample 17.3\n");
+
+dV=0.568; //Potential diff. b/w 2 electrodes
+V_Pb=-0.126;
+V_Zn=-0.763;
+
+C_Zn=0.01;
+C_Pb=0.0001;
+
+R=8.31; //Gas constt
+F=96500; //Faraday's constt
+n=2; //electron exchange
+
+T=-n*F*(dV-(V_Pb-V_Zn))/(R*log(C_Zn/C_Pb));
+
+printf("\nFinal temp is %.1f K\n",T);
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.1/Example_18_1.sce b/539/CH18/EX18.1/Example_18_1.sce new file mode 100755 index 000000000..3fe575aa2 --- /dev/null +++ b/539/CH18/EX18.1/Example_18_1.sce @@ -0,0 +1,21 @@ +//Computation of the Room-Temperature Intrinsic Carrier Concentration for Gallium Arsenide
+
+clear;
+clc;
+
+printf("\t Example 18.1\n");
+
+sigma=10^-6; // (Ohm-m)^-1 Electrical Conductivity
+
+e=1.6*10^-19; //Coulomb Charge on electron
+
+m_e=0.85; //m^2/V-s Mobility of electron
+
+m_h=0.04; //m^2/V-s Mobility of holes
+
+//ni is Intrinsic carrier concentration
+ni=sigma/(e*(m_e+m_h));
+
+printf("\n Intrinsic Carrier Concentration is: %f m^-3\n",ni);
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.2/Example_18_2.sce b/539/CH18/EX18.2/Example_18_2.sce new file mode 100755 index 000000000..968b0865d --- /dev/null +++ b/539/CH18/EX18.2/Example_18_2.sce @@ -0,0 +1,23 @@ +//Electrical Conductivity Determination for Intrinsic Silicon at 150°C
+
+clear;
+clc;
+
+printf("\t Example 18.2\n");
+
+e=1.6*10^-19; //Coulomb Charge on electron
+
+ni=4*10^19; //For Si at 423 K (m^-3)
+
+//Values of m_e and m_h are deduced from graphs at page No.689
+
+m_e=0.06; //m^2/V-s Mobility of electron
+
+m_h=0.022; ////m^2/V-s Mobility of holes
+
+//sigma is electrical conductivity
+sigma=ni*e*(m_e+m_h);
+
+printf("\nElectrical Conductivity is : %f (Ohm-m)^-1\n",sigma);
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.3.b/Example_18_3b.sce b/539/CH18/EX18.3.b/Example_18_3b.sce new file mode 100755 index 000000000..5e4332c25 --- /dev/null +++ b/539/CH18/EX18.3.b/Example_18_3b.sce @@ -0,0 +1,24 @@ +//Room-Temperature for Extrinsic Silicon
+
+clear;
+clc;
+
+printf("\tExample 18.3\n");
+printf("\n\tPart B\n ");
+
+n=10^23; //m^-3 Carrier Concentration
+
+e=1.6*10^-19; //Coulomb Charge on electron
+
+//From graph 18.18 m_e is calculated corresponding to n=10^23
+
+m_e=0.07; //m^2/V-s Mobility of electron
+
+//For extrinsic n-type, the formula used is:
+
+sigma=n*e*m_e;
+
+printf("\nConductivity at n=10^23 is : %d (Ohm-m)^-1\n",sigma);
+
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.3.c/Example_18_3c.sce b/539/CH18/EX18.3.c/Example_18_3c.sce new file mode 100755 index 000000000..519a9f7b3 --- /dev/null +++ b/539/CH18/EX18.3.c/Example_18_3c.sce @@ -0,0 +1,22 @@ +//Elevated-Temperature Electrical Conductivity Calculations for Extrinsic Silicon
+
+clear;
+clc;
+
+printf("\tExample 18.3\n");
+
+n=10^23; //m^-3 Carrier Concentration
+
+e=1.6*10^-19; //Coulomb Charge on electron
+
+printf("\n\tPart C\n");
+
+//From graph 18.19a m_e2 is calculated corresponding to 373 K
+
+m_e2=0.04; //m^2/V-s Mobility of electron
+
+sigma2=n*e*m_e2;
+
+printf("\nConductivity at T=373 K becomes : %d (Ohm-m)^-1\n",sigma2);
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.4/Example_18_4.sce b/539/CH18/EX18.4/Example_18_4.sce new file mode 100755 index 000000000..5a3384864 --- /dev/null +++ b/539/CH18/EX18.4/Example_18_4.sce @@ -0,0 +1,26 @@ +//Hall Voltage Computation
+
+clear;
+clc;
+
+printf("\tExample 18.4\n");
+
+sigma=3.8*10^7; //(Ohm-m)^-1 Electrical Conductivity
+
+m_e=0.0012; //m^2/V-s Mobility of electron
+
+Rh=-m_e/sigma; //Hall coefficient
+
+printf("\nHall coefficient is : %f * 10^-11 V-m/A-Tesla\n",Rh/10^-11);
+
+Ix=25; //Ampere(A) Current
+
+d=15*10^-3; //m Thickness
+
+Bz=0.6; //Tesla Magnetic field
+
+Vh=Rh*Ix*Bz/d;
+
+printf("\nHall Voltage is : %f * 10^-8 V\n",Vh/10^-8);
+
+//End
\ No newline at end of file diff --git a/539/CH18/EX18.6/Design_Example_18_1.sce b/539/CH18/EX18.6/Design_Example_18_1.sce new file mode 100755 index 000000000..964ca930e --- /dev/null +++ b/539/CH18/EX18.6/Design_Example_18_1.sce @@ -0,0 +1,29 @@ +//Acceptor Impurity Doping in Silicon
+
+clear;
+clc;
+
+printf("\tDesign Example 18.1\n");
+
+e=1.6D-19; //Charge on electron in Coulomb
+p=[10^22 10^21 8D21]; //Conc. of holes m^-3
+uh=[0.04 0.045 0.04]; //Mobility of holes
+
+for i=1:3
+ sigma(i)=p(i)*e*uh(i);
+end
+
+disp('(Ohm-m)^-1',sigma(3),'conductivity is','m^2/V-s',uh(3),'m^-3',p(3),'For hole conc and mobility');
+
+Na=6.023D23; //Avogadro no.
+den_Si=2.33D6; //Density of silicon in g/m^3
+A_Si=28.09; //Atomic weight of silicon
+
+N_Si=Na*den_Si/A_Si;
+
+
+Ca=p(3)/(p(3)+N_Si)*100;
+
+printf("\nThus, Silicon material must contain %.1f * 10^-5 %% B,Al,Ga or In\n",Ca/10^-5);
+
+//End
\ No newline at end of file diff --git a/539/CH19/EX19.1/Example_19_1.sce b/539/CH19/EX19.1/Example_19_1.sce new file mode 100755 index 000000000..271147ec5 --- /dev/null +++ b/539/CH19/EX19.1/Example_19_1.sce @@ -0,0 +1,20 @@ +// Calculation of maximum temperature
+
+clear;
+clc;
+
+printf("\t Example 19.1\n");
+
+To=20; // Room Temperature (degree celsius)
+
+sigma=-172; //Mpa Compressive stress
+
+E=100*10^3; //Mpa Young's modulus
+
+a=20*10^-6; //Celsius^-1 Coefficient of thermal expansion
+
+Tf=To-(sigma/(E*a));
+
+printf("\nFinal Temperature is : %d C\n",Tf);
+
+//End
\ No newline at end of file diff --git a/539/CH19/EX19.2/Example_19_2.sce b/539/CH19/EX19.2/Example_19_2.sce new file mode 100755 index 000000000..d6a717d3a --- /dev/null +++ b/539/CH19/EX19.2/Example_19_2.sce @@ -0,0 +1,20 @@ +//Final temperature Calculation
+
+clear;
+clc;
+
+printf("\tExample 19.2\n");
+
+m=10; //mass in lbm
+dQ= 65; //Heat supplied in Btu
+To=77; //Initial temp in F
+
+Cp=375*2.39*10^-4; //in Btu/lbm - F
+
+dT=dQ/(m*Cp);
+
+Tf=To+dT;
+
+printf("\nFinal temp is %.1f F\n",Tf);
+
+//End
\ No newline at end of file diff --git a/539/CH19/EX19.3/Example_19_3.sce b/539/CH19/EX19.3/Example_19_3.sce new file mode 100755 index 000000000..4a48a3a36 --- /dev/null +++ b/539/CH19/EX19.3/Example_19_3.sce @@ -0,0 +1,34 @@ +//Computation of specific heats for Al and Fe
+
+clear;
+clc;
+
+printf("\tExample 19.3\n");
+
+Cp_Al=900; //In J/kg-K
+Cp_Fe=448; //In j/kg-K
+
+beta_Al=1.77D-11;
+beta_Fe=2.65D-12;
+
+T=273;
+
+alphal_Al=23.6D-6;
+alphal_Fe=11.8D-6;
+
+alphav_Al=3*alphal_Al;
+alphav_Fe=3*alphal_Fe;
+
+den_Al=2.71D3; //in kg/m^3
+den_Fe=7.87D3; //in kg/m^3
+
+vo_Al=1/den_Al;
+vo_Fe=1/den_Fe;
+
+Cv_Al=Cp_Al-(alphav_Al^2*vo_Al*T/beta_Al);
+Cv_Fe=Cp_Fe-(alphav_Fe^2*vo_Fe*T/beta_Fe);
+
+printf("\nCv (Al) = %d J/kg-K",Cv_Al);
+printf("\nCv (Fe) = %d T/kg-K\n",Cv_Fe);
+
+//End
\ No newline at end of file diff --git a/539/CH20/EX20.1.a/Example_20_1_a.sce b/539/CH20/EX20.1.a/Example_20_1_a.sce new file mode 100755 index 000000000..51cd3f4e4 --- /dev/null +++ b/539/CH20/EX20.1.a/Example_20_1_a.sce @@ -0,0 +1,27 @@ +//Example 20.1 Calculation of saturation magnetisation and flux density for Nickel
+
+clear;
+clc;
+
+printf("Example 20.1\n");
+
+b_m=9.27*10^-24; //ampere*m^2 (Bohr Magneton)
+
+Na=6.023*10^23; //atoms/mol (Avogadro's No.)
+
+d=8.9*10^6; //g/m^3 (density)
+
+uo=4*%pi*10^-7; //Permitivity of free space
+
+A=58.71; //g/mol (Atomic weigth of Nickel)
+
+N=d*Na/A; //No. of atoms per cubic meter
+
+// M is saturation magnetisation
+M=0.6*b_m*N; //0.6= Bohr Magneton/atom
+
+printf("\nSaturation Magnetisation is : %d Ampere/m",M);
+
+
+
+// End
\ No newline at end of file diff --git a/539/CH20/EX20.1.b/Example_20_1_b.sce b/539/CH20/EX20.1.b/Example_20_1_b.sce new file mode 100755 index 000000000..ccb7d8834 --- /dev/null +++ b/539/CH20/EX20.1.b/Example_20_1_b.sce @@ -0,0 +1,29 @@ +//Example 20.1 Calculation of saturation magnetisation and flux density for Nickel
+
+clear;
+clc;
+
+printf("Example 20.1\n");
+
+b_m=9.27*10^-24; //ampere*m^2 (Bohr Magneton)
+
+Na=6.023*10^23; //atoms/mol (Avogadro's No.)
+
+d=8.9*10^6; //g/m^3 (density)
+
+uo=4*%pi*10^-7; //Permitivity of free space
+
+A=58.71; //g/mol (Atomic weigth of Nickel)
+
+N=d*Na/A; //No. of atoms per cubic meter
+
+// M is saturation magnetisation
+M=0.6*b_m*N; //0.6= Bohr Magneton/atom
+
+
+//B = Saturation Flux Density
+B=uo*M;
+
+printf("\nSaturation Flux Density is : %f Tesla\n",B);
+
+// End
\ No newline at end of file diff --git a/539/CH20/EX20.2/Example_20_2.sce b/539/CH20/EX20.2/Example_20_2.sce new file mode 100755 index 000000000..13b69719e --- /dev/null +++ b/539/CH20/EX20.2/Example_20_2.sce @@ -0,0 +1,19 @@ +//Example 20.2 Calculation of saturation magnetisation of Fe3O4
+
+clear;
+clc;
+
+printf("Example 20.2\n");
+
+a=0.839*10^-9; //a is edge length in m
+
+b_m=9.27*10^-24; //ampere*m^2 (Bohr Magneton)
+
+nb=8*4; //8 is no. of Fe++ ions per unit cell
+ //4 is Bohr magnetons per Fe++ ion
+
+M=nb*b_m/a^3; //M is Saturation magnetisation
+
+printf("\nSaturation Magnetisation is : %f Ampere/m\n",M);
+
+//End
\ No newline at end of file diff --git a/539/CH20/EX20.3/Design_Example_20_1.sce b/539/CH20/EX20.3/Design_Example_20_1.sce new file mode 100755 index 000000000..67cc49af4 --- /dev/null +++ b/539/CH20/EX20.3/Design_Example_20_1.sce @@ -0,0 +1,27 @@ +//Design Example 20.1: Designing a cubic mixed-ferrite magnetic material
+
+clear;
+clc;
+
+printf(" Design Example 20.1\n");
+
+x=poly([0],'x'); // Defining X
+
+Ms_Fe=5.25*10^5; //Required saturation Magnetisation
+
+b_m=9.27*10^-24; //ampere*m^2 (Bohr Magneton)
+
+a=0.839*10^-9; //a is edge length in m
+
+M=5*10^5; //From previous question result
+
+nb=Ms_Fe*a^3/b_m;
+
+// 'x' represent fraction of Mn++ that have substituted Fe++
+
+n=roots(8*[5*x+4*(1-x)]-nb); //5 is Bohr magnetons per Fe++ ion
+ //4 is Bohr magnetons per Mn++ ion
+
+printf("\nReplacing %f percent of Fe++ with Mn++ would produce the required saturation magnetisation\n",n*100);
+
+//End
\ No newline at end of file diff --git a/539/CH21/EX21.1/Example_21_1.sce b/539/CH21/EX21.1/Example_21_1.sce new file mode 100755 index 000000000..ae2dcaa12 --- /dev/null +++ b/539/CH21/EX21.1/Example_21_1.sce @@ -0,0 +1,22 @@ +//Example 20.1 Calculation of absorption coefficient
+
+clear;
+clc;
+
+printf("\tExample 21.1\n");
+
+// x is thickness of glass(mm)
+x=200;
+
+//It is intensity of non-absorbed radiation
+//Io is intensity of non-relected radiation
+
+f=0.98; //f=It/Io
+
+//b is absorption coefficient
+
+b=-log(f)/x;
+
+printf("\nAbsorption coefficient is %f mm^-1\n",b);
+
+//End
\ No newline at end of file diff --git a/539/CH21/EX21.2/Example_21_2.sce b/539/CH21/EX21.2/Example_21_2.sce new file mode 100755 index 000000000..6a53cce94 --- /dev/null +++ b/539/CH21/EX21.2/Example_21_2.sce @@ -0,0 +1,21 @@ +//Velocity of light in diamond
+
+clear;
+clc;
+
+printf("\tExample 21.2\n");
+
+er=5.5; //Relative permitivity
+xm=-2.17D-5; //Magnetic Suseptibility
+
+eo=8.85D-12; //Permitivity in free space
+uo=4*%pi*10^-7; //Permeability
+
+e=er*eo;
+u=uo*(1+xm);
+
+v=1/sqrt(u*e);
+
+printf("\nVelocity in diamond is %.2e m/s\n",v);
+
+//End
\ No newline at end of file diff --git a/539/CH21/EX21.3/Example_21_3.sce b/539/CH21/EX21.3/Example_21_3.sce new file mode 100755 index 000000000..05128eb14 --- /dev/null +++ b/539/CH21/EX21.3/Example_21_3.sce @@ -0,0 +1,20 @@ +//Suitable material required
+
+clear;
+clc;
+
+printf("\tExample 21.3\n");
+
+R=0.05;
+n=poly([0],'x');
+
+//R = (ns-1/ns+1)^2 leading to the equation
+// 0.95ns^2-2.1ns+0.95 = 0
+//HencE
+
+ns=roots((0.95*n^2)-(2.1*n)+0.95);
+
+disp(ns,'The values of ns are: ");
+printf("Thus, soda-lime glass, Pyrex glass, and polyprop would be suitable for this application.");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.1/Example_3_1.sce b/539/CH3/EX3.1/Example_3_1.sce new file mode 100755 index 000000000..f2ee6469e --- /dev/null +++ b/539/CH3/EX3.1/Example_3_1.sce @@ -0,0 +1,19 @@ +//Determination of FCC Unit Cell Volume
+
+clear;
+clc;
+
+printf("\tExample 3.1\n");
+
+//For FCC a=2*R*sqrt(2)
+R=poly([0],'R');
+
+//Edge Length
+a=2*R*sqrt(2);
+
+//Volume determination
+V=a^3;
+
+disp(V,"Volume is");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.11/Example_3_11.sce b/539/CH3/EX3.11/Example_3_11.sce new file mode 100755 index 000000000..c477af9f3 --- /dev/null +++ b/539/CH3/EX3.11/Example_3_11.sce @@ -0,0 +1,22 @@ +//Determination of Miller–Bravais Indices for a Plane Within a Hexagonal Unit Cell
+
+clear;
+clc;
+
+printf("\tExample 3.11\n");
+
+//This plane intersects the a1 axis at a distance a from the origin of the a1-a2-a3-z coordinate axes system.
+
+//Furthermore, its intersections withthe a2 and z axes are -a and c.
+
+//Therefore, in terms of the lattice parameters, these intersections are 1, -1 and 1.
+
+h=1;
+k=-1;
+l=1;
+i=-(h+k);
+
+x=[h k i l];
+disp(x,"The indices of plane are");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.12.a/Example_3_12a.sce b/539/CH3/EX3.12.a/Example_3_12a.sce new file mode 100755 index 000000000..00d7ef890 --- /dev/null +++ b/539/CH3/EX3.12.a/Example_3_12a.sce @@ -0,0 +1,17 @@ +//Interplanar Spacing
+
+clear;
+clc;
+
+printf("\tExample 3.12\n");
+
+a=0.2866; //Lattice parameter in nm
+h=2;
+k=2;
+l=0;
+
+printf("\n\tPart A");
+d_hkl=a/(sqrt(h^2+k^2+l^2));
+printf("\nInterplanar spacing is %.4f nm\n",d_hkl);
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.12.b/Example_3_12b.sce b/539/CH3/EX3.12.b/Example_3_12b.sce new file mode 100755 index 000000000..c6e1ab9ed --- /dev/null +++ b/539/CH3/EX3.12.b/Example_3_12b.sce @@ -0,0 +1,22 @@ +//Diffraction Angle Computations
+
+clear;
+clc;
+
+printf("\tExample 3.12\n");
+
+a=0.2866; //Lattice parameter in nm
+h=2;
+k=2;
+l=0;
+
+d_hkl=a/(sqrt(h^2+k^2+l^2));
+
+printf("\n\tPart B");
+lambda=0.1790; //Wavelength in nm
+n=1;
+
+theta=asind(n*lambda/(2*d_hkl));
+printf("\nDiffraction angle is %.2f degree\n",2*theta);
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.2/Example_3_2.sce b/539/CH3/EX3.2/Example_3_2.sce new file mode 100755 index 000000000..6f4ce5a9f --- /dev/null +++ b/539/CH3/EX3.2/Example_3_2.sce @@ -0,0 +1,28 @@ +//Computation of the Atomic Packing Factor for FCC
+
+clear;
+clc;
+
+printf("\tExample 3.2\n");
+
+//for FCC no. of atoms are 4
+n=4;
+
+//For FCC a=2*R*sqrt(2)
+R=poly([0],'R');
+
+//Edge Length
+a=2*R*sqrt(2);
+
+//Volume determination of cube
+Vc=a^3;
+
+//Volume of sphere
+Vs=n*4*%pi*R^3/3;
+
+//Atomic packing Fraction
+APF=Vs/Vc;
+
+disp(APF,"Atomic packing fraction is");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.3/Example_3_3.sce b/539/CH3/EX3.3/Example_3_3.sce new file mode 100755 index 000000000..a29d59aa1 --- /dev/null +++ b/539/CH3/EX3.3/Example_3_3.sce @@ -0,0 +1,21 @@ +//Theoretical Density Computation for Copper
+
+clear;
+clc;
+
+printf("\tExample 3.3\n");
+
+R=1.28D-08; //Atomic radius in cm
+A_Cu=63.5; //Atomic wt of copper
+n=4; //For FCC
+
+Na=6.023D23; //Avogadro no.
+
+a=2*R*sqrt(2);
+Vc=a^3;
+
+den=n*A_Cu/(Vc*Na);
+
+printf("\nDensity is %.2f g/cm^3\n",den);
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.5/Example_3_5.sce b/539/CH3/EX3.5/Example_3_5.sce new file mode 100755 index 000000000..d48845fc0 --- /dev/null +++ b/539/CH3/EX3.5/Example_3_5.sce @@ -0,0 +1,23 @@ +//Specification of Point Coordinates
+
+clear;
+clc;
+
+printf("\tExample 3.5\n");
+
+disp("Point coordinates for given positions of BCC cell are");
+
+A=['Point_no','x_axis','y_axis','z_axis','Coordinates';
+' 1','0','0','0','000';
+' 2','1','0','0','100';
+' 3','1','1','0','110';
+' 4','0','1','0','010';
+' 5','1/2','1/2','1/2','1/2 1/2 1/2';
+' 6','0','0','1','001';
+' 7','1','0','1','101';
+' 8','1','1','1','111';
+' 9','0','1','1','011'];
+
+disp(A);
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.6/Example_3_6.sce b/539/CH3/EX3.6/Example_3_6.sce new file mode 100755 index 000000000..179e0f349 --- /dev/null +++ b/539/CH3/EX3.6/Example_3_6.sce @@ -0,0 +1,19 @@ +//Determination of Directional Indices
+
+clear;
+clc;
+
+printf("\tExample 3.6\n");
+
+printf("\nThe procedure is summarised as :\n");
+
+A=[' ','x','y','z';
+'Projections','a/2','b','0c';
+'In terms of a,b,c','1/2','1','0';
+'Reduction','1','2','0'];
+
+disp(A);
+
+printf("\nEnclosure [1 2 0]\n");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.8/Example_3_8.sce b/539/CH3/EX3.8/Example_3_8.sce new file mode 100755 index 000000000..6f036f5cd --- /dev/null +++ b/539/CH3/EX3.8/Example_3_8.sce @@ -0,0 +1,23 @@ +//Determination of Directional Indices for a Hexagonal Unit Cell
+
+clear;
+clc;
+
+printf("\tExample 3.8\n");
+
+//From the construction shown in the book
+du=1;
+dv=1;
+dw=1;
+
+//The above indices are for parallelopiped
+//To convert it for hexagonal system
+u=(2*du-dv)/3;
+v=(2*dv-du)/3;
+t=-(u+v);
+w=dw;
+
+x=[u v t w]*3;
+disp(x,"The indices for the given directions are");
+
+//End
\ No newline at end of file diff --git a/539/CH3/EX3.9/Example_3_9.sce b/539/CH3/EX3.9/Example_3_9.sce new file mode 100755 index 000000000..3e0e522f7 --- /dev/null +++ b/539/CH3/EX3.9/Example_3_9.sce @@ -0,0 +1,12 @@ +//Determination of Planar (Miller) Indices
+
+clear;
+clc;
+
+printf("\tExample 3.9\n");
+
+x=[0 -1 2];
+
+disp(x,"The intercept for the given plane is");
+
+//End
\ No newline at end of file diff --git a/539/CH4/EX4.1/Example_4_1.sce b/539/CH4/EX4.1/Example_4_1.sce new file mode 100755 index 000000000..079fe67e6 --- /dev/null +++ b/539/CH4/EX4.1/Example_4_1.sce @@ -0,0 +1,23 @@ +//Number of Vacancies Computation at a Specified temperature
+
+clear;
+clc;
+
+printf("\tExample 4.1\n");
+
+Na=6.023*10^23; //Avogadro No.
+den=8.4D+06; //Density of Copper
+A=63.5; //Atomic weight of Copper
+
+//No. of atomic site per cubic meter
+N=Na*den/A;
+
+//No. of vacancies at 1000 C
+Qv=0.9; //Activation energy in eV
+k=8.62*10^-5; //Boltzmann Constatnt in eV/K
+T=1000+273; //Temperature in K
+
+Nv=N*exp(-Qv/(k*T));
+printf("\nNo.of vacancies are %.1f * 10^25 /m^3",Nv/10^25);
+
+//End
\ No newline at end of file diff --git a/539/CH4/EX4.3/Example_4_3.sce b/539/CH4/EX4.3/Example_4_3.sce new file mode 100755 index 000000000..14e42cfb3 --- /dev/null +++ b/539/CH4/EX4.3/Example_4_3.sce @@ -0,0 +1,26 @@ +//Composition Conversion- From weight percent to Atom percent
+
+clear;
+clc;
+
+printf("\t Example 4.3\n");
+
+//Conversion to Atom percent
+function[C]=conc(C1,C2,A1,A2)
+ C=C1*A2*100/((C1*A2)+(C2*A1));
+ funcprot(0)
+endfunction
+
+
+C_Al=97; //Aluminium wt%
+C_Cu=3; //Copper wt%
+A_Al=26.98; //Atomic wt of Aluminium
+A_Cu=63.55; //Atomic wt of Copper
+
+CAl=conc(C_Al,C_Cu,A_Al,A_Cu);
+CCu=conc(C_Cu,C_Al,A_Cu,A_Al);
+
+printf("\nAtomic %% of Al is %.1f %%",CAl);
+printf("\nAtomic %% of Cu is %.1f %%\n",CCu);
+
+//End
\ No newline at end of file diff --git a/539/CH4/EX4.4.a/Example_4_4a.sce b/539/CH4/EX4.4.a/Example_4_4a.sce new file mode 100755 index 000000000..fa5cc145d --- /dev/null +++ b/539/CH4/EX4.4.a/Example_4_4a.sce @@ -0,0 +1,16 @@ +//Computations of ASTM Grain Size Number
+
+clear;
+clc;
+
+printf("\tExample 4.4\n");
+
+printf("\n\tPart A");
+
+N=45; //No. of grains per square inch
+
+//Dterminin grain size no. N=2^(n-1)
+n=(log(N)/log(2))+1;
+printf("\nGrain size no. is %.1f\n",n);
+
+//End
\ No newline at end of file diff --git a/539/CH4/EX4.4.b/Example_4_4b.sce b/539/CH4/EX4.4.b/Example_4_4b.sce new file mode 100755 index 000000000..c2fd4c27f --- /dev/null +++ b/539/CH4/EX4.4.b/Example_4_4b.sce @@ -0,0 +1,17 @@ +//Number of Grains Per Unit Area
+
+clear;
+clc;
+
+printf("\tExample 4.4\n");
+
+printf("\n\tPart B");
+N=45; //No. of grains per square inch
+n=(log(N)/log(2))+1;
+M=85;
+
+Nm=(100/M)^2*2^(n-1);
+printf("\nAt magnification of 85x\n");
+printf("No. of grains per inch square are %.1f\n",Nm);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.1/Example_5_1.sce b/539/CH5/EX5.1/Example_5_1.sce new file mode 100755 index 000000000..dbe95e30c --- /dev/null +++ b/539/CH5/EX5.1/Example_5_1.sce @@ -0,0 +1,19 @@ +//Diffusion Flux Computation
+
+clear;
+clc;
+
+printf("\tExample 5.1\n");
+
+Ca=1.2; //Concentration at A in kg/m^3
+Cb=0.8; //Concentration at B in kg/m^3
+
+xa=5*10^-3; //Position 1 in m
+xb=10*10^-3; //Position 2 in m
+
+D=3*10^-11; //Diffusion coefficient in m^2/s
+
+J=-D*(Ca-Cb)/(xa-xb);
+printf("\nDiffusion flux is %.1f * 10^-9 kg/m^2-s",J/10^-9);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.2/Example_5_2.sce b/539/CH5/EX5.2/Example_5_2.sce new file mode 100755 index 000000000..62114cc04 --- /dev/null +++ b/539/CH5/EX5.2/Example_5_2.sce @@ -0,0 +1,23 @@ +//Nonsteady-State Diffusion Time Computation I
+
+clear;
+clc;
+
+printf("\tExample 5.2\n");
+
+Co=0.25; //Initial Conc. in wt%
+Cs=1.2; //Surface conc. in wt%
+Cx=0.8; //Conc. at any x in wt%
+
+x=5*10^-4; //Position in m
+D=1.6*10^-11; //Diffusion coeff in m^2/s
+
+C=1-((Cx-Co)/(Cs-Co));
+z=erfinv(C);
+
+//But C=erf(x/2sqrt(Dt))
+t=x^2/(4*D*z^2);
+
+printf("\nTime required is %d s or %.1f h\n",t,t/3600);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.3/Example_5_3.sce b/539/CH5/EX5.3/Example_5_3.sce new file mode 100755 index 000000000..51fc97cb6 --- /dev/null +++ b/539/CH5/EX5.3/Example_5_3.sce @@ -0,0 +1,17 @@ +//Nonsteady-State Diffusion Time Computation II
+
+clear;
+clc;
+
+printf("\tExample 5.3\n");
+
+D500=4.8*10^-14; //Diffusion coefficient at 500 C
+
+D600=5.3*10^-13; //Diffusion coefficient at 600 C
+t600=10; //Time in hours to diffuse
+
+t500=D600*t600/D500;
+
+printf("\nTime to diffuse at 500 C is %.1f h\n",t500);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.4/Example_5_4.sce b/539/CH5/EX5.4/Example_5_4.sce new file mode 100755 index 000000000..09b563c1f --- /dev/null +++ b/539/CH5/EX5.4/Example_5_4.sce @@ -0,0 +1,17 @@ +//Diffusion Coefficient Determination
+
+clear;
+clc;
+
+printf("\tExample 5.4\n");
+
+T=550+273; //in K
+D0=1.2*10^-4; //Temperature independent preexponential in m^2/s
+Qd=131000; //Activation energy in J/mol-K
+R=8.31; //Universal Gas constt
+
+D=D0*exp(-Qd/(R*T));
+
+printf("\nDiffusion coefficient is %.1f * 10^-13 m^2/s\n",D/10^-13);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.5/Example_5_5.sce b/539/CH5/EX5.5/Example_5_5.sce new file mode 100755 index 000000000..f16339a69 --- /dev/null +++ b/539/CH5/EX5.5/Example_5_5.sce @@ -0,0 +1,23 @@ +//Diffusion Coefficient Activation Energy and Preexponential Calculations
+
+clear;
+clc;
+
+printf("\tExample 5.5\n");
+
+//From graph log D ad 1/T are deducted
+inv_T1=0.8*10^-3; //Reciprocal of temp. in K^-1
+inv_T2=1.1*10^-3; //Reciprocal of temp. in K^-1
+logD1=-12.4;
+logD2=-15.45;
+
+R=8.31; //Gas law Constant in J/mol-K
+
+Qd=-2.3*R*(logD1-logD2)/(inv_T1-inv_T2);
+printf("\nActivation energy is %d kJ/mol",Qd/1000);
+
+//For calculating Peexponential factor
+D0=10^(logD2+(Qd*inv_T2/(2.3*R)));
+printf("\nPreexponential factor D0 is %.1f * 10^-5 m^2/s\n",D0/10^-5);
+
+//End
\ No newline at end of file diff --git a/539/CH5/EX5.6/Design_Example_5_1.sce b/539/CH5/EX5.6/Design_Example_5_1.sce new file mode 100755 index 000000000..33e90e73b --- /dev/null +++ b/539/CH5/EX5.6/Design_Example_5_1.sce @@ -0,0 +1,33 @@ +//Diffusion Temperature–Time Heat Treatment Specification
+
+clear;
+clc;
+
+printf("\tDesign Example 5.1\n");
+
+C0=0.2; //Initial concentration in wt%
+Cs=1; //Surface conc in wt%
+Cx=0.6; //Conc at any position X in wt%
+x=7.5*10^-4; //Position in m
+D0=2.3*10^-5; //Preexponential factor in m^2/s
+R=8.31; //Gas law constant in J/mol-K
+Qd=148000; //Activation energy in J/mol
+
+C=1-((Cx-C0)/(Cs-C0));
+z=erfinv(C);
+Dt=(x/(2*z))^2;
+
+//Dt=D0*exp(-Qd/RT)*t = value of variable Dt
+D=Dt/D0;
+
+T=[900 950 1000 1050];
+for i=1:4
+ t(i)=D/exp(-Qd/(R*(T(i)+273)))/3600;
+end
+
+printf("\nTemperature(in Celsius) is\n");
+disp(T);
+printf("\nTime is (in hours)\n");
+disp(t);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.1/Example_6_1.sce b/539/CH6/EX6.1/Example_6_1.sce new file mode 100755 index 000000000..11bef4ea8 --- /dev/null +++ b/539/CH6/EX6.1/Example_6_1.sce @@ -0,0 +1,17 @@ +//Elongation (Elastic) Computation
+
+clear;
+clc;
+
+printf("\tExample 6.1\n");
+
+E=110*10^3; //Young's modulus of Copper in MPa
+sigma=276; //Applied stress in MPa
+lo=305; //Original length in mm
+
+//Deformation
+dl=sigma*lo/E;
+
+printf("\nElongation obtained is %.2f mm \n",dl);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.2/Example_6_2.sce b/539/CH6/EX6.2/Example_6_2.sce new file mode 100755 index 000000000..b8bf8c031 --- /dev/null +++ b/539/CH6/EX6.2/Example_6_2.sce @@ -0,0 +1,25 @@ +//Computation of Load to Produce Specified Diameter Change
+
+clear;
+clc;
+
+printf("\tExample 6.2\n");
+
+del_d=-2.5*10^-3; //Deformation in dia in mm
+d0=10; //Initial dia in mm
+
+v=0.34; //Poisson ratio for brass
+
+ex=del_d/d0;
+printf("\nStrain in x-direction is %f",ex);
+
+ez=-ex/v;
+printf("\nStrain in z-direction is %f",ez);
+
+E=97*10^3; //Modulus of elasticity in MPa
+sigma=ez*E;
+F=sigma*%pi*(d0^2)/4;
+
+printf("\nApplied force is %d N",F);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.3.a/Example_6_3a.sce b/539/CH6/EX6.3.a/Example_6_3a.sce new file mode 100755 index 000000000..d8882fd86 --- /dev/null +++ b/539/CH6/EX6.3.a/Example_6_3a.sce @@ -0,0 +1,20 @@ +clear;
+clc;
+
+printf("\tExample 6.3\n");
+
+//From draph in the question
+//stress and strain can be obtained
+
+si2=150; // in MPa
+si1=0;
+e2=0.0016;
+e1=0;
+d0=12.8*10^-3; //Initial Diameter in m
+
+printf("\n\tPart A");
+//Young's Modulus = stress/strain
+E=(si2-si1)/(e2-e1);
+printf("\nModulus of elasticity is %.2f GPa",E/10^3);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.3.c/Example_6_3c.sce b/539/CH6/EX6.3.c/Example_6_3c.sce new file mode 100755 index 000000000..e8e0a47ee --- /dev/null +++ b/539/CH6/EX6.3.c/Example_6_3c.sce @@ -0,0 +1,22 @@ +clear;
+clc;
+
+printf("\tExample 6.3\n");
+
+//From draph in the question
+//stress and strain can be obtained
+
+si2=150; // in MPa
+si1=0;
+e2=0.0016;
+e1=0;
+d0=12.8*10^-3; //Initial Diameter in m
+
+printf("\n\tPart C");
+A0=%pi*d0^2/4;
+sig=450*10^6; //tensile strength in MPa
+
+F=sig*A0;
+printf("\nMaximum load sustained is %d N\n",F);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.3.d/Example_6_3d.sce b/539/CH6/EX6.3.d/Example_6_3d.sce new file mode 100755 index 000000000..1d5db01ac --- /dev/null +++ b/539/CH6/EX6.3.d/Example_6_3d.sce @@ -0,0 +1,21 @@ +clear;
+clc;
+
+printf("\tExample 6.3\n");
+
+//From draph in the question
+//stress and strain can be obtained
+
+printf("\n\tPart D");
+
+//From stress-strain curve
+//Strain corresponding to stress of 345 MPa is 0.06
+
+l0=250; //Initial lengt in mm
+e=0.06; //strain
+
+dl=e*l0;
+printf("\nChange in length is %d mm",dl);
+
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.4.a/Example_6_4a.sce b/539/CH6/EX6.4.a/Example_6_4a.sce new file mode 100755 index 000000000..aed4b8ae3 --- /dev/null +++ b/539/CH6/EX6.4.a/Example_6_4a.sce @@ -0,0 +1,17 @@ +//Ductility
+
+clear;
+clc;
+
+printf("\tExample 6.4\n");
+
+di=12.8; //Initial dia in mm
+df=10.7; //Final dia in mm
+
+printf("\n\tPart A");
+
+//Ductility in terms of Reduction Area
+RA = ((di^2-df^2)/di^2)*100;
+printf("\npercent reduction in area is %d %%\n",RA);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.4.b/Example_6_4b.sce b/539/CH6/EX6.4.b/Example_6_4b.sce new file mode 100755 index 000000000..af3869f2c --- /dev/null +++ b/539/CH6/EX6.4.b/Example_6_4b.sce @@ -0,0 +1,22 @@ +//True-Stress-At-Fracture Computations
+
+clear;
+clc;
+
+printf("\tExample 6.4\n");
+
+di=12.8; //Initial dia in mm
+df=10.7; //Final dia in mm
+
+printf("\n\tPart B");
+Ao=%pi*di^2*10^-6/4;
+sig=460*10^6; //Tensile strength
+
+F=sig*Ao;
+printf("\nF = %d N",F);
+
+Af=%pi*df^2/4;
+sig_t=F/Af;
+printf("\nTrue stress is %d MPa",sig_t);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.5/Example_6_5.sce b/539/CH6/EX6.5/Example_6_5.sce new file mode 100755 index 000000000..ab8fbc82d --- /dev/null +++ b/539/CH6/EX6.5/Example_6_5.sce @@ -0,0 +1,16 @@ +//Calculation of Strain-Hardening Exponent
+
+clear;
+clc;
+
+printf("\tExample 6.5\n");
+
+sig_t=415; //True stress in MPa
+et=0.1; //True strain
+K=1035; // In MPa
+
+n=log(sig_t/K)/log(et);
+
+printf("\nStrain - hardening coefficient is %.2f",n);
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.6.a/Example_6_6a.sce b/539/CH6/EX6.6.a/Example_6_6a.sce new file mode 100755 index 000000000..fef18d29c --- /dev/null +++ b/539/CH6/EX6.6.a/Example_6_6a.sce @@ -0,0 +1,24 @@ +//Average Computations
+
+clear;
+clc;
+
+printf("\tExample 6.6a\n");
+
+//First and Last point are arbitary to plot the required 4 points
+n=[0 1 2 3 4 5];
+TS=[510 520 512 515 522 525];
+
+plot(n,TS,'+');
+xtitle('Tensile strength data','Sample no.','Tensile strength');
+
+//Mean Tensile strength
+i=2;
+TSmean=0;
+
+for i=2:5
+ TSmean=TSmean+(TS(i)/4);
+end
+printf("\nMean tensile strength is %d MPa\n",TSmean);
+
+//End
diff --git a/539/CH6/EX6.6.b/Example_6_6b.sce b/539/CH6/EX6.6.b/Example_6_6b.sce new file mode 100755 index 000000000..24b820563 --- /dev/null +++ b/539/CH6/EX6.6.b/Example_6_6b.sce @@ -0,0 +1,29 @@ +//Standard Deviation Computations
+
+clear;
+clc;
+
+printf("\tExample 6.6b\n");
+
+//First and Last point are arbitary to plot the required 4 points
+n=[0 1 2 3 4 5];
+TS=[510 520 512 515 522 525];
+
+i=2;
+TSmean=0;
+
+for i=2:5
+ TSmean=TSmean+(TS(i)/4);
+end
+
+//Standard Deviation
+j=0;
+std=0;
+
+for i=2:5
+ std=std+((TS(i)-TSmean)^2/(4-1));
+end
+
+printf("\nStandard deviation is %.1f MPa\n",sqrt(std));
+
+//End
\ No newline at end of file diff --git a/539/CH6/EX6.7/Design_Example_6_1.sce b/539/CH6/EX6.7/Design_Example_6_1.sce new file mode 100755 index 000000000..3f55ccc16 --- /dev/null +++ b/539/CH6/EX6.7/Design_Example_6_1.sce @@ -0,0 +1,18 @@ +//Specification of Support Post Diameter
+
+clear;
+clc;
+
+printf("\tDesign Example 6.1\n");
+
+sig_y=310; //Minimum yield strength in MPa
+N=5; // Conservative factor of safety
+
+F=220000/2; //Two rods must support half of the total force
+
+sig_w=sig_y/N;
+d=2*sqrt(F/(%pi*sig_w));
+
+printf("\nDiameter of each of the two rods is %.1f mm\n",d);
+
+//End
\ No newline at end of file diff --git a/539/CH7/EX7.1.a/Example_7_1a.sce b/539/CH7/EX7.1.a/Example_7_1a.sce new file mode 100755 index 000000000..c1556f8bb --- /dev/null +++ b/539/CH7/EX7.1.a/Example_7_1a.sce @@ -0,0 +1,31 @@ +//Resolved Shear Stress Computations
+
+clear;
+clc;
+
+printf("\tExample 7.1\n");
+
+x=[1 1 0]; //Indices of Plane
+y=[0 1 0]; //direction of applied tensile stress
+z=[-1 1 1]; //Direction of shear stress
+
+function[angle]=dotproduct(a,b)
+ num=(a(1)*b(1))+(a(2)*b(2))+(a(3)*b(3));
+ den=sqrt((a(1)^2+a(2)^2+a(3)^2)*(b(1)^2+b(2)^2+b(3)^2));
+ angle=acos(num/den);
+ funcprot(0)
+endfunction
+
+phi=dotproduct(x,y);
+lambda=dotproduct(y,z);
+
+printf("\nAngles phi is %.1f degree and lambda is %.1f degree\n",phi*180/%pi,lambda*180/%pi);
+
+
+//When a tensile stress of 52 MPa (7500 psi) is applied
+printf("\n\tPart A\n");
+sigma=52; //in MPa
+tr=sigma*cos(phi)*cos(lambda);
+printf("Resolved shear stress is %.1f MPa\n",tr);
+
+//End
\ No newline at end of file diff --git a/539/CH7/EX7.1.b/Example_7_1b.sce b/539/CH7/EX7.1.b/Example_7_1b.sce new file mode 100755 index 000000000..d192e0a01 --- /dev/null +++ b/539/CH7/EX7.1.b/Example_7_1b.sce @@ -0,0 +1,32 @@ +//Stress-to-Initiate-Yielding Computations
+
+clear;
+clc;
+
+printf("\tExample 7.1\n");
+
+x=[1 1 0]; //Indices of Plane
+y=[0 1 0]; //direction of applied tensile stress
+z=[-1 1 1]; //Direction of shear stress
+
+function[angle]=dotproduct(a,b)
+ num=(a(1)*b(1))+(a(2)*b(2))+(a(3)*b(3));
+ den=sqrt((a(1)^2+a(2)^2+a(3)^2)*(b(1)^2+b(2)^2+b(3)^2));
+ angle=acos(num/den);
+ funcprot(0)
+endfunction
+
+phi=dotproduct(x,y);
+lambda=dotproduct(y,z);
+
+printf("\nAngles phi is %.1f degree and lambda is %.1f degree\n",phi*180/%pi,lambda*180/%pi);
+
+//If slip occurs on a (110) plane and in a [-1 1 1]direction, and the critical resolved shear stress is 30 MPa
+printf("\n\tPart B")
+
+trc=30; //in MPa Critical resolved shear stress
+
+sy=trc/(cos(phi)*cos(lambda));
+printf("\nYield strength is %.1f MPa\n",sy);
+
+//End
\ No newline at end of file diff --git a/539/CH7/EX7.2/Example_7_2.sce b/539/CH7/EX7.2/Example_7_2.sce new file mode 100755 index 000000000..d902b9cf0 --- /dev/null +++ b/539/CH7/EX7.2/Example_7_2.sce @@ -0,0 +1,21 @@ +//Tensile Strength and Ductility Determinations for Cold-Worked Copper
+
+clear;
+clc;
+
+printf("\t Example 7.2\n");
+
+df=12.2; //Final dia in mm
+di=15.2; //Initial dia in mm
+
+CW = ((di^2-df^2)/di^2)*100;
+
+printf("\nCold work is %.1f %%\n",CW);
+
+ts=340; //in Mpa tensile strength
+duc=7; //in % Ductility
+printf("\nFrom graph of Fig. 7.19b in book");
+printf("\nTensile strength is %d MPa",ts);
+printf("\nDuctility is %d %% EL\n",duc);
+
+//End
\ No newline at end of file diff --git a/539/CH7/EX7.3/Design_Example_7_1.sce b/539/CH7/EX7.3/Design_Example_7_1.sce new file mode 100755 index 000000000..594fe47a0 --- /dev/null +++ b/539/CH7/EX7.3/Design_Example_7_1.sce @@ -0,0 +1,28 @@ +//Description of Diameter Reduction Procedure
+
+clear;
+clc;
+
+printf("\tDesign Example 7.1\n");
+
+di=6.4; //Initial dia in mm
+df=5.1; //Final dia in mm
+
+//Cold Work Computation
+CW = ((di^2-df^2)/di^2)*100;
+
+printf("\nCold work is %.1f %%\n",CW);
+
+//From Figures 7.19a and 7.19c,
+//A yield strength of 410 MPa
+//And a ductility of 8% EL are attained from this deformation
+
+printf("\nBut required ductility and yield strength is not matched at this cold work");
+printf("\nHence required Cold work is 21.5 %%");
+
+//x=poly([0],'x');
+dmid = sqrt(df^2/(1-0.215));
+
+printf("\nHence first draw to %.1fmm and then to %.1fmm\n",dmid,df);
+
+//End
\ No newline at end of file diff --git a/539/CH8/EX8.1/Example_8_1.sce b/539/CH8/EX8.1/Example_8_1.sce new file mode 100755 index 000000000..3f069d4e7 --- /dev/null +++ b/539/CH8/EX8.1/Example_8_1.sce @@ -0,0 +1,17 @@ +//Maximum Flaw Length Computation
+
+clear;
+clc;
+
+printf("\tExample 8.1\n");
+
+sigma=40*10^6; // in Pa Tensile stress
+E=69*10^9; //Modulus of elaticity in pa
+Ys=0.3; //Specific surface energy in N/m^2
+
+//Maximum length of a surface flaw
+a=2*E*Ys/(%pi*sigma^2);
+
+printf("\nMaximum lemgth of a surface falw without fracture : %.4f mm\n",a/10^-3);
+
+//End
\ No newline at end of file diff --git a/539/CH8/EX8.2/Design_Example_8_2.sce b/539/CH8/EX8.2/Design_Example_8_2.sce new file mode 100755 index 000000000..5b82571ac --- /dev/null +++ b/539/CH8/EX8.2/Design_Example_8_2.sce @@ -0,0 +1,18 @@ +//Rupture Lifetime Prediction
+
+clear;
+clc;
+
+printf("\tDesign Example 8.2\n");
+
+T=800+273; // Temperature in K
+
+//stress is 140 MPa
+//From Graph of Fig. 8.32 Larson-Miller Parameter is deduced
+L_M=24*10^3;
+
+t=10^((L_M/T)-20);
+
+printf("\nTime to rupture is : %d hours\n",t);
+
+//End
\ No newline at end of file diff --git a/539/CH8/EX8.3/Example_8_3.sce b/539/CH8/EX8.3/Example_8_3.sce new file mode 100755 index 000000000..46c463691 --- /dev/null +++ b/539/CH8/EX8.3/Example_8_3.sce @@ -0,0 +1,16 @@ +//Estimating theoretical fracture strength
+
+clear;
+clc;
+
+printf("\tExample 8.3\n");
+
+a=0.5; //Crack length in mm
+ro=5D-3; //Crack tip radius of curvature in mm
+sig=1035; //Applied stress in MPa
+
+sigm=2*sig*sqrt(a/ro);
+
+printf("\nFracture strength is %.2e MPa\n",sigm);
+
+//End
\ No newline at end of file diff --git a/539/CH8/EX8.4/Example_8_4.sce b/539/CH8/EX8.4/Example_8_4.sce new file mode 100755 index 000000000..5d48d28c0 --- /dev/null +++ b/539/CH8/EX8.4/Example_8_4.sce @@ -0,0 +1,16 @@ +//Computation of critical shear stress
+
+clear;
+clc;
+
+printf("\tExample 8.4\n");
+
+E=393D9; //Young's modulus for Al
+gam=0.9; //surface energy in J/m^2
+a=4D-4; //Crack length in m
+
+sigc=sqrt(2*E*gam/(%pi*a/2));
+
+printf("\nCritical shear stress is %.2e N/m^2\n",sigc);
+
+//End
\ No newline at end of file diff --git a/539/CH8/EX8.5/Example_8_5.sce b/539/CH8/EX8.5/Example_8_5.sce new file mode 100755 index 000000000..dcce982b8 --- /dev/null +++ b/539/CH8/EX8.5/Example_8_5.sce @@ -0,0 +1,16 @@ +//Determining maximum allowable surface crack length
+
+clear;
+clc;
+
+printf("\tExample 8.5\n");
+
+E=225D9; //Young's modulus
+gam=1; //surface energy in N/m
+sigc=13.5D6; //Critical shear stress in N/m^2
+
+a=2*E*gam/(%pi*sigc^2);
+
+printf("\nMaximum allowable crack length is %.1e m\n",a);
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.1/Example_9_1.sce b/539/CH9/EX9.1/Example_9_1.sce new file mode 100755 index 000000000..d1cb4a358 --- /dev/null +++ b/539/CH9/EX9.1/Example_9_1.sce @@ -0,0 +1,17 @@ +//Lever Rule derivation
+
+clear;
+clc;
+
+printf("\tExample 9.1\n");
+
+disp("Since only 2 phases are present");
+disp("W_alpha + W_L = 1");
+disp("W_alpha*C_alpha + W_L*C_L = C0");
+disp("hence");
+
+disp("W_L = (C_alpha-C0)/(C_alpha-C_L)");
+disp("W_alpha = (C0-C_L)/(C_alpha-C_L)");
+
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.2/Example_9_2.sce b/539/CH9/EX9.2/Example_9_2.sce new file mode 100755 index 000000000..60d266720 --- /dev/null +++ b/539/CH9/EX9.2/Example_9_2.sce @@ -0,0 +1,15 @@ +//Determination of Phases Present and Computation of Phase Compositions
+
+clear;
+clc;
+
+printf("\tExample 9.2\n");
+
+printf("\nfor given composition and temp. of 150 C");
+printf("\ni) both alpha and beta phase coexist\n");
+
+disp("ii) Constructing the tie line");
+printf("10 wt%% Sn - 90 wt%% Pb for C_alpha");
+printf("\n98 wt%% Sn - 2 wt%% Pb for C_beta");
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.3.a/Example_9_3a.sce b/539/CH9/EX9.3.a/Example_9_3a.sce new file mode 100755 index 000000000..bce434165 --- /dev/null +++ b/539/CH9/EX9.3.a/Example_9_3a.sce @@ -0,0 +1,18 @@ +//Determination of Phases Present
+
+clear;
+clc;
+
+printf("\tExample 9.3\n");
+
+printf("\n\tPart A");
+C1=40; // Overall alloy composition
+Cb=98;
+Ca=10;
+
+Wa=(Cb-C1)/(Cb-Ca);
+Wb=(C1-Ca)/(Cb-Ca);
+
+printf("\nMass fractions for alpha and beta phases are : %.2f and %.2f respectively\n",Wa,Wb);
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.3.b/Example_9_3b.sce b/539/CH9/EX9.3.b/Example_9_3b.sce new file mode 100755 index 000000000..3ed25ba2b --- /dev/null +++ b/539/CH9/EX9.3.b/Example_9_3b.sce @@ -0,0 +1,37 @@ +//Computation of Phase Compositions
+
+clear;
+clc;
+
+printf("\tExample 9.3\n");
+
+C1=40; // Overall alloy composition
+Cb=98;
+Ca=10;
+
+Wa=(Cb-C1)/(Cb-Ca);
+Wb=(C1-Ca)/(Cb-Ca);
+
+printf("\n\tPart B");
+d_Sn=7.24; // in g/cm^3 density of tin
+d_Pb=11.23; // in g/cm^3 density of lead
+
+Ca_Sn=10;
+Ca_Pb=90;
+
+Cb_Sn=98;
+Cb_Pb=2;
+
+d_a=100/((Ca_Sn/d_Sn)+(Ca_Pb/d_Pb));
+d_b=100/((Cb_Sn/d_Sn)+(Cb_Pb/d_Pb));
+
+printf("\nDensity of alpha phase is : %.2f g/cm^3",d_a);
+printf("\nDensity of beta phase is : %.2f g/cm^3",d_b);
+
+Va=Wa/(d_a*((Wa/d_a)+(Wb/d_b)));
+Vb=Wb/(d_b*((Wa/d_a)+(Wb/d_b)));
+
+printf("\n\nVolume fraction of alpha phase : %.2f",Va);
+printf("\nVolume fraction of beta phase : %.2f",Vb);
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.4.a/Example_9_4a.sce b/539/CH9/EX9.4.a/Example_9_4a.sce new file mode 100755 index 000000000..5b94d49db --- /dev/null +++ b/539/CH9/EX9.4.a/Example_9_4a.sce @@ -0,0 +1,19 @@ +//Determining ferrite and cementite phase
+
+clear;
+clc;
+
+printf("\t Example 9.4\n");
+
+printf("\n\tPart A");
+C0=0.35;
+Ca=0.022;
+C_Fe3C=6.7;
+
+Wa=(C_Fe3C-C0)/(C_Fe3C-Ca);
+W_Fe3C=(C0-Ca)/(C_Fe3C-Ca);
+
+printf("\nMass fraction of total ferritic phase : %.2f",Wa);
+printf("\nMass fraction of Fe3C : %.2f\n",W_Fe3C);
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.4.b/Example_9_4b.sce b/539/CH9/EX9.4.b/Example_9_4b.sce new file mode 100755 index 000000000..b3b8c4429 --- /dev/null +++ b/539/CH9/EX9.4.b/Example_9_4b.sce @@ -0,0 +1,21 @@ +//Determining proeutectoid ferrite and pearlite
+
+clear;
+clc;
+
+printf("\t Example 9.4\n");
+
+C0=0.35;
+Ca=0.022;
+C_Fe3C=6.7;
+
+printf("\n\tPart B");
+C_p=0.76;
+
+Wp=(C0-Ca)/(C_p-Ca);
+W_a=(C_p-C0)/(C_p-Ca);
+
+printf("\nMass fraction of Pearlite : %.2f",Wp);
+printf("\nMass fraction of proeutectoid ferrite : %.2f\n",W_a);
+
+//End
\ No newline at end of file diff --git a/539/CH9/EX9.4.c/Example_9_4c.sce b/539/CH9/EX9.4.c/Example_9_4c.sce new file mode 100755 index 000000000..31dce8820 --- /dev/null +++ b/539/CH9/EX9.4.c/Example_9_4c.sce @@ -0,0 +1,23 @@ +//Determining eutectoid ferrite
+
+clear;
+clc;
+
+printf("\t Example 9.4\n");
+
+C0=0.35;
+Ca=0.022;
+C_Fe3C=6.7;
+
+C_p=0.76;
+
+Wp=(C0-Ca)/(C_p-Ca);
+W_a=(C_p-C0)/(C_p-Ca);
+
+Wa=(C_Fe3C-C0)/(C_Fe3C-Ca);
+printf("\n\tPart C");
+
+Wae=Wa-W_a;
+printf("\nMass fraction of eutectoid ferrite : %.3f\n",Wae);
+
+//End
\ No newline at end of file |