Chapter 12: Drying

Ex12.1: Page 660

In [4]:
# Illustration 12.1
# Page: 660

print'Illustration 12.1 - Page: 660\n\n'

# Solution

#****Data****#
F=1000;# [kg]
Xo=0.8;# [wt. fraction water]
X1=0.05;# [wt. fraction water]
#************#

Yo=Xo/(1-Xo);# [kg water/kg dry solid]
Y1=X1/(1-X1);# [kg water/kg dry solid]
solid=F*(1-X1);# [kg]
print"Moisture to be evaporated: ",solid*(Yo-Y1)," kg\n",
Illustration 12.1 - Page: 660


Moisture to be evaporated:  3750.0  kg

Ex12.2: Page 665

In [3]:
# Illustration 12.2
# Page: 665

print'Illustration 12.2 - Page: 665\n\n'

# Solution

# ***Data***#
Y1 = 0.05;# [kg water/kg dry air]
Yair = 0.01;# [kg water/kg dry air]
TempG1 = 95;# [OC]
width = 1;# [m]
apart = 100.0/1000;# [m]
deep = 38.0/1000;# [m]
Rate_evaporation=7.5*10**(-3);# [kg/s]
#*****************#

# From Table 7.1: (Pg 234)
vH = (0.00283+(0.00456*Y1))*(TempG1+273);# [cubic m/kg dry air]
freeArea = width*(apart-deep)*11;# [square m]
# Rate of air flow at 1:
Rate_air1 = 3*freeArea/vH;# [square m]
Y2 = Y1+(Rate_evaporation/Rate_air1);# [kg water/kg dry air]
# Assuming adiabatic drying:
# From adiabatic saturation curve, Fig 7.5: (Pg 232)
TempG2 = 86.0;# [OC]
# Overall Water Balance:
G = Rate_evaporation/(Y1-Yair);# [kg dry air/s]
# Rate of air flow at 3:
Rate_air3 = Rate_air1+G;# [kg dry air/s]
# Rate of air flow at 4:
Rate_air4 = Rate_air3;# [kg dry air/s]
# Volumetric Rate through fan:
Rate_fan = Rate_air3/vH;# [cubic m/s]
print"Percentage of air recycled is:",round((Rate_air1/Rate_air3)*100,2),"%\n",
print"\n"

# From Fig. 7.5 (page 232):
# Saturated enthalpy at adiabatic saturation temp.
Enthalpy1 = 233.0;# [kJ/kg dry air]
Enthalpy2 = 233.0;# [kJ/kg dry air]
# Enthalpy of fresh air:
Enthalpy_air = 50.0;# [kJ/kg dry air]
# Assuming complete mixing, by Enthalpy mixing:
Enthalpy3 = ((Enthalpy1*Rate_air1)+(Enthalpy_air*G))/Rate_air3;# [kJ/kg dry air]
Enthalpy4 = Enthalpy3;# [kJ/kg dry air]
# From table 7.1: (Pg 234)
Temp_dry = ((Enthalpy3*1000.0)-(2502300.0*Y1))/(1005.0+(1884.0*Y1));
Power = (Enthalpy2-Enthalpy3)*Rate_air3;# [kW]
# From Fig. 7.5, (Pg 232)
DewPoint1 = 40.4;# [OC]
DewPoint2 = 41.8;# [OC]
DewPoint3 = 40.4;# [OC]
DewPoint4 = 40.4;# [OC]
print"At Point 1\n"
print"Enthalpy of air:",Enthalpy1," kJ/kg dry air\n",
print"Dew Point of air: ",DewPoint1," degree C\n"
print"\n"
print"At Point 2\n"
print"Enthalpy of air: ",Enthalpy2," kJ/kg dry air\n"
print"Dew Point of air: ",DewPoint2," degree C\n"
print"\n"
print"At Point 3\n"
print"Enthalpy of air: ",Enthalpy3," kJ/kg dry air\n",
print"Dew Point of air: ",DewPoint3," degree C\n"
print"\n"
print"At Point 4\n"
print"Enthalpy of air: ",Enthalpy4," kJ/kg dry air\n"
print"Dew Point of air: ",DewPoint4," degree C\n"
print"\n"
print"Dry bulb temparature of air: ",Temp_dry," OC\n"
print"Power delivered by heater: ",Power," kW\n"
Illustration 12.2 - Page: 665


Percentage of air recycled is: 90.65 %


At Point 1

Enthalpy of air: 233.0  kJ/kg dry air
Dew Point of air:  40.4  degree C



At Point 2

Enthalpy of air:  233.0  kJ/kg dry air

Dew Point of air:  41.8  degree C



At Point 3

Enthalpy of air:  215.89174489  kJ/kg dry air
Dew Point of air:  40.4  degree C



At Point 4

Enthalpy of air:  215.89174489  kJ/kg dry air

Dew Point of air:  40.4  degree C



Dry bulb temparature of air:  82.5843748998  OC

Power delivered by heater:  34.3125  kW

Ex12.3: Page 671

In [1]:
# Illustration 12.3
# Page: 671

print'Illustration 12.3 - Page: 671\n\n'

# Solution
import numpy
import matplotlib.pyplot as plt
%matplotlib inline
# ***Data***#
SsByA = 40;
x1 = 0.25;# [moisture fraction]
x2 = 0.06;# [moisture fraction]
#***********#

X1 = x1/(1-x1);# [kg moisture/kg dry solid]
X2 = x2/(1-x2);# [kg moisture/kg dry solid]
# Fig. 12.10 (Pg 668) indicates that both constant and falling rate periods are involved.

# Constant Rate period:
# From Fig. 12.10 (Pg 668):
Xc = 0.200;# [kg moisture/kg dry solid]
Nc = 0.3*10**(-3);# [kg/square m.s]
# From Eqn. 12.4:
thetha1 = SsByA*(X1-Xc)/Nc;# [s]

# Falling Rate Period:
# From Fig. 12.10 (Pg 668):
# Data=[x N*10^3]
Data = numpy.array([[0.2 ,0.3],[0.18 ,0.266],[0.16 ,0.239],[0.14 ,0.208],[0.12, 0.180],[0.10 ,0.150],[0.09 ,0.097],[0.08, 0.070],[0.07 ,0.043],[0.064 ,0.025]]);
Val = zeros(10);
# Val=[(1/N)*10^(-3)]
for i in range(0,10):
    Val[i] = 1/Data[i,1];

plt.plot(Data[:,0],Val);
plt.grid();
plt.xlabel("x [kg moisture / kg dry solid]");
plt.ylabel("10^(-3) / N");
plt.title("Graphical Integration Falling Rate Period");
# Area under the curve:
Area = 1060.0;
# From Eqn. 12.3:
thetha2 = SsByA*Area;# [s]
thetha = thetha1+thetha2;# [s]
print"Total Drying Time: ",round(thetha/3600,2),"h\n",
#the answers are slightly different in textbook due to approximation while here answers are precise
Illustration 12.3 - Page: 671


Total Drying Time:  16.72 h

Ex12.4: Page 676

In [14]:
# Illustration 12.4
# Page: 676

print'Illustration 12.4 - Page: 676\n\n'

# Solution (a)

#***Data***#
# For rectangular pan:
l = 0.7;# [m]
b = 0.7;# [m]
zS = 0.025;# [m]
zM = 0.0008;# [m]
d = 0.1;# [m]
Y1 = 0.01;# [kg water/kg dry air]
TempG = 65.0;# [OC]
v = 3.0;# [m/s]
TempR = 120.0;# [OC]
#*************#

# From Table 7.1: (Pg 234)
vH = (0.00283+(0.00456*Y1))*(TempG+273.0);# [cubic m/kg dry air]
Density_G = (1+Y1)/vH;# [kg/cubic m]
G = v*Density_G;# [kg/square m.s]
de = 4*d*l/(2*(l+d));# [m]
# From Eqn. 12.20:
hc = 5.90*G**0.71/de**0.29;# [W/square m.K]
# Assume:
e = 0.94;
# Estimate:
TempS = 38;# [OC]
# From Eqn. 12.14:
hR = e*5.729*10**(-8)*((273+TempR)**4-(273+TempS)**4)/((273.0+TempR)-(273+TempS));
A = l*b;# [square m]
Am = A;# [square m]
As = 4*l*zS;# [square m]
Au = Am+As;# [square m]
# Thermal Coductivities:
kM = 45;# [W/m.K]
kS = 3.5;# [W/m.K]
# By Eqn. 12.16:
Uk = 1/(((1/hc)*(A/Au))+((zM/kM)*(A/Au))+((zS/kS)*(A/Am)));# [W/squre m.K]
# From Table 7.1: (Pg 234)
Cs = 1005+(1884*Y1);# [kJ/kg]
# At estimated 38 OC
lambdaS = 2411.4;# [kJ/kg]
# From Eqn. 12.18:
# (Ys-Y1)*lambdaS*10^3/Cs = ((1+(Uk/hc))*(TempG-Temps))+((hR/hC)*(TempR-TempS))
# On Simplifying:
# Ys = 0.0864-(10.194*10**(-4)*TempS)
# The eqn. is solved simultaneously with the saturated humidity curve of the psychometric chart for the air water mixture.
# From Fig. 12.12: (Pg 677)
Ys = 0.0460;# [kg water/kg dry air]
TempS = 39;# [OC]
# At 39 OC
lambdaS = 2409.7;# [kJ/kg]
# From Eqn. 12.17:
Nc = (((hc+Uk)*(TempG-TempS))+(hR*(TempR-TempS)))/(lambdaS*10**(3));# [kg water evaporated/square m.s]
print"The Evaporation Rate: ",round(Nc*A,8)," kg/s\n"

# Solution (b)
# When no radiation or conduction of heat through the solid occurs, the drying surface assumes wet bulb temparature of the air.
# From Fig. 12.12 (Pg 677)
TempS = 28.5;# [OC]
Ys = 0.025;# [kg water/kg dry air]
lambdaS = 2435;# [kJ/kg]
# From Eqn. 12.17:
Nc = hc*(TempG-TempS)/(lambdaS*10**3);# [kg/aquare m.s]
print"The Evaporation Rate: ",round(Nc*A,8), "kg/s\n"
Illustration 12.4 - Page: 676


The Evaporation Rate:  0.0003851  kg/s

The Evaporation Rate:  0.00016105 kg/s

Ex12.5: Page 684

In [18]:
# Illustration 12.5
# Page: 684

print'Illustration 12.5 - Page: 684\n\n'

# Solution 
from scipy import integrate
import math
#***Data***#
x1 = 0.025;# [moisture fraction]
x2 = 0.001;# [moisture fraction]
zS = 0.018;# [m]
dp = 2*10**(-4);# [m]
Density_S = 1350;# [kg dry solid/cubic m]
#***********#

X1 = x1/(1-x1);# [kg water/kg dry air]
X2 = x2/(1-x2);# [kg water/kg dry air]
# From Fig 7.5 (Pg 232)
Y1 = 0.0153;# [kg water/kg dry air]
Tempas = 24;# [OC]
Yas = 0.0190;# [kg water/kg dry air]
Gs = 0.24;# [kg dry air/square m.s]
Gav = Gs+(Gs*(Y1+Yas)/2.0);# [kg dry air/square m.s]
# From Eqn. 12.26:
Nmax = Gs*(Yas-Y1);# [kg evaporated/square m.s]
viscosity_air = 1.8*10**(-5);# [kg/m.s]
X3=lambda X : 1/(Nmax*(1-math.exp(-(0.273/dp**0.35)*((dp*Gav/viscosity_air)**0.215)*(Density_S*zS*X)**0.64)));
Value = integrate.quad(X3,X2,X1);
# From Eqn. 12.3:
thetha = Density_S*zS*Value[0];# [s]
print"The time for drying: ",round(thetha/60,3)," min\n",
Illustration 12.5 - Page: 684


The time for drying:  12.593  min

Ex12.6: Page 685

In [26]:
# Illustration 12.6
# Page: 685

print'Illustration 12.6 - Page: 685\n\n'

# Solution 

import math
#***Data***#
Y1 = 0.01;# [kg water/kg dry air]
Gs = 1.1;# [kg dry air/square m.s]
dia = 13.5/1000;# [m]
l = 13.0/1000;# [m]
zS = 50.0/1000;# [m]
Density_S = 600.0;# [kg dry solid/square m.s]
a = 280.0;# [square m/cubic m]
#************#

# From Fig 7.5 (Pg 232)
Yas = 0.031;# [kg water/kg dry air]
Gav = Gs+(Gs*(Y1+Yas)/2.0);# [kg/square m.s]
viscosity_air = 1.9*10**(-5);# [kg/m.s]
Area = (2.0*math.pi*dia**2.0/4)+(math.pi*dia*l);# [square m]
dp = (Area/math.pi)**0.5;# [m]
# From Table 3.3 (Pg 74)
Re = dp*Gav/viscosity_air;
e = 1.0-(dp*a/6);# [fraction voids]
jD = (2.06/e)*Re**(-0.575);
# For air water mixture:
Sc = 0.6;
# From Eqn. 12.33:
kY = jD*Gs/Sc**(2.0/3);# [kg H2O/square m.s.deltaX]
# From Eqn. 12.30:
NtG = kY*a*zS/Gs;
# From Eqn. 12.25:
Nmax = Gs*(Yas-Y1);# [kg/square m.s]
# From Eqn. 12.31:
N = Nmax*(1-math.exp(-NtG));# [kg water evaporated/square m.s]
Y2 = (Yas-Y1)*(N/Nmax)+Y1;# [kg water/kg dry air]
# From Fig 7.5 (Pg 232)
Tempas = 33.0;# [OC]
# From eqn. 12.2:
Rate = N/(Density_S*zS);# [kg H2O/(kg dry solid).s]
print"Humidity of the exit air: ",round(Y2,4)," kg water/kg dry air\n"
print"Temparature of exit air: ",Tempas," degree C\n"
print"Rate of Drying: ",round(Rate,7)," kg H2O/(kg dry solid).s\n"
Illustration 12.6 - Page: 685


Humidity of the exit air:  0.0302  kg water/kg dry air

Temparature of exit air:  33.0  degree C

Rate of Drying:  0.0007409  kg H2O/(kg dry solid).s

Ex12.7: Page 700

In [50]:
# Illustration 12.7
# Page: 700

print'Illustration 12.7 - Page: 700\n\n'

# Solution 

import math
from numpy.linalg import inv
#***Data***#
x1 = 3.5;# [percent moisture]
x2 = 0.2;# [percent moisture]
dia = 1.2;# [m]
l = 6.7;# [m]
Rate_prod = 900.0;# [kg/h]
y2 = 0.5;# [Humidity]
TempG2 = 90.0;# [OC]
TempG1 = 32.0;# [OC]
TempS1 = 25.0;# [OC]
TempS2 = 60.0;# [OC]
#***********#

X1 = x1/(100.0-x1);# [kg H2O/kg dry solid]
X2 = x2/(100.0-x2);# [kg H2O/kg dry solid]
Ss = Rate_prod*(1-X2);# [kg dry solid/h]
Rate_drying = Ss*(X1-X2);# [kg water evaporated/h]
Y2 = (y2/(1-y2))/100.0;# [kg water/kg dry air]
Tempo = 0.0;# [Base temp,OC]
# From Table 7.1: (Pg 234)
# Enthalpy of air entering the drier:
HG2 = (1005.0+(1884.0*Y2))*(TempG2-Tempo)+(2502300.0*Y2);# [J/kg dry air]
# For the outlet air:
# HG1 = (1005.0+(1884*Y1))*(TempG1-Tempo)+(2502300*Y1); [J/kg dry air]
# HG1 = (1005.0*TempG1)+((1884+TempG1)+2502300)*Y1; [J/kg dry air]
CsNH4 = 1507.0;# [J/kg.K]
CsH2O = 4187.0;# [J/kg.K]
# From Eqn. 11.45:
HS2 = CsNH4*(TempS2-Tempo)+(X2*CsH2O*(TempS2-Tempo));# [J/kg dry air]
HS1 = CsNH4*(TempS1-Tempo)+(X1*CsH2O*(TempS1-Tempo));# [J/kg dry air]
# The estimated combined natural convection and radiation heat transfer coeffecient from the drier to the surrounding:
h = 12.0;# [W/square m.K]
deltaTemp = ((TempG2-TempS1)+(TempG1-TempS1))/2;# [OC]
Ae = math.pi*dia*l;# [square m]
Q = h*3600.0*Ae*deltaTemp;# [kJ/h]
# Moisture Balance, Eqn. 12.39:
# Ss*(X1-X2) = Gs(Y1-Y2)
# (Gs*Y1)-(Gs*Y2) = (Ss*(X1-X2)) ........(1)
# Enthalapy Balance, Eqn. 12.40:
# (Ss*HS1)+(Gs*HG2) = (Ss*HG2)+(Gs*HG1)+Q 
# Gs*(HG2-HG1) = (Ss*HS2)+Q-(Ss*HS1)
# Gs*(HG2-((1005*TempG1)+((1884+TempG1)+2502300)*Y1)) = (Ss*HS2)+Q-(Ss*HS1)
# Gs*(HG2-(1005*TempG1))-(Gs*Y1*((1884+TempG1)+2502300)) = (Ss*HS2)+Q-(Ss*HS1)........ (2)
# Solving Simultaneously:
a = numpy.array([[HG2-(1005.0*TempG1),-((1884.0+TempG1)+2502300.0)],[(-Y2), 1.0]]);
b = numpy.array([[((Ss*HS2)+Q-(Ss*HS1))],[(Ss*(X1-X2))]]);
c=inv(a)
soln =np.dot(c, b)
Gs = soln[0];# [kg dry air/h]
Y1 = soln[1]/soln[0];# [kg water/kg dry air]
# From Fig. 7.5 (Pg 232)
Enthalpy_air = 56.0;# [kJ/kg dry air]
HeatLoad = Gs*(HG2-Enthalpy_air*1000);# [W]
print"Air Flow Rate: ",round(Gs,2)," kg/h\n"
print"Moisture content of air: ",round(Y1,2)," kg water/kg dry air \n"
print"Heat Load of drier: ",round(HeatLoad/1000)," kW"
#the answers are slightly different in textbook due to approximation while here answers are precise
Illustration 12.7 - Page: 700


Air Flow Rate:  2681.03  kg/h

Moisture content of air:  0.02  kg water/kg dry air 

Heat Load of drier:  163995.0  kW

Ex12.8: Page 705

In [56]:
# Illustration 12.8
# Page: 705

print'Illustration 12.8 - Page: 705\n\n'

# Solution 
from scipy.optimize import fsolve
import math
from numpy.linalg import inv
import numpy as np
#***Data***#
x1 = 8.0;# [percent moisture]
x2 = 0.5;# [percent moisture]
Rate_prod = 0.63;# [kg/s]
# Drying Gas:
xCO2 = 0.025;# [mole fraction]
xO2 = 0.147;# [mole fraction]
xN2 = 0.760;# [mole fraction]
xH2O = 0.068;# [mole fraction]
TempG2 = 480.0;# [OC]
Cs = 0.837;# [kJ/kg.K]
Temp1 = 27.0;# [OC]
Temp2 = 150.0;# [OC]
dp = 200.0*10**(-6);# [m]
Density_S = 1300.0;# [kg/cubic m]
#***********#

X1 = x1/(100-x1);# [kg water/kg dry solid]
X2 = x2/(100-x2);# [kg water/kg dry solid]
Ss = Rate_prod*(1-X2);# [kg dry solid/s]
Water_evap = Ss*(X1-X2);# [kg/s]
# Basis: 1 kmol of dry gas:
xDry = 1.0-xH2O;# [kmol]
XCO2 = 44.0*xCO2;# [kg]
XO2 = 32.0*xO2;# [kg]
XN2 = 28.0*xN2;# [kg]
Xdry = XCO2+XO2+XN2;# [kg]
cCO2 = 45.6;# [kJ/kmol.K]
cO2 = 29.9;# [kJ/kmol.K]
cN2 = 29.9;# [kJ/kmol.K]
cH2O = 4.187;# [kJ/kg.K]
Mav = Xdry/xDry;# [kg/kmol]
Y2 = xH2O*18.02/(xDry*Mav);# [kg water/kg dry gas]
cav = ((xCO2*cCO2)+(xO2*cO2)+(xN2*cN2))/(xDry*Mav);# [kJ/kmol.K]
# Assume:
TempG1 = 120.0;# [OC]
cDry = 1.005;# [kJ/kmol.K]
Tempo = 0;# [Base Temp,OC]
# By Eqn. 7.13:
HG2 = (cav+(1.97*Y2))*(TempG2-Tempo)+(2502.3*Y2);# [kJ/kg dry air]
# For the outlet air:
# HG1 = (1.005+(1.884*Y1))*(TempG1-Tempo)+(2502.3*Y1); [kJ/kg dry air]
# HG1 = (1.005*TempG1)+((1.884+TempG1)+2502.3)*Y1; [kJ/kg dry air]
# By Eqn. 11.45:
HS1 = (Cs*(Temp1-Tempo))+(cH2O*X1*(Temp1-Tempo));# [kJ/kg dry air]
HS2 = (Cs*(Temp2-Tempo))+(cH2O*X2*(Temp2-Tempo));# [kJ/kg dry air]
# Q = 0.15*HG2*Gs; [kJ/s]
# Moisture Balance, Eqn. 12.39:
# Ss*(X1-X2) = Gs(Y1-Y2)
# (Gs*Y1)-(Gs*Y2) = (Ss*(X1-X2)) ........(1)
# Enthalapy Balance, Eqn. 12.40:
# (Ss*HS1)+(Gs*HG2) = (Ss*HG2)+(Gs*HG1)+Q 
# Gs*(HG2-HG1) = (Ss*HS2)+(0.15*HG2*Gs)-(Ss*HS1)
# Gs*(HG2-(0.15*HG2)-((1.005*TempG1)+((1.884+TempG1)+2502.3)*Y1)) = (Ss*HS2)+Q-(Ss*HS1)
# Gs*(HG2-(0.15*HG2)-(1.005*TempG1))-(Gs*Y1*((1.884+TempG1)+2502.3)) = (Ss*HS2)+Q-(Ss*HS1)........ (2)
a = np.array([[(HG2-(0.15*HG2)-(1.005*TempG1)),-((1.884+TempG1)+2502.3)],[(-Y2), 1.0]]);
b = np.array([(Ss*HS2)-(Ss*HS1),(Ss*(X1-X2))]);
c=inv(a)
soln = np.dot(c, b)
Gs = soln[0];# [kg dry air/s]
Y1 = soln[1]/soln[0];# [kg water/kg dry gas]
HG1 = (1.005+(1.884*Y1))*(TempG1-Tempo)+(2502.3*Y1);# [kJ/kg dry air]
Q = 0.15*HG2*Gs;# [kJ/s]
# Assuming the sychrometric ratio of the gas as same as that of air:
# For Zone II:
Tempw = 65.0;# [OC]
Temp_A = 68.0;# [OC]
# At point A, Fig. 12.28 (Pg 702)
Enthalpy_A = Cs*(Temp_A-Tempo)+(X1*cH2O*(Temp_A-Tempo));# [kJ/kg dry air]
# At point B, Fig. 12.28 (Pg 702)
Temp_B = Temp_A;# [OC]
Enthalpy_B = Cs*(Temp_B-Tempo)+(X2*cH2O*(Temp_B-Tempo));# [kJ/kg dry air]

# Assuming that the heat losses in the three zones are propotional to the number of transfer units in each zone and to the average temp. difference between the gas and the surrounding air.
# Fractional heat loss in each Zone:
fr1 = 0.14;
fr2 = 0.65;
fr3 = 0.20;
# Calculations for zone III:
Cs3 = cav+(1.97*Y2);# [kJ/(kg dry gas).K]
# Heat balance:
def f1(TempGD):
    return (Gs*Cs3*(TempG2-TempGD))-(Ss*(HS2-Enthalpy_B)+(fr3*Q))
TempGD = fsolve(f1,7);# [OC]
delta_TempG = Ss*(HS2-Enthalpy_B)/(Gs*Cs3);# [OC]
delta_TempM = ((TempG2-Temp2)+(TempGD-Temp_A))/2;# [OC]
NtoG3 = delta_TempG/delta_TempM;

# Calculations for zone I:
Cs1 = 1.005+(1.884*Y1);# [kJ/(kg dry gas).K]
# Heat balance:
def f2(TempGC):
    return (Gs*Cs1*(TempGC-TempG1))-(Ss*(Enthalpy_A-HS1)+(fr1*Q))
TempGC = fsolve(f2,7);# [OC]
delta_TempG = Ss*(Enthalpy_A-HS1)/(Gs*Cs1);# [OC]
delta_TempM = ((TempGC-Temp_A)+(TempG1-Temp1))/2;# [OC]
NtoG1 = delta_TempG/delta_TempM;

# Calculations for zone II:
Cs2 = (cav+Cs1)/2.0;# [kJ/(kg dry gas).K]
# Heat balance:
True_deltaTemp = TempGD-TempGC;# [OC]
delta_Temp = fr2*Q/(Cs1*Gs);# [Change in temp resulting from heat loss,OC]
delta_TempG = True_deltaTemp-delta_Temp;# [OC]
delta_TempM = ((TempGD-Temp_A)-(TempGC-Temp_A))/log((TempGD-Temp_A)/(TempGC-Temp_A));# [OC]
NtoG2 = delta_TempG/delta_TempM;

NtoG = NtoG1+NtoG2+NtoG3;

# Standard diameters are availaible at 1, 1.2 & 1.4 m.
Td = 1.2;# [m]
Area = math.pi*Td**2.0/4;# [square m]
Gs = Gs/Area;# [kg/square m.s]
Ss = Ss/Area;# [kg/square m.s]
Gav = Gs*(1+(Y1+Y2)/2.0);# [kg/square m.s]
# From Eqn. 12.47:
Ua = 237.0*Gav**0.417/Td;# [W/square m.K]
HtoG = Gs*Cs2*1000.0/Ua;# [m]
Z = NtoG*HtoG;# [m]
# Assume:
v = 0.35;# [m/s]
N = v/(math.pi*Td);# [1/s]
# From Eqn. 12.37:
K = 0.6085/(Density_S*dp**(1.0/2));
# Take:
phi_D = 0.05;
# From Eqn. 12.35:
phi_DO = phi_D-(K*Gav);
# From Eqn. 12.35:
s = 0.3344*Ss/(phi_DO*Density_S*N**0.9*Td);# [m/s]
print"Height of the drier: ",round(Z,2)," m\n"
print"Drier Slope: ",round(s,5)," m/m \n",
Illustration 12.8 - Page: 705


Height of the drier:  5.89  m

Drier Slope:  0.03304  m/m 

Ex12.9: Page 709

In [2]:
# Illustration 12.9
# Page: 709

print'Illustration 12.9 - Page: 709\n\n'
import numpy as np
from scipy.optimize import fsolve
import matplotlib.pyplot as plt
%matplotlib inline
# Solution 

#***Data***#
x1 = 0.46;# [fraction moisture]
x2 = 0.085;# [fraction moisture]
Y1 = 0.08;# [kg water/kg dry solid]
Y2 = 0.03;# [kg water/kg dry solid]
G = 1.36;# [kg/square m.s]
#**********#

X1 = x1/(1-x1);# [kg water/kg dry solid]
X2 = x2/(1-x2);# [kg water/kg dry solid]
# By water balance:
SsByGs = (Y1-Y2)/(X1-X2);# [kg dry solid/kg air]
# Since the initial moisture content of the rayon is less than the critical, drying takes place entirely within zone III.
# Comparing with Eqn. 12.22:
# (kY*A/(Ss(Xc-X*)))=0.0137*G**1.47
# thetha=integrate('(1/(0.0137*G**1.47))*(1/((X-X_star)*(Yw-Y)))','X',X2,X1) # [s]
X = np.array([X1, 0.80, 0.60, 0.40, 0.20 ,X2]);# [kg water/kg dry solid]
Y = zeros(6);
for i in range(0,6):
   # From Eqn. 12.54:
   Y[i] = Y2+((X[i]-X2)*SsByGs);# [kg water/kg dry gas]

# From Fig. 7.5 (Pg 232):
Yw = np.array([0.0950, 0.0920, 0.0790, 0.0680, 0.0550, 0.0490]);# [kg water/kg dry gas]
X_star = zeros(6);
RH=zeros(6)
Val = zeros(6);
P = 51780.0;# [vapour pressure, kN/square m]
for i in range(0,6):
    # From Eqn 7.8:
    def f(p):
         return Y[i]-((p/(101330.0-p))*(18.0/29))
    p = fsolve(f,7);# [kN/square m]
    RH[i] = (p/P)*100.0;
    X_star[i] = (RH[i]/4)/(100.0-(RH[i]/4));# [kg water/kg dry solid]
    Val[i] = 1/((X[i]-X_star[i])*(Yw[i]-Y[i]));

plt.plot(X,Val);
plt.grid();
plt.xlabel("X kg water/kg dry solid");
plt.ylabel("1/((X-X*)*(Yw-Y))");
plt.title("Graphical Integration");
plt.show()
# Area Under the curve:
Area = 151.6;
# From Eqn. 12.59:
thetha = Area/(0.0137*G**1.47);
print"Time required for drying: ",round(thetha/3600,2)," h\n"
Illustration 12.9 - Page: 709


Time required for drying:  1.96  h

In [ ]: