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 /1394 | |
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 '1394')
87 files changed, 1503 insertions, 0 deletions
diff --git a/1394/CH10/EX10.2.1/Ex10_2_1.sce b/1394/CH10/EX10.2.1/Ex10_2_1.sce new file mode 100755 index 000000000..933f296c7 --- /dev/null +++ b/1394/CH10/EX10.2.1/Ex10_2_1.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+c = 0.92
+F = 93 // ft^-1
+nu = 2 // cs
+dl = 63 // lb/ft^3
+dg = 2.8 // lb/ft^3
+G = 23 //lb/sex
+//Calculations
+G11 = c*((dl-dg)^0.5)/(((F)^0.5)*(nu^0.05))// lb/ft^2-sec
+A = G/G11// ft^2
+d = sqrt(4*A/%pi)//ft
+//Results
+printf("The diameter of the tower is %.1f ft",d)
diff --git a/1394/CH10/EX10.3.1/Ex10_3_1.sce b/1394/CH10/EX10.3.1/Ex10_3_1.sce new file mode 100755 index 000000000..c6ebb3fb3 --- /dev/null +++ b/1394/CH10/EX10.3.1/Ex10_3_1.sce @@ -0,0 +1,21 @@ + +clc
+//Initialization of variables
+G = 2.3 // Gas flow in gmol/sec
+L = 4.8 // Liquid flow in gmol/sec
+y0 = 0.0126 // entering gas Mole fraction of CO2
+yl = 0.0004 // Exiting gas mole fraction of CO2
+xl = 0 // Exiting liquid mole fraction of CO2
+d = 40 // Diameter of the tower in cm
+x0star = 0.0080// if the amine left in equilibrium with the entering gas would contain 0.80 percent C02
+Kya = 5*10^-5 // Overall M.T.C and the product times the area per volume in gmol/cm^3-sec
+//Calculations
+A =%pi*(d^2)/4
+x0 = ((G*(y0-yl))/(L)) + xl // Entering liquid mole fraction of CO2
+m = y0/x0star // Equilibirum constant
+c1 = G/(A*Kya)
+c2 = 1/(1-(m*G/L))
+c3 = log((y0-m*x0)/(yl-m*xl))
+l = (G/(A*Kya))*(1/(1-((m*G)/L)))*(log((y0-m*x0)/(yl-m*xl)))/100 //length of the tower in metres
+//Results
+printf("The length of the tower is %.1f m",l)
diff --git a/1394/CH10/EX10.3.2/Ex10_3_2.sce b/1394/CH10/EX10.3.2/Ex10_3_2.sce new file mode 100755 index 000000000..571a135bf --- /dev/null +++ b/1394/CH10/EX10.3.2/Ex10_3_2.sce @@ -0,0 +1,19 @@ + +
+clc
+//initialization of variables
+l = 200 // Length of the tower in cm
+d = 60 // diameter of the tower
+Lf = 300 // Liquid flow in cc/sec
+Kx = 2.2*10^-3 // dominant transfer co efficient in liquid in cm/sec
+//Calculations
+A = %pi*60*60/4 // Area of the cross section in sq cm
+L = Lf/A // Liquid flux in cm^2/sec
+ratio = 1/(exp((l*Kx)/L))
+percentage = (1-ratio)*100 // Percentage removal of Oxygen
+//Results
+printf("the percentage of oxygen we can remove is %.1f",percentage)
+
+
+
+// Rounding of error in textbook
diff --git a/1394/CH10/EX10.4.1/Ex10_4_1.sce b/1394/CH10/EX10.4.1/Ex10_4_1.sce new file mode 100755 index 000000000..df473897a --- /dev/null +++ b/1394/CH10/EX10.4.1/Ex10_4_1.sce @@ -0,0 +1,50 @@ + +
+clc
+//initialization of variables
+y1in = 0.37 // mole fraction of Ammonia in gas mixture entering
+y2in =0.16 // mole fraction of nitrogen in gas mixture entering
+y3in = 0.47 // mole fraction of hydrogen in gas mixture entering
+x1out = 0.23 // mole fraction of Ammonia in liquid coming out
+y1out = 0.01 // mole fraction of ammonia in gas coming out
+G0 = 1.20 // Gas glow entering in m^3/sec
+Mu = 1.787*0.01*0.3048/2.23 // liquid viscousity in american units
+dl = 62.4 // Density of liquid in lb/ft^3
+KG = 0.032 // Overall m.t.c in gas phase in gas side m/sec
+a = 105 // surface area in m^2/m^3
+gc = 32.2 // acceleration due to gravity in ft/sec^2
+dg = 0.0326 // Density of gas in lb/ft^3
+//Molecular weights of Ammonia , N2 , H2
+M1 = 17
+M2 = 28
+M3 = 2
+Nu = 1 // Viscousity
+//Calculations
+AG0 = (y2in+y3in)*G0/22.4 // Total flow of non absorbed gases in kgmol/sec
+ANH3 = y1in*G0/22.4- (y1out*AG0)/(1-y1out) // Ammonia absorbed kgmol/sec
+AL0 = ((1-x1out)/x1out)*ANH3 // the desired water flow in kgmol/sec
+avg1 = 11.7 // Average mol wt of gas
+avg2 = 17.8 // avg mol wt of liquid
+TFG = avg1*AG0/(y2in+y3in)//Total flow of gas in kg/sec
+TFL = avg2*AL0/(1-x1out)//total flow of liquid in kg/sec
+F = 45 // Packing factor
+GFF = 1.3*((dl-dg)^0.5)/((F^0.5)*(Nu^0.05))// Flux we require in lb/ft^2-sec
+GFF1 = GFF*0.45/(0.3^2) // in kg/m^2-sec (answer wrong in textbook)
+Area = TFG/GFF1 // Area of the cross section of tower
+dia = (sqrt(4*Area/%pi)) // diameter in metres
+HTU = (22.4*AG0/%pi*dia^2)/(KG*a*4)
+NTU = 5555
+l = HTU*NTU // Length of the tower
+//Results
+printf("The flow of pure water into the top of the tower %.4f kgmol/sec",AL0)
+printf("\n The diameter of the tower is %.1f m",dia)
+printf("\n The length of the tower is %.f m",l)
+
+
+
+
+
+
+
+
+
diff --git a/1394/CH11/EX11.1.1/Ex11_1_1.sce b/1394/CH11/EX11.1.1/Ex11_1_1.sce new file mode 100755 index 000000000..8e4b7ca3a --- /dev/null +++ b/1394/CH11/EX11.1.1/Ex11_1_1.sce @@ -0,0 +1,10 @@ + +clc
+//Initialization of variables
+N1 = 1.6*10^-10 // mol/cm^2-sec
+c1star = 0 // mol/cc
+c1 = 2.7*10^-4/1000 // mol/cc
+//Calculations
+K = N1/(c1-c1star)// cm/sec
+//Results
+printf("The mass transfer co efficient is %.4f cm/sec",K)
diff --git a/1394/CH11/EX11.2.1/Ex11_2_1.sce b/1394/CH11/EX11.2.1/Ex11_2_1.sce new file mode 100755 index 000000000..73d7dfb7d --- /dev/null +++ b/1394/CH11/EX11.2.1/Ex11_2_1.sce @@ -0,0 +1,15 @@ + +
+clc
+//Initialization of variables
+d = 400*10^-4 // cm
+D = 10^-5 // cm^2/sec
+v = 1 // cm/sec
+l = 30 // cm
+nu = 0.01 // cm^2/sec
+//Calculations
+k1 = (D/d)*1.62*(((d^2)*v/D*l)^(1/3))// Mass transfer co efficient inside the hollow fibers in cm/sec
+k2 = (D/d)*0.8*((d*v/nu)^0.47)*((nu/D)^(1/3))//Mass transfer co efficient outside the hollow fibers in cm/sec
+//Results
+printf("Mass transfer co efficient inside the hollow fibers %.2e cm/sec",k1)
+printf("\nMass transfer co efficient outside the hollow fibers %.1e cm/sec",k2)
diff --git a/1394/CH11/EX11.2.2/Ex11_2_2.sce b/1394/CH11/EX11.2.2/Ex11_2_2.sce new file mode 100755 index 000000000..b259fe4ec --- /dev/null +++ b/1394/CH11/EX11.2.2/Ex11_2_2.sce @@ -0,0 +1,23 @@ + +clc
+//initialization of variables
+phi = 0.2
+d = 200*10^-4 // cm
+dia = 3.8 // cm
+Q = 4.1 // blood flow in cc/sec
+k = 3.6*10^-4 // cm/sec
+l = 30 // cm
+//Calculations
+a = 4*phi/d // cm^2/cm^3
+B = Q/((%pi*dia^2)/4) // cm/sec
+ratio1 = 1/(1+(k*a*l/B))// D equals B
+percent1 = (1-ratio1)*100 // percentage of toxins removed when dialystate flow equals blood flow
+D = 2*B // in second case
+ratio2 =1/(((1/(exp(-k*a*l/D)))-0.5)*2) // when D =2B
+percent2 = (1-ratio2)*100 // percentage of toxins removed when dialystate flow is twice the blood flow
+ratio3 = exp(-k*a*l/B)// when dialystate flow is very large
+percent3 = (1-ratio3)*100 // percentage of toxins removed when dialystate flow is very large
+//Results
+printf("The percentage of toxins removed when dialystate flow equals blood flow is %.f",percent1)
+printf("\nThe percentage of toxins removed when dialystate flow is twice the blood flow is %.f",percent2)
+printf("\nThe percentage of toxins removed when dialystate flow is very large is %.f",percent3)
diff --git a/1394/CH12/EX12.2.1/Ex12_2_1.sce b/1394/CH12/EX12.2.1/Ex12_2_1.sce new file mode 100755 index 000000000..54bab483b --- /dev/null +++ b/1394/CH12/EX12.2.1/Ex12_2_1.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+l = 1.22 // length of tower
+Gflow = 0.026 // mol/sec
+GbyL = 0.07
+dia = 0.088 // m
+pl = 1.1/100// pl = 1-yl
+p0 = 0.04/100 // p0 = 1-y0
+//Calculations
+A = %pi*(dia^2)/4 // cross sectional of tower in m^2
+G = Gflow/A // Gas flux in mol/m^2-sec
+Kya = (G/l)*(1/(1-GbyL))*(log(pl/p0))// Mass transfer per volume in mol/m^3-sec
+//Results
+printf("The mass transfer per volume is %.1f mol/m^3-sec",Kya)
diff --git a/1394/CH12/EX12.2.2/Ex12_2_2.sce b/1394/CH12/EX12.2.2/Ex12_2_2.sce new file mode 100755 index 000000000..10b317dbc --- /dev/null +++ b/1394/CH12/EX12.2.2/Ex12_2_2.sce @@ -0,0 +1,27 @@ + +clc
+//Initialization of variables
+x1=0.99
+x2=0.99
+y1=0.95
+y2=0.95
+alpha=1.5
+m=0.42
+l=2
+HTU=0.34
+//calculations
+y1s= (y1-0.58)/m
+xrd= (x2-y2)/(x1-y1s)
+Rd=xrd/(1-xrd)
+Rds=alpha*Rd
+xl= ((Rds+1)*y1 - x1)/(Rds)
+function z= ystar(y)
+ z=0.58+0.42*y
+endfunction
+NTU = log((ystar(xl) -y1)/(ystar(x1)-x1)) /(1- m*(Rds+1)/Rds)
+NTU2=l/HTU
+xd2=(ystar(y1)-y1)/%e^(NTU2*(1-m))
+xd=(0.58-xd2)/(1-m)
+//results
+printf("In case 1, NTU = %.2f",NTU)
+printf("\n In case 2, xd = %.3f",xd)
diff --git a/1394/CH12/EX12.4.1/Ex12_4_1.sce b/1394/CH12/EX12.4.1/Ex12_4_1.sce new file mode 100755 index 000000000..fccc568ce --- /dev/null +++ b/1394/CH12/EX12.4.1/Ex12_4_1.sce @@ -0,0 +1,25 @@ + +clc
+//initialization of variables
+F=3500 //mol/hr
+xf=0.4
+x1=0.98
+y1=0.97
+y2=0.625
+x1=0.97
+x2=0.4
+ratio=1.5
+HTU=0.2
+//calculations
+A=[1 1;x1 1-x1]
+B=[F;xf*F]
+C=A\B
+DA=C(1)
+BA=C(2)
+Rds=(y1-y2)/(x1-x2)
+Rd=Rds/(1-Rds)
+Rdreq=ratio*Rd
+NTU=13.9
+l=HTU*NTU
+//results
+printf("length of the tower = %.1f m",l)
diff --git a/1394/CH13/EX13.1.1/Ex13_1_1.sce b/1394/CH13/EX13.1.1/Ex13_1_1.sce new file mode 100755 index 000000000..ff0872eae --- /dev/null +++ b/1394/CH13/EX13.1.1/Ex13_1_1.sce @@ -0,0 +1,28 @@ + +
+clc
+//Intialization of variables
+xD = 0.90 // Distillate mole fraction
+xB = 0.15// Reboiler mole fraction
+xF = 0.50 //Feed mole fraction
+F = 10 // mol/sec
+dg = 3.1*10^-3 // g/cc
+dl = 0.65 // g/cc
+C = 0.11 // m/sec
+//Calculations
+D = ((xF*F)-(xB*F))/(xD-xB)
+B = ((xF*F)-(xD*F))/(xB-xD)
+L = 3.5*D
+G = L+D
+L1 = L+F
+G1 = G
+f = (L1/G1)*(sqrt(dg/dl)) // flow parameter
+vG = C*(sqrt((dl-dg)/dg))//vapor velocity in m/sec
+c = (22.4*10^-3)*340/373
+d = sqrt(4*G1*c/(vG*%pi))//m
+//Results
+printf("The column diameter is %.1f m",d)
+
+//Calculation mistake in textbook
+
+
diff --git a/1394/CH13/EX13.2.1/Ex13_2_1.sce b/1394/CH13/EX13.2.1/Ex13_2_1.sce new file mode 100755 index 000000000..f2bf627de --- /dev/null +++ b/1394/CH13/EX13.2.1/Ex13_2_1.sce @@ -0,0 +1,20 @@ + +
+clc
+//Initialization of variables
+y1 = 0.9999
+x0 = y1 // For a total condenser
+y0 =0.58 + 0.42*x0 // The equilbirum line
+LbyG = 0.75
+yNplus1 = 0.99
+A = LbyG/0.42
+n= 1
+//Calculations
+xN = (yNplus1-((1-LbyG)*y1))/LbyG
+yN = 0.58 + 0.42*xN
+N = (log((yNplus1-yN)/(y1-y0))/log(A))+n//, number of stages
+//Results
+printf("the number of stages approximately is %.f",N)
+
+
+
diff --git a/1394/CH13/EX13.2.2/Ex13_2_2.sce b/1394/CH13/EX13.2.2/Ex13_2_2.sce new file mode 100755 index 000000000..81d983519 --- /dev/null +++ b/1394/CH13/EX13.2.2/Ex13_2_2.sce @@ -0,0 +1,22 @@ + + +clc
+//initialization of variables
+x0 = 0.0082
+xB = 10^-4
+L = 1
+//Calculations
+y0 = 36*x0
+//There are two balancing equations , mole fraction balance , mole balance , from them G is
+G0 = (xB-x0)*L/(xB-y0)
+G = 3*G0
+B = L-G
+y1 = ((L*x0)-(B*xB))/G
+yNplus1 = 36*xB
+xN = (L*x0 - (G*(y1-yNplus1)))/L
+yN = 36*xN
+N = (log((yNplus1-yN)/(y1-y0)))/log((yNplus1-y1)/(yN-y0))
+//Results
+printf("The number of stages are %.1f",N)
+//Answer wrong in textbook
+
diff --git a/1394/CH13/EX13.4.1/Ex13_4_1.sce b/1394/CH13/EX13.4.1/Ex13_4_1.sce new file mode 100755 index 000000000..ecbf0f9a3 --- /dev/null +++ b/1394/CH13/EX13.4.1/Ex13_4_1.sce @@ -0,0 +1,14 @@ + +clc
+//initialization of variables
+yn = 0.84
+ynplus1 = 0.76
+ystarn = 0.874
+GA = 0.14 // kg-mol/sec
+Al = 0.04 // m^3
+//Calculations
+Murphree = (yn-ynplus1)/(ystarn-ynplus1)
+Kya = GA/(Al*((1/Murphree)-1))
+//results
+printf("the murphree efficiency is %.2f",Murphree)
+printf("\n the m.t.c along with the product with a is %.2f kg-mol/m^3-sec",Kya)
diff --git a/1394/CH13/EX13.4.2/Ex13_4_2.sce b/1394/CH13/EX13.4.2/Ex13_4_2.sce new file mode 100755 index 000000000..60f4a0f8d --- /dev/null +++ b/1394/CH13/EX13.4.2/Ex13_4_2.sce @@ -0,0 +1,19 @@ + +clc
+//Initialization of variables
+R = 82 // atm-cm^3/gmol-K
+T = 273 + 60 // Kelvin
+pk = 1 // atm
+a1 = 440 // sec^-1 (of gas)
+a2 = 1.7 //sec^-1 (of liquid)
+ck = 1.5/((0.47*(76.1))+(0.53*(158.7)))
+x = 0.2
+Vs = 10 // litres
+GA = 59 // gmol/sec
+m = 1.41
+//Calculations
+k = (R*T)/(pk*a1) + (m/(ck*a2))
+Kya = (1/k)*1000 // gmol/l-sec
+Murphree = 1 - exp(-Kya*Vs/(GA))
+//Results
+printf("The murphree efficiency is %.2f",Murphree)
diff --git a/1394/CH14/EX14.3.1/Ex14_3_1.sce b/1394/CH14/EX14.3.1/Ex14_3_1.sce new file mode 100755 index 000000000..f4de66c74 --- /dev/null +++ b/1394/CH14/EX14.3.1/Ex14_3_1.sce @@ -0,0 +1,17 @@ + +clc
+//initialization of variables
+Rat1 = (6.5/3)*(1-0.47)// as Rat = x0/y0
+m = 0.14
+H = (6.5*10^3)/3600 // Extract flow in g/sec
+L = (3*10^3)/3600// Solvent flow in g/sec
+d= 10 // cm
+A = 0.25*%pi*d^2 // cm^2
+l = 65 // cm
+//Calculations and Results
+Kya = ((H/(l*A))*(1/(1-((m*H)/L)))*(log((1-0.14*Rat1)/(0.47))))*10^3// kg/m^3-sec
+printf("The value of Kya is %.2f kg/m^3-sec",Kya)
+Rat2 = (6.5/3)*(1-0.1)//For case B
+l2 = l*(log(1/((1-0.14*Rat2)/(0.1))))/(log(1/((1-0.14*Rat1)/(0.47))))/100// m
+printf("\nThe length for 90 percent recovery is %.1f m",l2)
+
diff --git a/1394/CH14/EX14.4.1/Ex14_4_1.sce b/1394/CH14/EX14.4.1/Ex14_4_1.sce new file mode 100755 index 000000000..1f883097d --- /dev/null +++ b/1394/CH14/EX14.4.1/Ex14_4_1.sce @@ -0,0 +1,19 @@ + +
+clc
+//Initialization of variables
+m = 0.018
+H = 450 // litres/hr
+L = 37 // litres/hr
+Ynplus1byY1 = 100
+//Calculations
+E =m*H/L
+nplus1 = log((Ynplus1byY1*((1/E)-1))+1)/log(1/E)
+n = nplus1 -1
+printf("The number of ideal stages are %.f",n)
+N = 0.60//Murphree efficienct
+E1 = (m*H/L) + (1/N) - 1
+nplus1 = log((Ynplus1byY1*((1/E1)-1))+1)/log(1/E1)
+n=nplus1-1
+printf("\nThe number of stages required if Murphree efficiency is 60 percent is %.f",n)
+
diff --git a/1394/CH14/EX14.5.1/Ex14_5_1.sce b/1394/CH14/EX14.5.1/Ex14_5_1.sce new file mode 100755 index 000000000..16ac7a3f1 --- /dev/null +++ b/1394/CH14/EX14.5.1/Ex14_5_1.sce @@ -0,0 +1,16 @@ + +clc
+//initialization of variables
+F = 5 //kg feed
+S = 2 // kg solvent
+E = F-S // kg extract
+W = 1 // kg waste
+EG = 80 // ppm
+y0 = (100-99)/100 // mole fraction of gold left
+y1 = y0*EG*W/S // concentration in raffinate
+//Calculations
+xN = (EG*W - y1*S)/E // solvent concentration
+xNminus1 = ((xN*(E+S)) - EG*W)/F//feed stage balance
+N = 1 + ((log((xN-xNminus1)/(y1))/log(F/S)))//numner of stages including feed stage
+//Results
+printf("The number of stages including feed stage is %.f",N)
diff --git a/1394/CH15/EX15.3.2/Ex15_3_2.sce b/1394/CH15/EX15.3.2/Ex15_3_2.sce new file mode 100755 index 000000000..56552d149 --- /dev/null +++ b/1394/CH15/EX15.3.2/Ex15_3_2.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+tE = 33 // Time taken for ferric ion to exhaust the bed in min
+tB = 23 // Time taken for nickel to break through ferric in min
+l = 120 //bed length in cm
+//Calculations
+Theta = 2*tB/(tB+tE)
+lunused = (1-Theta)*120 // cm
+//Results
+printf("the length of the bed unused is %.1f cm",lunused)
diff --git a/1394/CH15/EX15.3.3/Ex15_3_3.sce b/1394/CH15/EX15.3.3/Ex15_3_3.sce new file mode 100755 index 000000000..4e5ca69a4 --- /dev/null +++ b/1394/CH15/EX15.3.3/Ex15_3_3.sce @@ -0,0 +1,19 @@ + +clc
+//initialization of variables
+tB = 10 // min
+tE = 14 // min
+l = 0.12 //m
+l2 = 10 // m
+c = 10000
+A = 1/10000 // m^2
+//Calculations
+theta = 2*tB/(tB+tE)
+l1 = l*(1-theta)// m , length of bed unused in first case
+V1 = c*A*l // m^3
+l3 = l2-l1 // length of bed unused in second case
+d = sqrt(V1*4/(l3*%pi))// m
+V2 = c*(l-l1)*A*l2/l3 // volume needed for second case
+//Results
+printf("The volume of adsorbent needed if the bed is kept 12 cm deep is %.2f m^3",V1)
+printf("\nThe volume of adsorbent needed if the bed length is 10 m long is %.4f m^3",V2)
diff --git a/1394/CH15/EX15.4.1/Ex15_4_1.sce b/1394/CH15/EX15.4.1/Ex15_4_1.sce new file mode 100755 index 000000000..734245cb5 --- /dev/null +++ b/1394/CH15/EX15.4.1/Ex15_4_1.sce @@ -0,0 +1,15 @@ + +clc
+//intialization of variables
+tB1 = 38 // days , breakthrough time
+tE1 = 46 // days, exhaustion time
+c = 2 // number of times flow doubled
+//Calculations
+theta1 = 2*tB1/(tB1+tE1)// in the first case
+ratio1 = 1-theta1 // ratio of unused bed length to total bed length
+ratio2 = ratio1*c
+tB2 = ((1/c)*(tB1 + 0.5*(tE1-tB1)))*ratio2//breakthrough time for second case
+tE2 = (c-ratio2)*tB2/ratio2//exhaustion time for second case
+//Results
+//answwer slightly wrong in textbook
+printf("The breakthrough time for this case is %.1f days",tB2)
diff --git a/1394/CH15/EX15.4.2/Ex15_4_2.sce b/1394/CH15/EX15.4.2/Ex15_4_2.sce new file mode 100755 index 000000000..6a14f7cb1 --- /dev/null +++ b/1394/CH15/EX15.4.2/Ex15_4_2.sce @@ -0,0 +1,18 @@ + +clc
+//initialization of variables
+slope = 0.93/3600 // sec^-1
+q0 = 300 // 300 times y0
+E = 0.4 // void fraction
+d = 310*10^-4 //cm
+v = 1/60 //cm/sec
+Nu = 0.01 //cm^2/sec
+D = 5*10^-6 //cm^2/sec
+//Calculations
+ka1 = slope*q0*(1-E)//sec^-1
+k = (D/d)*1.17*((d*v/Nu)^0.58)*((Nu/D)^0.33)// cm/sec
+a = (6/d)*(1-E)//cm^2/cm^3
+ka2 = k*a//sec^-1
+//Results
+printf("The rate constant is %.3f sec^-1",ka1)
+printf("\nThe rate constant of literature is %.3f sec^-1",ka2)
diff --git a/1394/CH16/EX16.3.2/Ex16_3_2.sce b/1394/CH16/EX16.3.2/Ex16_3_2.sce new file mode 100755 index 000000000..c1c9a65c3 --- /dev/null +++ b/1394/CH16/EX16.3.2/Ex16_3_2.sce @@ -0,0 +1,13 @@ + +clc
+//initialization of variables
+K = 0.0087 // overall m.t.c in cm/sec
+D = 0.98*10^-5 // cm^2/sec
+L = 0.3 // cm
+v = 70 // cm/sec
+nu = 0.01 //cm^2/sec
+//Calculations
+k1 = 0.646*(D/L)*((L*v/nu)^(0.5))*((nu/D)^(1/3))// cm/sec
+k2 = (1/((1/K)-(1/k1)))/// cm/sec
+//Results
+printf("The rate constant for the reaction is %.2f cm/sec",k2)
diff --git a/1394/CH16/EX16.3.3/Ex16_3_3.sce b/1394/CH16/EX16.3.3/Ex16_3_3.sce new file mode 100755 index 000000000..9e152b130 --- /dev/null +++ b/1394/CH16/EX16.3.3/Ex16_3_3.sce @@ -0,0 +1,23 @@ + +
+clc
+//initialization of variables
+D =2*10^-6 // cm^2/sec
+nu = 0.036 // cm^2/sec
+d1 = 1.59 // cm
+d2 = 1 // cm
+deltap = 1*10^-5 // g/cc ( change in density)
+p = 1 // g/cc
+Re = 11200 // Reynolds number
+g = 980 // cm/sec^2
+dis = 5.37*10^-9 // g/cm^2-sec // Dissolution rate
+sol = 1.48*10^-3 // g/cc
+//Calculations
+k11 = 0.62*(D/d1)*(Re^(0.5))*((nu/D)^(1/3))// cm/sec
+K1 = dis/sol// the overall mass transfer co efficient in cm/sec
+k2 = (1/((1/K1)-(1/k11)))/// cm/sec /// the rate constant in cm/sec
+k12 = (D/d2)*(2+(((0.6*((d2^3)*(deltap)*g/(p*nu^2)))^0.25)*((nu/D)^(1/3)))) // cm/sec
+K2 = 1/((1/k12)+(1/k2))// cm/sec (the overall mtc)
+//Results
+printf("the rate of surface reaction is %.7f cm/sec",k2)
+printf("\nThe dissolution rate for 1 cm gallstone is %.7f cm/sec",K2)
diff --git a/1394/CH17/EX17.1.1/Ex17_1_1.sce b/1394/CH17/EX17.1.1/Ex17_1_1.sce new file mode 100755 index 000000000..5fb2828ac --- /dev/null +++ b/1394/CH17/EX17.1.1/Ex17_1_1.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+K = 1.46*10^-4 // lit/mol-sec (rate constant)
+cpyridine = 0.1 // mol/lit
+K1 = 2.0*10^-5 // cm^2/sec
+//Calculations
+D = K*cpyridine // sec^-1
+k0 = (sqrt(D*K1))*10^5//in x*10^-5 cm/sec
+//Results
+printf("The diffusion co efficient of methyl iodide in benzene is %.1f x10^-5 cm/sec",k0)
diff --git a/1394/CH17/EX17.1.2/Ex17_1_2.sce b/1394/CH17/EX17.1.2/Ex17_1_2.sce new file mode 100755 index 000000000..8d8502069 --- /dev/null +++ b/1394/CH17/EX17.1.2/Ex17_1_2.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+R = 0.3 // cm
+K1 = 18.6 // sec^-1
+D = 0.027 // cm^2/sec
+//Calculations
+l = R/3 // cm
+n = (sqrt(D/(K1*(l^2))))*coth(sqrt(K1*(l^2)/D))
+//Results
+printf("The value of reduction in reaction rate due to diffusion is %.2f",n)
diff --git a/1394/CH17/EX17.1.3/Ex17_1_3.sce b/1394/CH17/EX17.1.3/Ex17_1_3.sce new file mode 100755 index 000000000..77ed1a484 --- /dev/null +++ b/1394/CH17/EX17.1.3/Ex17_1_3.sce @@ -0,0 +1,9 @@ + +clc
+//initialization of variables
+k = 16*10^-3 // m.t.c in cm/sec
+D = 1.25*10^-5 // Diffusion co efficient in cm^2/sec
+//Calculations
+K1 = (k^2)/D
+//Results
+printf("The rate constant is %.f sec^-1",K1)
diff --git a/1394/CH17/EX17.2.1/Ex17_2_1.sce b/1394/CH17/EX17.2.1/Ex17_2_1.sce new file mode 100755 index 000000000..8ab0329e9 --- /dev/null +++ b/1394/CH17/EX17.2.1/Ex17_2_1.sce @@ -0,0 +1,12 @@ + +clc
+//initialization of variables
+D2 = 5*10^-6 // The diffusion co efficient of the new compound in cm^2/sec
+Nu = 3 // The factor
+D1 = 0.7*10^-5 // The diffusion co efficient of the original compound in cm^2/sec
+c2l = 1.5*10^-5 // the new solubility in mol/cc
+c1l = 3*10^-7 // The old solubility in mol/cc
+//Calculations
+k = 1 + ((D2*c2l)/(Nu*D1*c1l))// The number of times the rate has increased to the previous rate
+//Results
+printf("There is about a %.f fold increase in rate",k)
diff --git a/1394/CH17/EX17.4.1/Ex17_4_1.sce b/1394/CH17/EX17.4.1/Ex17_4_1.sce new file mode 100755 index 000000000..4478f2f3c --- /dev/null +++ b/1394/CH17/EX17.4.1/Ex17_4_1.sce @@ -0,0 +1,29 @@ + +
+clc
+//initialization of variables
+//For first reaction
+D1 = 9.3*10^-5 // cm^2/sec
+D2 = 5.3*10^-5 // cm^2/sec
+K1exp = 1.4*10^11 // litre/mol-sec
+sigma12 = 2.8*10^-8 // cm
+N = (6.02*10^23)/10^3// liter/cc-mol
+K1 = 4*%pi*(D1+D2)*sigma12*N // Rate constant for first reaction in litre/mol-sec
+printf("The rate constant for this reaction is %.1e litre/",K1)
+if K1>K1exp
+ then disp("This reaction is controlled more by chemical factors")
+ else
+ disp("This reaction is diffusion controlled")
+end
+//Second reaction
+D1 = 5.3*10^-5 // cm^2/sec
+D2 = 0.8*10^-5 // cm^2/sec
+sigma12 = 5*10^-8 // cm
+K1exp = 3.8*10^7 // litre/mol-sec
+K1 = 4*%pi*(D1+D2)*sigma12*N // Rate constant for second reaction in litre/mol-sec
+printf("The rate constant for this reaction is %.1e litre/mol-sec",K1)
+if K1>K1exp then
+ disp("This reaction is controlled more by chemical factors")
+else
+ disp("The reaction is diffusion controlled")
+end
diff --git a/1394/CH17/EX17.5.1/Ex17_5_1.sce b/1394/CH17/EX17.5.1/Ex17_5_1.sce new file mode 100755 index 000000000..d992de91a --- /dev/null +++ b/1394/CH17/EX17.5.1/Ex17_5_1.sce @@ -0,0 +1,16 @@ + +clc
+//intitialization of variables
+d = 5// cm
+v = 200 // cm/sec
+nu = 0.01 // cm^2/sec
+D = 3.2*10^-5 // cm^2/sec
+l = 30*10^-4 // cm
+//Calculations
+Re = d*v/nu // Flow is turbulent
+E = d*v/2 // cm^2/sec
+tou1 = (d^2)/(4*E)// sec
+tou2 = (l^2)/(4*D)
+tou = tou1 + tou2 // sec
+//Results
+printf("The relaxation time is %.2f sec",tou)
diff --git a/1394/CH18/EX18.1.1/Ex18_1_1.sce b/1394/CH18/EX18.1.1/Ex18_1_1.sce new file mode 100755 index 000000000..0aaabb39c --- /dev/null +++ b/1394/CH18/EX18.1.1/Ex18_1_1.sce @@ -0,0 +1,17 @@ + +clc
+//initialization of variables
+d = 240*10^-4 // cm
+D = 2.1*10^-5 // cm^2/sec
+v = 10 // cm/sec
+Nu = 0.01 // cm^2/sec
+E = 0.5
+ka1 = 0.09 // sec^-1
+//Calculations
+k = 0.8*(D/d)*((d*v/Nu)^0.47)*((Nu/D)^0.33)
+a = 4*(1-E)/d // cm^2/cm^3
+ka2 = k*a
+ratio = ka2/ka1
+//results
+printf("The rapidness is roughly %.f times that of sparger",ratio)
+
diff --git a/1394/CH18/EX18.2.1/Ex18_2_1.sce b/1394/CH18/EX18.2.1/Ex18_2_1.sce new file mode 100755 index 000000000..9f6ea361b --- /dev/null +++ b/1394/CH18/EX18.2.1/Ex18_2_1.sce @@ -0,0 +1,12 @@ + +clc
+//initialization of variables
+p1 = 10^-10 // cm^3(stp)cm/cm^2-sec-cm-Hg
+c = 1/(22.4*10^3) // mol at stp /cc
+P = p1*c // for proper units
+R = 6240 // cmHg cm^3 //mol-K (gas constant)
+T = 298 // Kelvin
+//Calculations
+DH = P*R*T*10^9 // Permeability in x*10^-9 cm^2/sec
+//Results
+printf("The permeability is %.1f x10^-9 cm^2/sec",DH)
diff --git a/1394/CH18/EX18.2.2/Ex18_2_2.sce b/1394/CH18/EX18.2.2/Ex18_2_2.sce new file mode 100755 index 000000000..eb17625d9 --- /dev/null +++ b/1394/CH18/EX18.2.2/Ex18_2_2.sce @@ -0,0 +1,14 @@ + +clc
+//initialization of variables
+P = 1*10^-4 // membrane permeability in cm^2/sec
+l = 2.3*10^-4 // membrane thickness in cm
+d = 320*10^-4 // fiber dia in cm
+E = 0.5 // void fraction
+c0 = 1// initial concentration
+c = 0.1// final concentration
+//Calculations
+a = 4*(1-E)/d // surface area per module volume in cm^2/cm^3
+t = (log(c0/c))*(l/P)/a // t = z/v in seconds , time gas spends in the module in sec
+//Results
+printf("The gas spends %.2f sec in the module",t)
diff --git a/1394/CH18/EX18.3.1/Ex18_3_1.sce b/1394/CH18/EX18.3.1/Ex18_3_1.sce new file mode 100755 index 000000000..a0e0d8b1f --- /dev/null +++ b/1394/CH18/EX18.3.1/Ex18_3_1.sce @@ -0,0 +1,28 @@ + +clc
+//initialization of variables
+R = 0.082 // litre-atm/mol-K
+T = 283 // Kelvin
+V2 = 0.018 // litre/mol
+//For first solution contents are sucrose and water
+w1 = 0.01 // gm of sucrose
+MW1 = 342 // MW of sucrose
+w2 = 0.09 // gm of water
+MW2 = 18 // MW of water
+n1 = 1 // no of particles sucrose divides into in water
+//Calculations
+x1juice = (n1*w1/MW1)/((n1*w1/MW1)+(w2/MW2))// Mole fracion of sucrose
+//For second solution , contents are NaCl and water
+w1 = 35 // gm of NaCl
+MW1 = 58.5 // MW of Nacl
+w2 = 100 // gm of water
+MW2 = 18 // MW of water
+n1 = 2 // no of particles sucrose divides into in water
+//Calculations
+x1brine = (n1*w1/MW1)/((n1*w1/MW1)+(w2/MW2))// Mole fracion of sucrose
+//Calculation of difference in Osmotic pressure
+DeltaPi = (R*T/V2)*log((1-x1juice)/(1-x1brine))// atm
+//Results
+printf("The osmotic pressure difference is %.f atm",DeltaPi)
+//answer wrong in textbook
+
diff --git a/1394/CH18/EX18.3.2/Ex18_3_2.sce b/1394/CH18/EX18.3.2/Ex18_3_2.sce new file mode 100755 index 000000000..02b7e725f --- /dev/null +++ b/1394/CH18/EX18.3.2/Ex18_3_2.sce @@ -0,0 +1,22 @@ + +clc
+//initialization of variables
+D1=0.0035
+l=2.59 //cm
+t=1.62 //hr
+C1=0.03 //mol/l
+T1=298 //K
+R=0.0821 //arm/mol K
+D2=0.005
+t2=0.49 //hr
+Ps=733 //mm of Hg
+P=760 //mm of Hg
+//calculations
+Lps=D1*l/(t*3600) /(C1*R*T1)
+Lp=(D2*l/(t2*3600) + Lps*(C1*R*T1))/(Ps/P)
+Lp=2.4*10^-6
+sig=Lps/Lp
+sig2=0.95
+//results
+printf("Transport coefficient for phase 1 = %.2f",sig)
+printf("\n Transport coefficient for phase 2 = %.2f",sig2)
diff --git a/1394/CH18/EX18.4.1/Ex18_4_1.sce b/1394/CH18/EX18.4.1/Ex18_4_1.sce new file mode 100755 index 000000000..81a0c7ec1 --- /dev/null +++ b/1394/CH18/EX18.4.1/Ex18_4_1.sce @@ -0,0 +1,13 @@ + +clc
+//initialization of variables
+D1 = 3.0*10^-7 // cm^2/sec
+H1 = 0.18 // mol/cc-atm
+D2 = 1.4*10^-6 // cm^2/sec
+H2 = 2.2*10^-3 // mol/cc-atm
+H11 = 13 // atm-cc/mol
+H21 = 0.6 // atm-cc/mol
+//Calculations
+Beta = (D1*H1/(D2*H2))*(H11/H21)// Membrane selectivity
+//Results
+printf("The membrane selectivity is %.f",Beta)
diff --git a/1394/CH18/EX18.5.2/Ex18_5_2.sce b/1394/CH18/EX18.5.2/Ex18_5_2.sce new file mode 100755 index 000000000..eb94e6a1d --- /dev/null +++ b/1394/CH18/EX18.5.2/Ex18_5_2.sce @@ -0,0 +1,25 @@ + +clc
+// Initialization of variables
+D = 2*10^-5 // cm^2/sec
+l = 32*10^-4 // cm
+c = 6.8*10^-6 // mol/cc
+C10 = 10^-4 // mol/cc
+function[j] = Totalflux(H,K)
+ j = (D*H*C10/l)+((D*H*K*c*C10)/(l*(1+(H*K*C10))))
+endfunction
+//For Lithium Chloride
+H1 = 4.5*10^-4 //Partition coefficient
+K1 = 2.6*10^5 // cc/mol association constant
+j1 = (Totalflux(H1,K1))*10^10 // TOtal flux in x*10^-10 mol/cm^2-sec
+printf("The total flux for Lithium Chloride is %.1f x10^-10 mol/cm^2-sec",j1)
+ //For Sodium Chloride
+H2 = 3.4*10^-4 //Partition coefficient
+K2 = 1.3*10^7 // cc/mol association constant
+j2 = (Totalflux(H2,K2))*10^10 // TOtal flux in x*10^-10 mol/cm^2-sec
+printf("\nThe total flux for Sodium Chloride is %.1f x10^-10 mol/cm^2-sec",j2)
+ //For potassium Chloride
+H3 = 3.8*10^-4 //Partition coefficient
+K3 = 4.7*10^9 // cc/mol association constant
+j3 = (Totalflux(H3,K3))*10^10 // TOtal flux in x*10^-10 mol/cm^2-sec
+printf("\nThe total flux for Potassium Chloride is %.1f x10^-10 mol/cm^2-sec",j3)
diff --git a/1394/CH19/EX19.1.1/Ex19_1_1.sce b/1394/CH19/EX19.1.1/Ex19_1_1.sce new file mode 100755 index 000000000..160ddfb16 --- /dev/null +++ b/1394/CH19/EX19.1.1/Ex19_1_1.sce @@ -0,0 +1,17 @@ + +
+clc
+//initialization of variables
+VP = 0.045*10^-3// Vapor pressure of permethrin in kg/m-sec^2
+R = 8.31 // Gas constant in kg-m^2/sec^2-gmol-K
+l = 63*10^-6 // membrane thickness in m
+A = 12*10^-4 // area surrounded by the membrane in m^2
+M1 = 19*10^-3 // Permithrin release in gmol
+t = 24*3600 // time taken to release
+T = 298 // Kelvin
+MW = 391 // Mol wt
+//Calculations
+c1 = VP/(R*T) // C1sat
+P = (M1/(t*MW))*(l/c1)*(1/A)*10^-3 //Permeability in cm^2/sec
+//Results
+printf("The permeability is %.1e m^2/sec",P)
diff --git a/1394/CH19/EX19.2.1/Ex19_2_1.sce b/1394/CH19/EX19.2.1/Ex19_2_1.sce new file mode 100755 index 000000000..ab5148496 --- /dev/null +++ b/1394/CH19/EX19.2.1/Ex19_2_1.sce @@ -0,0 +1,14 @@ + +clc
+//initialization of variables
+M= 25*10^-6 //gm/hr
+d = 0.006 //g/cc
+P = 1.4*10^-4// permeance in cm/sec
+Deltac1 = 0.006 //Equivalent//cc
+//Calculations
+c1 = 1/3600 // unit conversion factor hr/sec
+c2 = 1/18 //unit conversion factor mole/cc
+m = M*c1*c2/d // moles/sec
+A = m/(P*Deltac1)//cm^2
+//Results
+printf("you will need a membrane area of %.3f cm^2",A)
diff --git a/1394/CH20/EX20.1.1/Ex20_1_1.sce b/1394/CH20/EX20.1.1/Ex20_1_1.sce new file mode 100755 index 000000000..9afb25c71 --- /dev/null +++ b/1394/CH20/EX20.1.1/Ex20_1_1.sce @@ -0,0 +1,13 @@ + +clc
+//initialization of variables
+T = 26.2 // centigrade
+T0 = 4 // centigrade
+Tinf = 40 //centigrade
+z = 1.3//cm
+t = 180 //seconds
+//calculations
+k = erfinv((T-T0)/(Tinf-T0))
+alpha = (1/(4*t))*((z/k)^2)//cm^2/sec
+//Results
+printf("The thermal diffusivity is %.3f",alpha)//answer wrong in textbook
diff --git a/1394/CH20/EX20.3.1/Ex20_3_1.sce b/1394/CH20/EX20.3.1/Ex20_3_1.sce new file mode 100755 index 000000000..ff873dd7a --- /dev/null +++ b/1394/CH20/EX20.3.1/Ex20_3_1.sce @@ -0,0 +1,21 @@ + +clc
+//initialization of variables
+Q = 18 // m^3/hr
+z = 2.80 //m
+T = 140//C
+T1 = 240 //C
+T2 = 20 //C
+p= 900 //kg/m^3
+Cp = 2 // W/kg-K
+d = 0.05//m
+//Calculations
+A = %pi*(d^2)/4
+v = Q*(1/(3600*40))/(A)
+U = (v*p*Cp*d/(4*z))*(log((T1-T2)/(T1-T)))//W/m^2-K
+DeltaT = ((T1-T2)+(T1-T))/2//C
+q = (Q*(1/(3600*40))*p*Cp/(%pi*d*z))*(T-T2)//W/m^2-K
+U1 = q/DeltaT//W/m^2-K
+//Results
+printf("The overall heat transfer co efficient based on local temp difference is %.2f W/m^2-K",U)
+printf("\nThe overall heat transfer co efficient based on average temp difference is %.2f W/m^2-K",U1)
diff --git a/1394/CH20/EX20.3.2/Ex20_3_2.sce b/1394/CH20/EX20.3.2/Ex20_3_2.sce new file mode 100755 index 000000000..3fbd1f6bc --- /dev/null +++ b/1394/CH20/EX20.3.2/Ex20_3_2.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+T = 32 //F
+T0 = 10//F
+Tinf= 80 //F
+U = 3.6 //Btu/hr-ft^2-F
+A = 27 //ft^2
+d = 8.31 //lb/gal
+V = 100 //gal
+Cv = 1//Btu/lb-F
+//Calculations
+t = (-log((T-T0)/(Tinf-T0)))*d*V*Cv/(U*A)//hr
+//Results
+printf("The time we can wait before the water in the tank starts to freeze is %.f hr",t)
diff --git a/1394/CH20/EX20.3.3/Ex20_3_3.sce b/1394/CH20/EX20.3.3/Ex20_3_3.sce new file mode 100755 index 000000000..190055583 --- /dev/null +++ b/1394/CH20/EX20.3.3/Ex20_3_3.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+//Given q = h*DeltaT and 0.6q = (1/(1/h)+10/12*0.03)*delta T , divide both to get
+l = 10/12 //ft
+k = 0.03 //Btu/hr-ft-F
+//Calculations
+l2 = 2//feet
+k2 = 0.03 //Btu/hr-ft-F
+h = ((1/0.6)-1)*k/l //Btu/hr-ft^2-F
+U = 1/((1/h)+(l2/k2))//Btu/hr-ft^2-F
+Savings = U*100/h
+//Results
+printf("The savings due to insulation is about %.f percent",Savings)
+
diff --git a/1394/CH20/EX20.4.1/Ex20_4_1.sce b/1394/CH20/EX20.4.1/Ex20_4_1.sce new file mode 100755 index 000000000..719c47386 --- /dev/null +++ b/1394/CH20/EX20.4.1/Ex20_4_1.sce @@ -0,0 +1,30 @@ + +clc
+//initialization of variables
+T = 673 // Kelvin
+M = 28
+sigma = 3.80 // angstroms
+omega = 0.87
+d1 = 0.05 //m
+v1 = 17 //m/sec
+Mu1 = 3.3*10^-5 // kg/m-sec
+p1 = 5.1*10^-1 // kg/m^3
+Cp1 = 1100 // J/kg-K
+k2 = 42 // W/m-K
+l2 = 3*10^-3 //m
+d3 = 0.044 //m
+v3 = 270 //m/sec
+p3 = 870 //kg/m^3
+Mu3 = 5.3*10^-4 // kg/m-sec
+Cp3 = 1700// J/kg-K
+k3 = 0.15 //W/m-K
+//Calculations
+kincal = (1.99*10^-4)*(sqrt(T/M))/((sigma^2)*omega)//W/m^2-K
+k = kincal*4.2*10^2// k in W/m-K
+h1 = 0.33*(k/d1)*((d1*v1*p1/Mu1)^0.6)*((Mu1*Cp1/k)^0.3)//W/m^2-K
+h2 = k2/l2 //W/m^2-K
+h3 = 0.027*(k3/d3)*((d3*v3*p3/Mu3)^0.8)*((Mu3*Cp3/k3)^0.33)//W/m^2-K
+U = 1/((1/h1)+(1/h2)+(1/h3))//W/m^2-K
+//Results
+printf("The overall heat transfer co efficient is %.f W/m^2-K",U)
+
diff --git a/1394/CH20/EX20.4.2/Ex20_4_2.sce b/1394/CH20/EX20.4.2/Ex20_4_2.sce new file mode 100755 index 000000000..b38ffb0d3 --- /dev/null +++ b/1394/CH20/EX20.4.2/Ex20_4_2.sce @@ -0,0 +1,25 @@ + +clc
+//initialization of variables
+//For window with two panes 3 cm apart
+k = 0.57*10^-4 //cal/cm-sec-K
+l = 3 //cm
+g = 980 // cm/sec^2
+Nu = 0.14 // cm^2/sec
+DeltaT = 30 // Kelvin
+T = 278 // Kelvin
+L = 100 // cm
+//calculations
+h = (0.065*(k/l)*(((l^3)*g*DeltaT/((Nu^2)*T))^(1/3))*((l/L)^(1/9)))*10^4//for two pane in x*10^-4 cal/cm^2-sec-K
+printf("The heat transfer co efficent for two panes is %.2f x10^-4 cal/cm^2-sec-K",h)
+
+//For window with three panes 1.5 cm each apart
+k = 0.57*10^-4 //cal/cm-sec-K
+l = 1.5//cm
+DeltaT = 15 // Kelvin
+g = 980 // cm/sec^2
+Nu = 0.14 // cm^2/sec
+//calculations
+h = (0.065*(k/l)*(((l^3)*g*DeltaT/((Nu^2)*T))^(1/3))*((l/L)^(1/9)))*10^4//for two pane in x*10^-4 cal/cm^2-sec-K
+printf("\nThe heat transfer co efficent for three panes is %.2f x10^-4 cal/cm^2-sec-K",h/2)//Because there are two gaps
+
diff --git a/1394/CH21/EX21.1.2/Ex21_1_2.sce b/1394/CH21/EX21.1.2/Ex21_1_2.sce new file mode 100755 index 000000000..11725ad9f --- /dev/null +++ b/1394/CH21/EX21.1.2/Ex21_1_2.sce @@ -0,0 +1,17 @@ + +
+clc
+//initialization of variables
+Tdisc = 30 // Centigrade
+T = 21 // Centigrade
+T0 = 18 // Centigrade
+R0 = 1.5 // cm
+V = 1000 // cc
+t = 3600 //seconds
+Nu = 0.082 //cm^2/sec
+omeg = 2*%pi*10/60 //sec^-1
+//Calculations
+k = -V*(log((Tdisc-T)/(Tdisc-T0)))/(%pi*(R0^2)*t)// k = h/d*cp cm/sec
+alpha = ((1/0.62)*(k)*(Nu^(1/6))*(omeg^(-0.5)))^1.5 // cm^2/sec
+//Results
+printf("the value of thermal diffusivity is %.1e cm^2/sec",alpha)
diff --git a/1394/CH21/EX21.3.1/Ex21_3_1.sce b/1394/CH21/EX21.3.1/Ex21_3_1.sce new file mode 100755 index 000000000..dbd8ffa2a --- /dev/null +++ b/1394/CH21/EX21.3.1/Ex21_3_1.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+d =1000 // kg/m^3
+h = 30 // W/m^2-C-sec
+Hvap = 2300*10^3 // J/kg
+T = 75 // C
+Ti = 31 // C
+l = 0.04 // m
+epsilon = 0.36
+c = 3600 // sec/hr
+t1 = (Hvap/h)*(1/(T-Ti))*(l*epsilon*d)// sec
+t = t1/c // in hr
+//Results
+printf("The time taken for drying is %.f hr",t)// answer wrong in textbook
diff --git a/1394/CH21/EX21.3.2/Ex21_3_2.sce b/1394/CH21/EX21.3.2/Ex21_3_2.sce new file mode 100755 index 000000000..e5c630c5c --- /dev/null +++ b/1394/CH21/EX21.3.2/Ex21_3_2.sce @@ -0,0 +1,17 @@ + +clc
+//intialization of variables
+d = 100*10^-4 // cm
+v = 10^-3// cm/sec
+nu = 0.2 // cm^2/sec
+DS = 0.3 // cm^2/sec
+DG = 3*10^-7 // cm^2/sec
+H = 4.3*10^-4 // at 60 degree centigrade
+//Calculations
+kG = (2+(0.6*((d*v/nu)^0.5)*((nu/DS)^(1/3))))*DS/d// cm/sec
+k = kG*H
+t = 30*DG/k^2
+//Results
+printf("The mass transfer coefficient is %.5f cm/sec",k)
+printf("\nTHe time needed to dry the particle is %.6f sec",t)
+//Answer wrong in textbook starting from kG
diff --git a/1394/CH21/EX21.4.1/Ex21_4_1.sce b/1394/CH21/EX21.4.1/Ex21_4_1.sce new file mode 100755 index 000000000..234bacda9 --- /dev/null +++ b/1394/CH21/EX21.4.1/Ex21_4_1.sce @@ -0,0 +1,21 @@ + +clc
+//initialization of variables
+slope = 230 //J/g-mol-C
+nair = 60 // gmol/cm^2-sec
+CpH2O = 75 // J/gmol-C
+f = 0.4 // Correction factor
+F = 2150/(60*0.018)//gmol/m^2-sec
+kc= 20/3
+a = 3 // m^2/m^3
+k = 2.7 // integral of dH/Hi-H with limits Hout and Hin
+//Calculations
+nH2Omax = slope*nair/CpH2O//gmol/m^2-sec
+nH2O = nH2Omax*(1-f) //gmol/m^2-sec
+A = F/nH2O // m^2
+l = (nair/(kc*a))*k // m
+//Results
+printf("The flow rate of the water per tower cross section is %.f gmol H2O/m^2-sec",nH2O)
+printf("\nThe area of tower cross section is %.f m^2",A)
+printf("\nThe length of the tower is %.1f m",l)
+
diff --git a/1394/CH21/EX21.5.1/Ex21_5_1.sce b/1394/CH21/EX21.5.1/Ex21_5_1.sce new file mode 100755 index 000000000..d1cff006c --- /dev/null +++ b/1394/CH21/EX21.5.1/Ex21_5_1.sce @@ -0,0 +1,26 @@ + +clc
+//initialization of variables
+A = 0.01 // cm^2
+l = 1 // cm
+VA = 3 // cc
+VB = 3 // cc
+alphagas = 0.29
+alphaliquid = -1.3
+x1 = 0.5
+x2 = 0.5
+deltaT = 50 // Kelvin Thot-Tcold = 50
+Tavg = 298 // kelvin
+Dgas = 0.3 // cm^2/sec
+Dliquid = 10^-5 // cm^2/sec
+//calculations
+deltaY = alphagas*x1*x2*deltaT/Tavg // Y1hot-Y1cold = DeltaY
+deltaX = alphaliquid*x1*x2*deltaT/Tavg// X1hot-X1cold = DeltaX
+Beta = (A/l)*((1/VA)+(1/VB))//cm^-2
+BetaDgasinverse = 1/(Beta*Dgas)// sec
+BetaDliquidinverse = (1/(Beta*Dliquid))/(365*24*60*60)
+//Results
+printf("The seperation achieved for gas is %.3f",deltaY)
+printf("\nThe seperation achieved for liquid is %.2f",deltaY)
+printf("\nThe time taken for seperation for gas will be %.f seconds",BetaDgasinverse)
+printf("\nThe time taken for seperation for liquid will be %.1f year",BetaDliquidinverse)
diff --git a/1394/CH3/EX3.2.4/Ex3_2_4.sce b/1394/CH3/EX3.2.4/Ex3_2_4.sce new file mode 100755 index 000000000..e6747c18f --- /dev/null +++ b/1394/CH3/EX3.2.4/Ex3_2_4.sce @@ -0,0 +1,15 @@ + +clc
+D = 0.1 // cm^2/sec
+l = 10 // cm
+C10 = 1
+C1l = 0
+C1 = 0.5
+V1 = (D/l)*(C10 - C1l)/C1 // Cm/sec
+V2 = -V1
+M1 = 28
+M2 = 2
+omeg1 = C1*M1/(C1*M1 + C1*M2)
+omeg2 = C1*M2/(C1*M1 + C1*M2)
+V = omeg1*V1 + omeg2*V2
+printf("The mass average velocity is %.5f cm/s",V)
diff --git a/1394/CH3/EX3.3.1/Ex3_3_1.sce b/1394/CH3/EX3.3.1/Ex3_3_1.sce new file mode 100755 index 000000000..895e4340e --- /dev/null +++ b/1394/CH3/EX3.3.1/Ex3_3_1.sce @@ -0,0 +1,23 @@ + +clc
+//initialization of variables
+// At 6 degree centigrade
+p1sat = 37 // Vapor pressure of benzene in mm Hg
+p = 760 // atmospheric pressure in mm Hg
+y1l = 0
+y10 = p1sat/p
+n1byDcbyl = log((1-y1l)/(1-y10))// because flux n1 = D*c/l * ln(1-y11/1-y10)
+n2byDcbyl = y10-y1l // Flux calculated assuming dilute solution as n1 = Dc/l*(y10-y1l)
+err1 = ((n1byDcbyl-n2byDcbyl)/n2byDcbyl)*100 // Percentage error
+printf("The error in measurement at 6 degree centigrade is %.1f percent",err1)
+// At 60 degree centigrade
+p1sat = 395 // Vapor pressure of benzene in mm Hg
+p = 760 // atmospheric pressure in mm Hg
+y1l = 0
+y10 = p1sat/p
+n1byDcbyl = log((1-y1l)/(1-y10))// because flux n1 = D*c/l * ln(1-y11/1-y10)
+n2byDcbyl = y10-y1l // Flux calculated assuming dilute solution as n1 = Dc/l*(y10-y1l)
+err1 = ((n1byDcbyl-n2byDcbyl)/n2byDcbyl)*100 // Percentage error
+printf("\n The error in measurement at 60 degree centigrade is %.1f percent",err1)
+
+
diff --git a/1394/CH4/EX4.2.1/Ex4_2_1.sce b/1394/CH4/EX4.2.1/Ex4_2_1.sce new file mode 100755 index 000000000..40a07e842 --- /dev/null +++ b/1394/CH4/EX4.2.1/Ex4_2_1.sce @@ -0,0 +1,22 @@ + +clc
+//initialization of variables
+z = 80 // metres
+c1 = 410 //ppm
+c = 860 // ppm
+d = 2 //km
+v = 0.6 //km/hr
+r = 3600 //sec/hr
+//Calculations
+t1 = (d/v)*r//sec
+E = (-((z^2)/(4*t1))/(log(410/860)))*10^4// cm^2/sec//answer in textbook is wrong
+d2 = 15 //km
+c2 = c*(sqrt(d/d2))//ppm
+//Results
+printf("The value of dispersion coefficent is %.f cm^2/sec",E)
+printf("\n The value of maximum concentration at 15 km downstream is %.f ppm",c2)
+
+
+
+
+
diff --git a/1394/CH4/EX4.2.2/Ex4_2_2.sce b/1394/CH4/EX4.2.2/Ex4_2_2.sce new file mode 100755 index 000000000..2097e2fe4 --- /dev/null +++ b/1394/CH4/EX4.2.2/Ex4_2_2.sce @@ -0,0 +1,15 @@ + +clc
+//initialization of variables
+d = 10 //cm
+s = 3 // km
+v = 500 //cm/sec
+nu = 0.15 // cm^2/sec
+//Calculations
+E = 0.5*d*v // cm^2/sec
+c1 = 1000 // m/km
+c2 = 1/100 // m/cm
+z = sqrt(4*E*c1*c2*s/v)
+percent = z*100/(s*c1)
+//Results
+printf(" The percent of pipe containing mixed gases is %.1f percent",percent)
diff --git a/1394/CH5/EX5.1.1/Ex5_5_1.sce b/1394/CH5/EX5.1.1/Ex5_5_1.sce new file mode 100755 index 000000000..ee017e7f3 --- /dev/null +++ b/1394/CH5/EX5.1.1/Ex5_5_1.sce @@ -0,0 +1,12 @@ + +clc +//initialization of variables +m = 20/(6*10^23)//wt of each molecule +kb = 1.38*10^-16 // g-cm^2/sec-K +T = 298 // Kelvin +dou = 0.04*10^-7 // cm +//Calculations +v = sqrt(kb*T*2/m) //cm/sec +D = (dou*v/6)*10^5 // in x*10^-5 cm^2/sec +//Results +printf("The value of Diffusion co efficient is %.f x10^-5 cm^2/sec",D) diff --git a/1394/CH5/EX5.1.2/Ex5_1_2.sce b/1394/CH5/EX5.1.2/Ex5_1_2.sce new file mode 100755 index 000000000..b72c216c0 --- /dev/null +++ b/1394/CH5/EX5.1.2/Ex5_1_2.sce @@ -0,0 +1,24 @@ + +clc
+//Initialization of variables
+sigma1 = 2.92 // angstroms
+sigma2 = 3.68 // angstroms
+sigma12 = (sigma1+sigma2)/2 // angstroms
+T = 294 // Kelvin
+M1 = 2.02 // Mol wt of hydrogen
+V1 = 7.07
+V2 = 17.9
+M2 = 28 // Mol wt of Nitrogen
+p = 2 //atm
+Omega = 0.842
+Dexp = 0.38 // cm^2/sec
+//calculations
+D1 = ((1.86*10^-3)*((T)^1.5)*(((1/M1)+(1/M2))^0.5))/((p)*((sigma12)^2)*Omega)//cm^2/sec
+err1 = ((Dexp-D1)/Dexp)*100
+D2 = ((10^-3)*((T)^1.75)*(((1/M1)+(1/M2))^0.5))/((p)*((((V1)^(1/3))+ ((V2)^(1/3)))^2)) //cm^2/sec
+err2 = ((Dexp-D2)/Dexp)*100
+//Results
+printf("The diffusion co efficient using Chapman-enskong theory is %.2f cm^2/sec",D1)
+printf("\nThe error for the above correlation is %.f percent",err1)
+printf("\nThe diffusion co efficient using Fuller correlation is %.2f cm^2/sec",D2)
+printf("\nThe error for the above correlation is %.f percent",err2)
diff --git a/1394/CH5/EX5.1.3/Ex5_1_3.sce b/1394/CH5/EX5.1.3/Ex5_1_3.sce new file mode 100755 index 000000000..ba409ca4a --- /dev/null +++ b/1394/CH5/EX5.1.3/Ex5_1_3.sce @@ -0,0 +1,12 @@ +
+
+clc
+//initialization of variables
+p0 = 1//atm
+p = 33 //atm
+D0 = 0.043 // cm^2/sec
+//Calculations
+D = (p0*D0/p)*10^5 // x*10^-5 cm^2/sec
+//Results
+printf("The diffusion co efficient for the given conditions is %.3f x10^-5 cm^2/sec",D)
+disp("The answer is a bit different due to rounding off error in textbook. Also please verify that 10^-5 factor is utilized outside.")
diff --git a/1394/CH5/EX5.2.1/Ex5_2_1.sce b/1394/CH5/EX5.2.1/Ex5_2_1.sce new file mode 100755 index 000000000..970e4407c --- /dev/null +++ b/1394/CH5/EX5.2.1/Ex5_2_1.sce @@ -0,0 +1,24 @@ + +clc
+//Initialization of variables
+R0 = 1.73*10^-8 //cm
+kb = 1.38*10^-16 // g-cm^2/sec^2-K
+T = 298 // kelvin
+Mu = 0.01 // g/cm-sec
+Mu2 = 1 // Centipoise
+DE = 1.80//x*10^-5 cm^2/sec
+phi = 2.6
+VH2O = 18 // cc/g-mol
+VO2 = 25 // cc/g-mol
+//calculations
+D1 = ((kb*T)/(6*%pi*Mu*R0))*10^5// x*10^-5 cm^2/sec
+err1 = (DE-D1)*100/DE // error percentage
+D2 = (((8.2*10^-8)*T/(Mu2*((VO2)^(1/3))))*(1+ ((3*VH2O/VO2)^(2/3))))*10^5 //x*10^-5 cm^2/sec
+err2 = (D2-DE)*100/DE // Error percentage
+D3 = (((7.4*10^-8)*((phi*VH2O)^0.5)*T)/(Mu2*((VO2)^0.6)))*10^5//x*10^-5 cm^2/sec
+err3 = (D3-DE)*100/DE// Error percentage
+//Results
+printf("The diffusion co efficent using Stokes einstien correlation is %.1f x10^-5 cm^2/sec",D1)
+printf("\nThe error regarding above correlation is %.1f percent low",err1)
+printf("\nThe diffusion co efficent using Wilke-Chang correlation is %.1f x10^-5 cm^2/sec",D3)
+printf("\nThe error regarding above correlation is %.1f percent high",err3)
diff --git a/1394/CH5/EX5.2.2/Ex5_2_2.sce b/1394/CH5/EX5.2.2/Ex5_2_2.sce new file mode 100755 index 000000000..1f92b47ed --- /dev/null +++ b/1394/CH5/EX5.2.2/Ex5_2_2.sce @@ -0,0 +1,14 @@ + +clc
+//Initialization of variables
+kb = 1.38*10^-16//g-cm^2-sec^2-K
+T = 310 // kelvin
+k = 30 // which is a/b
+D = 2.0*10^-7 // cm^2/sec
+Mu = 0.00695 // g/cm-sec
+//Calculations
+a = ((kb*T/(6*%pi*Mu*D))*((log(k + ((k^2-1)^(0.5))))/((1-(1/k^2))^0.5)))*10^7 // nm
+b = a/k // nm
+//Results
+printf("The results of a and b are %.f nm and %.1f nm",a,b)
+
diff --git a/1394/CH5/EX5.2.3/Ex5_2_3.sce b/1394/CH5/EX5.2.3/Ex5_2_3.sce new file mode 100755 index 000000000..eebb36d57 --- /dev/null +++ b/1394/CH5/EX5.2.3/Ex5_2_3.sce @@ -0,0 +1,13 @@ + +clc
+//initialization of variables
+D1 = 1.26*10^-5 // for x1=1 , D0 value in cm^2/sec
+x1 = 0.5
+D2 = 4.68*10^-5 // for x2=1 , D0 Value in cm^2/sec
+x2 = 0.5
+k = -0.69 // dlngamma1/dx1 value given
+//Calculations
+D0 = ((D1)^x1)*((D2)^x2)*10^5 // x*10^-5 cm^2/sec
+D = D0*(1+k) // Diffusion coefficient in x*10^-5 cm^2/sec
+//Results
+printf("The diffusion coefficent is %.2f x10^-5 cm^2/sec",D)
diff --git a/1394/CH5/EX5.5.1/Ex5_5_1.sce b/1394/CH5/EX5.5.1/Ex5_5_1.sce new file mode 100755 index 000000000..1d830db21 --- /dev/null +++ b/1394/CH5/EX5.5.1/Ex5_5_1.sce @@ -0,0 +1,12 @@ + +clc
+//initialization of variables
+m = 20/(6*10^23)//wt of each molecule
+kb = 1.38*10^-16 // g-cm^2/sec-K
+T = 298 // Kelvin
+dou = 0.04*10^-7 // cm
+//Calculations
+v = sqrt(kb*T*2/m) //cm/sec
+D = (dou*v/6)*10^5 // in x*10^-5 cm^2/sec
+//Results
+printf("The value of Diffusion co efficient is %.f x10^-5 cm^2/sec",D)
diff --git a/1394/CH5/EX5.5.2/Ex5_5_2.sce b/1394/CH5/EX5.5.2/Ex5_5_2.sce new file mode 100755 index 000000000..7e4b2c163 --- /dev/null +++ b/1394/CH5/EX5.5.2/Ex5_5_2.sce @@ -0,0 +1,9 @@ + +clc
+//Intialization of variables
+sigmasquare = 0.014 // Slope of the graph
+t = 150 // seconds
+//Calculations
+D = (sigmasquare/(2*t))*10^5 // in x*10^-5 cm^2/sec
+//Results
+printf("The value of diffusion co efficient is %.1f x10^-5 cm^2/sec",D)
diff --git a/1394/CH6/EX6.1.1/Ex6_1_1.sce b/1394/CH6/EX6.1.1/Ex6_1_1.sce new file mode 100755 index 000000000..1b2f9144a --- /dev/null +++ b/1394/CH6/EX6.1.1/Ex6_1_1.sce @@ -0,0 +1,12 @@ + +clc
+//Initialization of variables
+DHplus = 9.31*10^-5 // cm^2/sec
+DClminus = 2.03*10^-5 // cm^2/sec
+//Calculations
+DHCl = (2/((1/DHplus)+(1/DClminus)))*10^5 // x*10^-5 cm^2/sec
+tHplus = DHplus/(DHplus+DClminus)
+percentage = tHplus*100 // percent
+//Results
+printf("The diffusion co efficient of the solution is %.1f x10^-5 cm^2/sec",DHCl)
+printf("\n The transeference for protons is %.f percent",percentage)
diff --git a/1394/CH6/EX6.1.2/Ex6_1_2.sce b/1394/CH6/EX6.1.2/Ex6_1_2.sce new file mode 100755 index 000000000..2637c5768 --- /dev/null +++ b/1394/CH6/EX6.1.2/Ex6_1_2.sce @@ -0,0 +1,11 @@ + +clc
+//Initialization of variables
+z1 = 3
+z2 = 1
+D2 = 2.03*10^-5 // cm^2/sec
+D1 = 0.62*10^-5 // cm^2/sec
+//Calculations
+D = ((z1+z2)/((z1/D2)+(z2/D1)))*10^5// x*10^-5 cm^2/sec
+//Results
+printf("The diffusion coefficient is %.2f x10^-5 cm^2/sec",D)
diff --git a/1394/CH6/EX6.1.5/Ex6_1_5.sce b/1394/CH6/EX6.1.5/Ex6_1_5.sce new file mode 100755 index 000000000..e1bf0940e --- /dev/null +++ b/1394/CH6/EX6.1.5/Ex6_1_5.sce @@ -0,0 +1,11 @@ + + clc
+//Initialization of variables
+zCa = 2
+zCl = 1
+DCl = 2.03*10^-5 // cm^2/sec
+DCa = 0.79*10^-5 // cm^2/sec
+//Calculations
+DCaCl2 = ((zCa+zCl)/((zCa/DCl)+(zCl/DCa)))*10^5// x*10^-5 cm^2/sec
+//Results
+printf("The diffusion coefficient of CaCl2 is %.2f x10^-5 cm^2/sec",DCaCl2)
diff --git a/1394/CH6/EX6.2.1/Ex6_2_1.sce b/1394/CH6/EX6.2.1/Ex6_2_1.sce new file mode 100755 index 000000000..b887bda80 --- /dev/null +++ b/1394/CH6/EX6.2.1/Ex6_2_1.sce @@ -0,0 +1,14 @@ + +clc
+//initialization of variables
+pKa = 4.756
+DH = 9.31*10^-5 // cm^2/sec
+DCH3COO = 1.09*10^-5 //cm^2/sec
+D2 = 1.80*10^-5 //cm^2/sec
+Ct = 10 // moles/lit
+//Calculations
+K = 10^pKa // litres/mol
+D1 = 2/((1/DH)+(1/DCH3COO))
+D = 2/((1/D1)+(1/D2))*10^5// Diffusion co efficient in x*10^-5 cm^2/sec
+//Results
+printf("The diffusion coefficient of acetic acid in water is %.1f x10^-5 cm^2/sec",D)
diff --git a/1394/CH6/EX6.4.1/Ex6_4_1.sce b/1394/CH6/EX6.4.1/Ex6_4_1.sce new file mode 100755 index 000000000..94ee06b8f --- /dev/null +++ b/1394/CH6/EX6.4.1/Ex6_4_1.sce @@ -0,0 +1,18 @@ + +clc
+//Initialization of variables
+sigma1 = 4.23 // angstroms
+sigma2 = 4.16 //Angstroms
+sigma12 = (sigma1+sigma2)/2 // angstroms
+T = 573 // Kelvin
+M1 = 28
+M2 = 26
+p = 1 //atm
+Omega = 0.99
+Deff = 0.17 //cm^2/sec
+//calculations
+D = ((1.86*10^-3)*((T)^1.5)*(((1/M1)+(1/M2))^0.5))/((p)*((sigma12)^2)*Omega)//cm^2/sec
+Tou = D/Deff
+//Results
+printf("The tortuosity is %.f",Tou)
+
diff --git a/1394/CH6/EX6.4.2/Ex6_4_2.sce b/1394/CH6/EX6.4.2/Ex6_4_2.sce new file mode 100755 index 000000000..21cfbd882 --- /dev/null +++ b/1394/CH6/EX6.4.2/Ex6_4_2.sce @@ -0,0 +1,12 @@ + +clc
+//Initialzation of variables
+kb = 1.38*10^-16 // g-cm^2/sec^2-K
+T = 310 //Kelvin
+Mu = 0.01 // g/cm-sec
+R0 = 2.5*10^-8 //cm
+d = 30*10^-8 //cm
+//Calculations
+D = (kb*T/(6*%pi*Mu*R0))*(1+((9/8)*(2*R0/d)*(log(2*R0/d)))+((-1.54)*(2*R0/d)))//cm^2/sec
+//Results
+printf("The diffusion coefficient is %.8f cm^2/sec",D)
diff --git a/1394/CH6/EX6.4.3/Ex6_4_3.sce b/1394/CH6/EX6.4.3/Ex6_4_3.sce new file mode 100755 index 000000000..b6337abad --- /dev/null +++ b/1394/CH6/EX6.4.3/Ex6_4_3.sce @@ -0,0 +1,26 @@ + +clc
+//Initialzation of variables
+kb = 1.38*10^-16 // g-cm^2/sec^2-K
+T = 373 // K
+T0 = 273 // K
+sigma = 2.83*10^-8 // cm
+p = 1.01*10^6// g/cm-sec^2
+l = 0.6 // cm
+d = 13*10^-7 // cm
+m = 2/(6.023*10^23)// gm/sec
+M1 = 2.01
+M2 = 28.0
+sigma1 = 2.92//cm
+sigma2 = 3.68//cm
+sigma12 = (sigma1+sigma2)/2
+omega = 0.80
+deltac1 = (1/(22.4*10^3))*(T0/T)
+//Calculations
+DKn = (d/3)*(sqrt((2*kb*T)/m))//cm^2/sec
+flux1 = (DKn*deltac1/l)*10^5//in x*10^-5mol/cm^2-sec
+D = (1.86*10^-3)*(T^(1.5))*(((1/M1)+(1/M2))^0.5)/(p*(sigma12^2)*omega)
+flux2 = (D*deltac1/l)*10^11// in x*10^-11 mol/cm^2-sec
+//Results
+printf("The steady diffusion flux is %.2f x10^-5 mol/cm^2-sec",flux1)
+printf("\nThe flux through 18.3 micrometre pore is %.1f x10^-11 cm^2/sec",flux2)// answer wrong in text book
diff --git a/1394/CH6/EX6.4.4/Ex6_4_4.sce b/1394/CH6/EX6.4.4/Ex6_4_4.sce new file mode 100755 index 000000000..2b8a10e4f --- /dev/null +++ b/1394/CH6/EX6.4.4/Ex6_4_4.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+d=0.01 //cm
+s=2*10^-2 //cm
+//calculations
+phi = 4/3 *%pi*(d/2)^3 /(s^3)
+disp("On solving, D")
+D=5*10^-7 //cm^2/s
+//results
+printf("Diffusion in homogeneous gel = %.1e cm^2/sec",D)
diff --git a/1394/CH8/EX8.1.1/Ex8_1_1.sce b/1394/CH8/EX8.1.1/Ex8_1_1.sce new file mode 100755 index 000000000..95ce8a955 --- /dev/null +++ b/1394/CH8/EX8.1.1/Ex8_1_1.sce @@ -0,0 +1,15 @@ + +clc
+//initiliazation of variables
+Vap = (0.05/22.4)*23.8/760 // Vapour concentration
+V = 18.4*10^3 // Air Volume in cc
+A = 150 // Liquid Area in Cm^2
+t1 = 180 // Time in sec
+N1 = (Vap*V)/(A*t1)
+k = 3.4*10^-2 // cm/sec
+C = 0.9
+//Calculations
+t = (-V/(k*A))*log(1 - C)
+thr = t/3600
+//Results
+printf("the time taken to reach 90 percent saturation is %.3f hr",thr)
diff --git a/1394/CH8/EX8.1.2/Ex8_1_2.sce b/1394/CH8/EX8.1.2/Ex8_1_2.sce new file mode 100755 index 000000000..5818dd41c --- /dev/null +++ b/1394/CH8/EX8.1.2/Ex8_1_2.sce @@ -0,0 +1,12 @@ + +
+clc
+//initialization of variables
+Vo = 5 // cm/sec
+a = 23 //cm^2/cm^3
+z = 100 //cm
+Crat = 0.62 // Ratio of c/Csat
+//Calculations
+k = -(Vo/(a*z))*log(1-Crat)
+//Results
+printf("the mass transfer co efficient is %.1e cm/sec",k)
diff --git a/1394/CH8/EX8.1.3/Ex8_1_3.sce b/1394/CH8/EX8.1.3/Ex8_1_3.sce new file mode 100755 index 000000000..b16e02f64 --- /dev/null +++ b/1394/CH8/EX8.1.3/Ex8_1_3.sce @@ -0,0 +1,10 @@ + +
+clc
+//initialization of variables
+t = 3*60 // seconds
+crat = 0.5 // Ratio of c and csat
+//calculations
+ka = -(1/t)*log(1-crat)
+//results
+printf("the mass transfer co efficient along the product with a is %.1e sec^-1",ka)
diff --git a/1394/CH8/EX8.1.4/Ex8_1_4.sce b/1394/CH8/EX8.1.4/Ex8_1_4.sce new file mode 100755 index 000000000..630537ad8 --- /dev/null +++ b/1394/CH8/EX8.1.4/Ex8_1_4.sce @@ -0,0 +1,15 @@ + +
+clc
+//initialiazation of variables
+rin = 0.05 // initial radius of oxygen bubble in cm
+rf = 0.027 //final radius of oxygen bubble in cm
+tin = 0 // initial time in seconds
+tf = 420 // final time in seconds
+c1 = 1/22.4 // oxygen concentration in the bubble in mol/litres
+c1sat = 1.5*10^-3 // oxygen concentration outside which is saturated in mol/litres
+//Calculations
+k = -((rf-rin)/(tf-tin))*(c1/c1sat)
+//Results
+printf("The mass transfer co efficient is %.1e cm/sec",k)
+
diff --git a/1394/CH8/EX8.2.1/Ex8_2_1.sce b/1394/CH8/EX8.2.1/Ex8_2_1.sce new file mode 100755 index 000000000..b145cca9b --- /dev/null +++ b/1394/CH8/EX8.2.1/Ex8_2_1.sce @@ -0,0 +1,15 @@ + +
+clc
+//initialization of variables
+kc = 3.3*10^-3 // M.T.C in cm/sec
+d = 1 // density of oxygen in g/cm^3
+M = 18 // Mol wt of water in g/mol
+Hatm = 4.4*10^4 // Henrys constant in atm
+HmmHg = Hatm*760 // Henrys constant in mm Hg
+//calculations
+ratio = d/(M*HmmHg)// Ratio of concentration and pressure of oxygen
+kp = kc*ratio // M.T.O=C in x*10^12mol/cm^2-sec-mm Hg
+//Results
+printf("the M.T.C in given units is %.1e",kp )
+
diff --git a/1394/CH8/EX8.2.2/Ex8_2_2.sce b/1394/CH8/EX8.2.2/Ex8_2_2.sce new file mode 100755 index 000000000..63b9842c7 --- /dev/null +++ b/1394/CH8/EX8.2.2/Ex8_2_2.sce @@ -0,0 +1,18 @@ + +
+clc
+//initialization of variables
+k1 = 1.18 // M.T.C in lb-mol NH3/hr-ft^2
+k2 = 1.09 // M.T.C in lb-mol NH3/hr-ft^2
+M2 = 18 // Mol wt of NH3 in lb/mol
+d = 62.4 // Density of NH3 in lb/ft^3
+c1 = 30.5 // Conversion factor from ft to cm
+c2 = 1/3600 // Conversion factor from seconds to hour
+R = 1.314 // Gas constant in atm-ft^3/lb-mol-K
+T = 298 // Temperature in Kelvin scale
+//Calculations
+kf1 = (M2/d)*k1*c1*c2 // M.T.C in cm/sec
+kf2 = R*T*k2*c1*c2 // M.T.C in cm/sec
+//Results
+printf("the M.T.C for liquid is %.1e cm/sec",kf1)
+printf("\n the M.T.C for gas is %.1f cm/sec",kf2)
diff --git a/1394/CH8/EX8.3.1/Ex8_3_1.sce b/1394/CH8/EX8.3.1/Ex8_3_1.sce new file mode 100755 index 000000000..e4bcca8fc --- /dev/null +++ b/1394/CH8/EX8.3.1/Ex8_3_1.sce @@ -0,0 +1,12 @@ + +clc
+//initialization of variables
+l = 0.07 // flim thickness in cm
+v = 3 // water flow in cm/sec
+D = 1.8*10^-5 // diffusion coefficient in cm^2/sec
+crat = 0.1 // Ratio of c1 and c1(sat)
+//Calculations
+z = (((l^2)*v)/(1.38*D))*((log(1-crat))^2) //Column length
+//Results
+printf("the column length needed is %.1f cm",z)
+
diff --git a/1394/CH8/EX8.3.2/Ex8_3_2.sce b/1394/CH8/EX8.3.2/Ex8_3_2.sce new file mode 100755 index 000000000..e8002c4d0 --- /dev/null +++ b/1394/CH8/EX8.3.2/Ex8_3_2.sce @@ -0,0 +1,24 @@ + +clc
+//Initialization of variables
+Dw = 1*10^-5 // Diffusion co efficient in cm^2/sec
+omeg = 20*2*%pi/60 // disc rotation in /sec
+Nuw = 0.01 // Kinematic viscousity in water in cm^2/sec
+Da = 0.233 // Diffusion co efficient in cm^2/sec
+Nua = 0.15 // Kinematic viscousity in air in cm^2/sec
+c1satw = 0.003 // Solubility of benzoic acid in water in gm/cm^3
+p1sat = 0.30 // Equilibrium Vapor pressure in mm Hg
+ratP = 0.3/760 // Ratio of pressures
+c1 = 1/(22.4*10^3) // Moles per volume
+c2 = 273/298 // Ratio of temperatures
+c3 = 122 // Grams per mole
+//Calculations
+kw = 0.62*Dw*((omeg/Nuw)^0.5)*((Nuw/Dw)^(1/3))// cm/sec
+Nw = kw*c1satw*10^6 // mass flux in x*10^-6 in g/cm^2-sec
+ka = 0.62*Da*((omeg/Nua)^0.5)*((Nua/Da)^(1/3))//cm/sec
+c1sata = ratP*c1*c2*c3// Solubility of benzoic acid in air in gm/cm^3
+Na = ka*c1sata*10^6 // mass flux in x*10^-6 in g/cm^2-sec
+//Results
+printf ("the mass flux in water is %.1f x10^-6 g/cm^2-sec",Nw)
+printf("\n the mass flux in air is %.1f x10^-6 g/cm^2-sec",Na)
+
diff --git a/1394/CH8/EX8.5.1/Ex8_5_1.sce b/1394/CH8/EX8.5.1/Ex8_5_1.sce new file mode 100755 index 000000000..38f67f318 --- /dev/null +++ b/1394/CH8/EX8.5.1/Ex8_5_1.sce @@ -0,0 +1,18 @@ + +
+clc
+//initialization of variables
+Dl=2.1*10^-5// Diffusion co efficient for Oxygen in air in cm^2/sec
+Dg = 0.23 //Diffusion co efficient for Oxygen in water in cm^2/sec
+R = 82 // Gas constant in cm^3-atm/g-mol-K
+T = 298 //Temperature in Kelvin
+l1 = 0.01 // film thickness in liquids in cm
+l2 = 0.1 // film thickness in gases in cm
+H1 = 4.3*10^4 // Henrys constant in atm
+c = 1/18 // concentration of water in g-mol/cm^3
+//Calculations
+kl = (Dl/l1)*c // m.t.c in liquid phase in mol/cm^2/sec
+kp = (Dg/l2)/(R*T)// m.t.c in gas phase in gmol/cm^2-sec-atm
+KL = 1/((1/kl)+(1/(kp*H1)))// Overall m.t.c in mol/cm^2-sec liquid phase
+//Results
+printf("The overall m.t.c in liquid side is %.1e mol/cm^2-sec",KL)
diff --git a/1394/CH8/EX8.5.2/Ex8_5_2.sce b/1394/CH8/EX8.5.2/Ex8_5_2.sce new file mode 100755 index 000000000..b66d06a84 --- /dev/null +++ b/1394/CH8/EX8.5.2/Ex8_5_2.sce @@ -0,0 +1,15 @@ + +clc +//initialization of variables +Dl=1.9*10^-5// Diffusion co efficient for liquid phase in cm^2/sec +Dg = 0.090 //Diffusion co efficient for gas phase in cm^2/sec +R = 82 // Gas constant in cm^3-atm/g-mol-K +T = 363 //Temperature in Kelvin +H1 = 0.70 // Henrys constant in atm +c = 1/97 // concentration of water in g-mol/cm^3 +//Calculations +kl = (Dl/0.01)*c // m.t.c in liquid phase in mol/cm^2/sec +kp = (Dg/0.1)/(R*T)// m.t.c in gas phase in gmol/cm^2-sec-atm +KL = 1/((1/kl)+(1/(kp*H1)))*10^5// Overall m.t.c in x*10^-5 mol/cm^2-secliquid phase +//Results +printf("The overall m.t.c in liquid side is %.2f x10^-5 mol/cm^2-sec",KL)// answer wrong in textbook diff --git a/1394/CH8/EX8.5.3/Ex8_5_3.sce b/1394/CH8/EX8.5.3/Ex8_5_3.sce new file mode 100755 index 000000000..e91b87cb5 --- /dev/null +++ b/1394/CH8/EX8.5.3/Ex8_5_3.sce @@ -0,0 +1,10 @@ + +clc
+//Initialization of variables
+k1 = 3.0*10^-4 // m.t.c in benzene in cm/sec
+k2 = 2.4*10^-3 // m.t.c in water in cm/sec
+ratio = 150 // Solubility ratio in benzene to water
+//Calculations
+K1 = (1/((1/k1)+(ratio/k2)))*10^5 // Overall m.t.c through benzene phase in x*10^-5 cm/sec
+//Results
+printf("The overall M.T.C through benzene phase is %.1f x10^-5 cm/sec",K1)
diff --git a/1394/CH8/EX8.5.4/Ex8_5_4.sce b/1394/CH8/EX8.5.4/Ex8_5_4.sce new file mode 100755 index 000000000..2ec89501c --- /dev/null +++ b/1394/CH8/EX8.5.4/Ex8_5_4.sce @@ -0,0 +1,14 @@ + +clc
+//initialization of variables
+H1 = 75 // henrys constant for ammonia in atm
+H2 = 41000 // henrys constant for methane in atm
+p = 2.2 // pressure in atm
+kya = 18 // product of m.t.c and packing area per tower volume in lb-mol/hr-ft^3
+kxa = 530 //product of m.t.c and packing area per tower volume in lb-mol/hr-ft^3
+//calcuations
+Kya1 = 1/((1/kya) + (H1/p)/kxa) //The overall coefficient for ammonia in lb-mol/hr-ft^3
+Kya2 = 1/((1/kya) + (H2/p)/kxa) //The overall coefficient for methane in lb-mol/hr-ft^3
+//Results
+printf("The overall coefficient for ammonia is %.1f lb-mol/hr-ft^3",Kya1)
+printf("\n The overall coefficient for methane is %.2f lb-mol/hr-ft^3",Kya2)
diff --git a/1394/CH9/EX9.1.1/Ex9_1_1.sce b/1394/CH9/EX9.1.1/Ex9_1_1.sce new file mode 100755 index 000000000..7c5d24ee4 --- /dev/null +++ b/1394/CH9/EX9.1.1/Ex9_1_1.sce @@ -0,0 +1,16 @@ + +clc
+//initialization of variables
+p1 = 10 // pressure in atm
+H = 600 // henrys constant in atm
+c1 = 0 // gmol/cc
+N1 = 2.3*10^-6 // mass flux in mol/cm^2-sec
+c = 1/18 //total Concentration in g-mol/cc
+D = 1.9*10^-5 // Diffusion co efficient in cm^2/sec
+//Calculations
+c1i = (p1/H)*c // Component concentration in gmol/cc
+k = N1/(c1i-c1)//Mass transfer co efficient in cm/sec
+l = D/k // Film thickness in cm
+//Results
+printf("The film thickness is %.5f cm",l)
+
diff --git a/1394/CH9/EX9.2.1/Ex9_2_1.sce b/1394/CH9/EX9.2.1/Ex9_2_1.sce new file mode 100755 index 000000000..4403821e0 --- /dev/null +++ b/1394/CH9/EX9.2.1/Ex9_2_1.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+D = 1.9*10^-5 //Diffusion co efficient in cm^2/sec
+k = 2.5*10^-3 // M.T.C in cm/sec
+//Calculations
+Lbyvmax = 4*D/((k^2)*%pi)//sec
+tou = D/k^2 // sec
+//Results
+printf("The contact time is %.1f sec",Lbyvmax)
+printf("\nThe surface resident time is %.1f sec",tou)
diff --git a/1394/CH9/EX9.3.1/Ex9_3_1.sce b/1394/CH9/EX9.3.1/Ex9_3_1.sce new file mode 100755 index 000000000..780a5897d --- /dev/null +++ b/1394/CH9/EX9.3.1/Ex9_3_1.sce @@ -0,0 +1,19 @@ + +
+clc
+//initialization of variables
+const = 0.5 // The part of flow in the system which bypasses the region where the mass transfer occurs
+v1 = 1 // cm/sec
+al = 10^3
+k = 10^-3 // cm/sec
+v2 = 3 // cm/sec
+//Calculations
+C1byC10first = const + (1-const)*(exp(-k*al/v1))// c1/c10
+appk1 = (v1/al)*(log(1/C1byC10first))// Apparent m.t.c for first case in cm/sec
+C1byC10second = const + (1-const)*(exp(-(sqrt(3))*k*al/v2))//c1/c10 in second case
+appk2 = (v2/al)*log(1/C1byC10second)// apparent m.t.c for second case in cm/sec
+power = log(appk2/appk1)/log(v2/v1)
+//Results
+printf("The apparent m.t.c for the first case is %.2e cm/sec",appk1)
+printf("\nThe apparent m.t.c for the second case is %.2e cm/sec",appk2)
+printf("\nThe apparent is proportional to the power of %.2f of the velocity",power)
diff --git a/1394/CH9/EX9.4.1/Ex9_4_1.sce b/1394/CH9/EX9.4.1/Ex9_4_1.sce new file mode 100755 index 000000000..22287f9b2 --- /dev/null +++ b/1394/CH9/EX9.4.1/Ex9_4_1.sce @@ -0,0 +1,11 @@ + +clc
+//initialization of variables
+D = 1*10^-5 //cm^2/sec
+d = 2.3 // cm
+L = 14 // cm
+v0 = 6.1 // cm/sec
+//calculations
+k = ((3^(1/3))/(gamma(4/3)))*((D/d))*(((d^2)*v0/(D*L))^(1/3))// cm/sec
+//Results
+printf("The average mass transfer coefficient is %.6f cm/sec",k)
diff --git a/1394/CH9/EX9.4.2/Ex9_4_2.sce b/1394/CH9/EX9.4.2/Ex9_4_2.sce new file mode 100755 index 000000000..d5eb9250e --- /dev/null +++ b/1394/CH9/EX9.4.2/Ex9_4_2.sce @@ -0,0 +1,19 @@ + +clc
+//initialization of variables
+tn = 300000 // turbulence number
+v0 = 10 // cm/sec
+p = 1 // g/cc
+mu = 0.01 // g/cm-sec
+delta = 2.5 //cm
+D = 1*10^-5 // cm^2/sec
+//Calculations
+x = tn*mu/(v0*p)// cm
+delta = ((280/13)^(1/2))*x*((mu/(x*v0*p))^(1/2))//cm
+deltac = ((D*p/mu)^(1/3))*delta//cm
+k = (0.323*(D/x)*((x*v0*p/mu)^0.5)*((mu/(p*D))^(1/3)))*10^5// x*10^-5 cm/sec
+//Results
+printf("The distance at which turbulent flow starts is %.f cm",x)
+printf("\nThe boundary layer for flow at this point is %.1f cm",delta)
+printf("\nThe boundary layer for concentration at this point is %.2f cm",deltac)
+printf("\nThe local m.t.c at the leading edge and at the position of transistion is %.1f x10^-5 cm/sec",k)
|