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 /581/CH11 | |
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 '581/CH11')
-rwxr-xr-x | 581/CH11/EX11.1/Example11_1.sce | 24 | ||||
-rwxr-xr-x | 581/CH11/EX11.10/Example11_10.sce | 26 | ||||
-rwxr-xr-x | 581/CH11/EX11.11/Example11_11.sce | 28 | ||||
-rwxr-xr-x | 581/CH11/EX11.14/Example11_14.sce | 21 | ||||
-rwxr-xr-x | 581/CH11/EX11.15/Example11_15.sce | 20 | ||||
-rwxr-xr-x | 581/CH11/EX11.16/Example11_16.sce | 30 | ||||
-rwxr-xr-x | 581/CH11/EX11.2/Example11_2.sce | 35 | ||||
-rwxr-xr-x | 581/CH11/EX11.3/Example11_3.sce | 20 | ||||
-rwxr-xr-x | 581/CH11/EX11.4/Example11_4.sce | 38 | ||||
-rwxr-xr-x | 581/CH11/EX11.5/Example11_5.sce | 19 | ||||
-rwxr-xr-x | 581/CH11/EX11.6/Example11_6.sce | 13 |
11 files changed, 274 insertions, 0 deletions
diff --git a/581/CH11/EX11.1/Example11_1.sce b/581/CH11/EX11.1/Example11_1.sce new file mode 100755 index 000000000..bf432cd24 --- /dev/null +++ b/581/CH11/EX11.1/Example11_1.sce @@ -0,0 +1,24 @@ +
+clear;
+clc;
+
+printf("\t Example 11.1\n");
+
+Mn2=0.7556; //mass fraction of nitrogen
+Mo2=0.2315; //mass fraction of oxygen
+Mar=0.01289; //mass fraction of argon gas
+M1=28.02; //molar mass of N2,kg/kmol
+M2=32; //molar mass of O2,kg/kmol
+M3=39.95 ; //molar mass of Ar,kg/kmol
+Mair=(Mn2/M1+Mo2/M2+Mar/M3)^-1; //molar mass of air,kg/kmol
+
+Xo2=Mo2*Mair/M2; //mole fraction of O2
+PO2=Xo2*101325; //partial pressure of O2,Pa
+Co2=PO2/(8314.5*300); //molar volume of O2,kmol/m^3
+ao2=Co2*M2; //density of O2,kg/m^3
+
+printf("mole fraction of O2 is :%.4f\n",Xo2);
+printf("partial pressure of O2 is :%4e\n",PO2);
+printf("molar volume of O2 is :%.5f kmol/m^3\n",Co2);
+printf("density of O2 is :%.4f kg/m^3\n",ao2);
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.10/Example11_10.sce b/581/CH11/EX11.10/Example11_10.sce new file mode 100755 index 000000000..ec6ad5dff --- /dev/null +++ b/581/CH11/EX11.10/Example11_10.sce @@ -0,0 +1,26 @@ +
+
+clear;
+clc;
+
+printf("\t Example 11.10\n");
+T1=303; // isothermal temp.,K
+v=5; //air speed,m/s
+l=0.05; //length of naphthalene model that is flat, m
+Mnap=128.2; //molar mass of naphthalene,kg/kmol
+D=0.86*10^-5; //diffusion coefficient of naphthalene in air,m/s
+
+Pv=10^(11.45-3729.3/T1)*133.31; //vapor pressure, Pa
+xn=Pv/101325; //mole fraction of naphthalene
+mn=xn*Mnap/(xn*Mnap+(1-xn)*28.96); //mass fraction of naphthalene
+mnp=0; //mass fraction of naphthalene in free stream is 0
+
+Rel=v*l/(1.867*10^-5); //reynolds no.
+Sc=1.867*10^-5/D; //schimidt no.
+Nul=0.664*Rel^0.5*Sc^1/3; //mass transfer nusselt no.
+Gmn=D*Nul*1.166/l; //gas phase mass transfer coefficient,kg/(m^2*s)
+n=Gmn*(mn-mnp)+0.0000071; //average mass flux,kg/(m^2*s)
+
+printf("\t average rate of loss of naphthalene from a part of model is :%-4e kg/(m^2*s) or 58 g/(m^2*h)\n",n);
+printf("\t naphthalene sublimatin can be used to infer heat transfer coefficient by measuring the loss of naphthalene from a model over some length of time.since the schimidt no. of naphthalene is not generally equal to prandtl no. under the conditions of interest, some assumption about the dependence of nusselt no. on the prandtl no must usually be introduced.")
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.11/Example11_11.sce b/581/CH11/EX11.11/Example11_11.sce new file mode 100755 index 000000000..ee67a382a --- /dev/null +++ b/581/CH11/EX11.11/Example11_11.sce @@ -0,0 +1,28 @@ +
+clear;
+clc;
+
+printf("\t Example 11.11\n");
+T1=300; //temp. of helium-water tube,K
+h=0.4; //height of vertical wall,m
+m=0.087*10^-3; //flow rate of helium,kg/(m^2*s)
+//this is a uniform flux natural convection problem.
+
+Mhes=0.01; // assuming the value of mass fraction of helium at the wall to be 0.01
+Mhef=Mhes/2; //film composition
+
+af=1.141; //film density,kg/m^3
+as=1.107; //wall density,kg/m^3
+Dha=7.119*10^-5; //diffusion coefficient,m^2/s
+u=1.857*10^5; //fil,m viscosity at 300K,kg/(m*s)
+Sc=(u/af)/Dha; //schimidt no.
+aa=1.177; //air density,kg/m^3
+Ra1=9.8*(aa-as)*m*h^4/(u*af*Dha^2*Mhes); //Rayleigh no.
+
+Nu=6/5*(Ra1*Sc/(4+9*Sc^0.5+10*Sc))^(1/5); //approximate nusselt no.
+s=m*h/(af*Dha*Nu); //average concentration of helium at hte wall
+
+//thus we have obtained an average wall concentration 14 oercent higher than our initial guess of Mhes.we repeat this calclations with revised values of densities to obtain Mhes = 0.01142
+
+printf(" average conentration of helium at the wall is 0.01142 ,since the result is within 0.5 percent of our second guess, a third iteration is not needed.");
+//end
diff --git a/581/CH11/EX11.14/Example11_14.sce b/581/CH11/EX11.14/Example11_14.sce new file mode 100755 index 000000000..a261397f3 --- /dev/null +++ b/581/CH11/EX11.14/Example11_14.sce @@ -0,0 +1,21 @@ +
+clear ;
+clc;
+
+printf("\t Example 11.14\n");
+T1=325; //temp. of helium-water tube,K
+l=0.2; //length of tube,m
+x=0.01; // mole fraction of water
+//the vapor pressure of the liquid water is approximately the saturation pressure at the water temp.
+p=1.341*10000 ; //vapor pressure using steam table,Pa
+x1=p/101325; //mole fraction of saturated water
+R=8314.472; //gas constant,J/(kmol*K)
+c= 101325/(R*T1); //mole concentration in tube,kmol/m^3
+D12=1.067*10^-4; //diffusivity ofwater with respect to helium,m^2/s
+Nw=c*D12*log(1+(x-x1)/(x1-1))/l ; //molar evaporation rate,kmol/(m^2*s)
+
+nw=Nw*18.02; // mass evaporation rate,kg/(m^2*s)
+
+//S=1+(x1-1)*exp(Nw*y/(c*D12)) //conentration distribution of water-vapor
+printf("\t conentration distribution of water-vapor is : x1(y)=1-0.8677*exp(0.6593*y) where y is expressed in meters.\n")
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.15/Example11_15.sce b/581/CH11/EX11.15/Example11_15.sce new file mode 100755 index 000000000..a7d42ac61 --- /dev/null +++ b/581/CH11/EX11.15/Example11_15.sce @@ -0,0 +1,20 @@ +
+clear ;
+clc;
+
+printf("\t Example 11.15\n");
+T1=1473; //suraface temp.of hot water,K
+x=0.05; //mass fraction of water
+Gm=0.017; //average mass transfer coefficient,kg/(m^2*s)
+A=0.04; //suraface area of pan,m^2
+
+//only water vapour passes through the liquid surface, since air is not strongly absorbed into water under normal conditions.
+
+p=38.58*1000; // saturation pressure of water,kPa
+Xwater=p/101325; //mole fraction of saturated water
+Mwater=Xwater*18.02/(Xwater*18.02+(1-Xwater)*28.96); //mass fraction of saturated water
+
+B=(x-Mwater)/(Mwater-1); //mass transfer driving force
+m=Gm*B*A; //evaporation rate,kg/s
+printf("\t evaporation rate is:%f kg/s or 769 g/hr.",m);
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.16/Example11_16.sce b/581/CH11/EX11.16/Example11_16.sce new file mode 100755 index 000000000..22a7271df --- /dev/null +++ b/581/CH11/EX11.16/Example11_16.sce @@ -0,0 +1,30 @@ +
+clear;
+clc;
+
+printf("\t Example 11.16\n");
+T1=298; //temp.of air,K
+T2=323.15; //film temp.,K
+x=0.05; //mass fraction of water at 75 C
+Gm=0.017; //average mass transfer coefficient,kg/(m^2*s)
+A=0.04; //suraface area of pan,m^2
+l=0.2; //length of pan in flow direction,m
+v=5; //air speed,m/s
+m=(x+0.277)/2; //film composition of water at 50 C
+Mf=26.34; //mixture molecular weight,kg/kmol
+af=101325*Mf/(8314.5*T2); //film density from ideal gas law,kg/m^3
+Uf=1.75*10^-5; //film viscosity,kg/(m*s)
+Vf=Uf/af; //kinematic viscosity,m^2/s
+Rel=v*l/Vf; //reynolds no. comes out to be 56,800 so the flow is laminar.
+B=0.314; //mass transfer driving force
+
+D=2.96*10^-5; //diffusivity of water in air,m^2/s
+Sc=Vf/D; //scimidt no.
+
+Nu=0.664*Rel^0.5*Sc^1/3; //nussselt no.
+Gmw1=Nu*(D*A/l); //appropriate value of mass transfer gas phase coeffficient of water in air,kg/(m^2*s)
+Gmw=Gmw1*(log(1+B)/B)+0.0168; //mass transfer gas phase coeffficient of water in air,kg/(m^2*s)
+
+printf("mass transfer gas phase coeffficient of water in air is : %.4f kg/(m^2*s)\n In this caes, the blowing factor is 0.870. thus the mild blowing has reduced the mass transfer coefficient by about 13 percent.",Gmw);
+
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.2/Example11_2.sce b/581/CH11/EX11.2/Example11_2.sce new file mode 100755 index 000000000..8cd91c37b --- /dev/null +++ b/581/CH11/EX11.2/Example11_2.sce @@ -0,0 +1,35 @@ +
+clear;
+clc;
+
+printf("\t Example 11.2\n");
+
+r=0.00241; //rate of consumption of carbon,kg/(m^2*s)
+Mo2=0.2; //concentration of oxygen at surface s
+Mco2=0.052; //concentration of CO2 at surface s
+as=0.29; //density of surface s,kg/m^3
+
+//since carbon flows through a second imaginary surface u, the mass fluxes are relatedd by Ncu=-12/32*No2s=12/44*Nco2s
+//the minus sign arises because the O2 flow is opposite the C and CO2 flows.in steady state if we apply mass conservation to the control volume between the u and s surface, wee find that the total mass flux entering the u surface equals that leaving the s surface
+
+Ncu=r; //mass fluxes of carbon in u surface,kg/m^2/s
+
+No2s=-32/12*Ncu; //mass flux of O2 in surface s,kg/(m^2*s)
+Nco2s=44/12*Ncu; //mass flux of CO2 in surface s,kg/(m^2*s)
+Vo2s=No2s/(Mo2*as); //mass average speed,m/s
+Vco2s=Nco2s/(as); //mass average speed,m/s
+
+Vs=(Nco2s+No2s)/as; //effective mass average speed,m/s
+j1=0.0584*(Vo2s-Vs)+0.000526; //diffusional mass flux,kg/(m^2*s)
+j2=0.0087+0.00014; //diffusional mass flux,kg/(m^2*s)
+//the diffusional mass fluxes are very nearly equal to the species m ss fluxes. tha is because the mass average speed is much less than species speeds.
+
+N1=Ncu/12; //mole flux of carbon through the surface s,kmol/(m^2*s)
+N2=-N1; //mole flux of oxygen through the surface s,kmol/(m^2*s)
+printf("\t mass flux of O2 through an imaginary surface is :%.5f kg/(m^2*s)\n",j1);
+printf("\t mass flux of CO2 through an imaginary surface is :%.5f kg/(m^2*s)\n",j2);
+
+printf("\t mole flux of Co2 through an imaginary surface is :%f kmol/(m^2*s)\n",N1);
+printf("\t mole flux of O2through an imaginary surface is :%f kmol/(m^2*s)\n",N2);
+printf("\t the two diffusional mole fluxes sum to zero themselves because ther is no convective mole flux for other species to diffuse against. the reader may ind the velocity of the interface.that calculation shows the interface to be receding so slowly that the velocities are equal to those that would be seen by a stationary observer. ")
+//end
diff --git a/581/CH11/EX11.3/Example11_3.sce b/581/CH11/EX11.3/Example11_3.sce new file mode 100755 index 000000000..a16575690 --- /dev/null +++ b/581/CH11/EX11.3/Example11_3.sce @@ -0,0 +1,20 @@ +
+
+clear ;
+clc;
+
+printf("\t Example 11.3\n");
+T1=276; //temp.of air,K
+aa=3.711; //lennard jones constant or collision diameter,A
+ab=2.827; //lennard jones constant or collision diameter,A
+b1=78.6; //lennard jones constant,K
+b2=59.7; //lennard jones constant,K
+a=(aa+ab)/2; //effective molecular diameter for collisions of hydrogen and air,m
+b=(b1*b2)^0.5; //effective potential well depth,K
+c=T1/b;
+
+d=0.8822; //potential well function
+Dab=1.8583*10^-7*T1^1.5/(a^2*d)*(1/2.016+1/28.97)^0.5; //diffusion coefficient of hydrogen in air,m^2/s
+
+printf("\t diffusion coefficient of hydrogen in air is :% -5e m^2/s an experimental value from table is 6.34*10^-5 m^2/s,so the prediction is high by 5 percent.\n",Dab);
+//end
\ No newline at end of file diff --git a/581/CH11/EX11.4/Example11_4.sce b/581/CH11/EX11.4/Example11_4.sce new file mode 100755 index 000000000..0d7f30ad9 --- /dev/null +++ b/581/CH11/EX11.4/Example11_4.sce @@ -0,0 +1,38 @@ +
+clear;
+clc;
+
+printf("\t Example 11.4\n");
+T1=373.15; //temp.of tea,K
+XN2=0.7808; //mole fraction of nitrogen
+XO2=0.2095; //mole fraction of oxygen
+Xar=0.0093; //mole fraction of
+a=[3.798 3.467 3.542]; //collisin diameter,m
+b=[71.4 106.7 93.3]; //lennard jones constant,K
+M=[28.02 32 39.95]; //molar masses,kg/kmol
+c=[0.9599 1.057 1.021]; //potential well function
+d=[1.8*10^-5 2.059*10^-5 2.281*10^-5]; //calculated viscosity,kg/(m*s)
+e=[1.8*10^-5 2.07*10^-5 2.29*10^-5 ]; // theoritical viscosity,kg/(m*s)
+f=[0.0260 0.02615 0.01787]; //theoritical thermal conducitvity,W/(m*K)
+i=1;
+while(i<4)
+u(i)=2.6693*10^-6*(M(i)*T1)^0.5/((a(i)^2*c(i))); //viscosity,kg/(m*s)
+k(i)=0.083228/((a(i))^2*c(i))*(T1/M(i))^0.5 //thermal conductivity,W/(m*s)
+
+i=i+1;
+end
+umc=XN2*u(1)/0.9978+XO2*u(2)/1.008+Xar*u(3)/0.9435 ; //calculated mixture viscosity,kg/(m*s)
+umc1=1.857*10^-5;
+printf("\t theoritical mixture viscosity is : % -5e kg/(m*s)\n",umc1);
+umd=XN2*e(1)/0.9978+XO2*e(2)/1.008+e(3)*Xar/0.9435; //theoritical mixture viscosity,kg/(m*s)
+printf("\t calculated mixture viscosity is : % -5e kg/(m*s)\n",umd);
+
+kmc=XN2*k(1)/0.9978+XO2*k(2)/1.008+Xar*k(3)/0.9435; //calculated thermal conducitvity,W/(m*K)
+kmc1=0.02623;
+printf("\t theoritical thermal conducitvity is : %f W/(m*K)\n",kmc1);
+kmd=XN2*f(1)/0.9978+XO2*f(2)/1.008+Xar*f(3)/0.9435; //theoritical thermal conductivity, W/(m*K)
+printf("\t calculated thermal conducitvity is : %.5f W/(m*K)\n",kmd);
+Cp=1006 //mixture diffusivity,j/(kg*K)
+pr=umd*Cp/kmd; //prandtl no.
+printf("\t prandtl no. is : %.3f\n",pr);
+//end
diff --git a/581/CH11/EX11.5/Example11_5.sce b/581/CH11/EX11.5/Example11_5.sce new file mode 100755 index 000000000..db4b22fa6 --- /dev/null +++ b/581/CH11/EX11.5/Example11_5.sce @@ -0,0 +1,19 @@ +
+clear;
+clc;
+
+printf("\t Example 11.5\n");
+Psat = [0.6113 1.2276 2.3385 4.2461 7.3837 12.35 19.941 31.188 47.39 70.139 101.325];
+T = [0.01 10 20 30 40 50 60 70 80 90 100];
+i=1;
+while i<12
+ xw(i)=Psat(i)/101.325; //mole fraction of water
+ printf("\n %.4f",xw(i));
+ mw(i)=(xw(i)*18.02)/(xw(i)*18.02+(1-xw(i))*28.96);//mass fraction of water
+ i = i+1;
+end
+plot(T,mw);
+xtitle("Mass fraction of water vapour in air above liquid water surface as a function of surface temperature(1 atm total pressure)","Temperature(degree celsius)","Mass fraction of water vapor");
+
+
+
diff --git a/581/CH11/EX11.6/Example11_6.sce b/581/CH11/EX11.6/Example11_6.sce new file mode 100755 index 000000000..f1cbeebb2 --- /dev/null +++ b/581/CH11/EX11.6/Example11_6.sce @@ -0,0 +1,13 @@ +
+
+clear ;
+clc;
+
+printf("\t Example 11.6\n");
+T1=263.15; //temp.of ice,K
+
+Pv=exp(21.99-6141/(T1)); //vapor pressure,KPa
+xw=Pv/101.325; //mole fraction of water
+mw=xw*18.02/(xw*18.02+(1-xw)*28.96); //mass fraction
+printf("\t mass fraction of watervapor above the surface of ice is :%.5f\n",mw);
+//end
\ No newline at end of file |