Thanks to visit codestin.com
Credit goes to www.scribd.com

0% found this document useful (0 votes)
43 views11 pages

Problem 1

Head Exchanger Design with EES

Uploaded by

soleymaniardalan
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
0% found this document useful (0 votes)
43 views11 pages

Problem 1

Head Exchanger Design with EES

Uploaded by

soleymaniardalan
Copyright
© © All Rights Reserved
We take content rights seriously. If you suspect this is your content, claim it here.
Available Formats
Download as PDF, TXT or read online on Scribd
You are on page 1/ 11

File:Problem 1_new.

EES 10/28/2024 11:01:53 AM Page 1


EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

"Problem 1"
"Given"
T_h_i = converttemp(C,K,427[C])
T_c_i = converttemp(C,K,25[C])
m_dot_h = 0.2 [kg/s]
m_dot_c = 0.3 [kg/s]
q_dot = 55000 [W]
d_c = 0.0254 [m]
d_h = 0.0635 [m]
th_w = 0.0016 [m]

"Design Parameters"
A_c_c = (pi*(d_c^2))/4 "Inner tube cross sectional area"

A_c_h = (pi*(d_h^2))/4 - (pi*((d_c+(2*th_w))^2))/4 "Annulus cross sectional area"

A_s_h = pi*(d_c + (2*th_w))*L "Surface area at hot side, we need to find L"

A_s_c = pi*d_c*L "Surface area at cold side, we need to find L"

"Avg Temperatures"
T_avg = (T_h_i + T_c_i)/2

T_avg_h = (T_h_i + T_h_o)/2

T_avg_c = (T_c_i + T_c_o)/2

"Finding C_p at T_avg temperature to find the outlet temperatures"


c_p_h = 1045 [J/kg*K] "Iterated twice to find the convergence"

c_p_c = 4180 [J/kg*K] "Iterated twice to find the convergence"

"Finding outlet temperatures"


C_h = m_dot_h*c_p_h

C_c = m_dot_c*c_p_c

q_dot = C_h*(T_h_i - T_h_o)

q_dot = C_c*(T_c_o - T_c_i)

"Iterating the process above with fluid properties evaluated at the avg inlet and outlet temperatures for both hot and cold side
accordingly"

"Bulk temperature calculations"


T_b_c = (T_c_i + T_c_o)/2

T_LMTD = (((T_h_i - T_c_o)) - (T_h_o - T_c_i)) / (ln(((T_h_i - T_c_o) / (T_h_o - T_c_i))))

T_b_h = T_b_c + T_LMTD

"Based on bulk temperatures, finding fluid and pipe properties"


Mu_h_b = 2.849e-5 [kg/m*s]
Mu_c_b = 5.7790e-4 [kg/m*s]
Rho_h = 0.6418 [kg/m*m*m]
Rho_c = 989.45 [kg/m*m*m]
Pr_h = 0.680 [-]
Pr_c = 3.8405 [-]
k_h = 0.043570 [W/k*m]
k_c = 0.6369 [W/K*m]
k_w = 36 [W/k*m]
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 2
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

"Part A"

"Finding C_star"
C_min = C_h
C_max = C_c
C_star = C_min/C_max

"Finding q_max"
q_dot_max = C_min*(T_h_i - T_c_i)

"Finding Effectiveness Epsilon"


Epsilon = q_dot / q_dot_max

"Calculating NTU and UA from effectiveness and C star for a counter flow arrangement"
NTU = (1/(1-C_star))*(ln((1-(Epsilon*C_star))/(1-Epsilon)))

UA = NTU*C_min

"Reynold's number on hot side"


dh_h = d_h - (d_c + (2*th_w)) "Hydraulic diameter at the annulus region"

Re_h = (m_dot_h*dh_h)/(Mu_h_b*A_c_h) "Turbulent flow"

"Fanning friction factor, Nusselt Number and heat transfer coefficient on hot side"
r_star = (d_c + (2*th_w))/(d_h)

f_h = 0.934*(1 + (0.0925*r_star))*((1.7372*ln((Re_h)/((1.964*ln(Re_h)) - 3.8215)))^(-2))

correction_f_h = ((T_h_w/T_b_h)^0.14) "correction = 0.934"


correction_Nusselt_h = ((T_b_h/T_h_w)^0.25) "correction = 1.13"
"First iteration, assume the correction factor to be 1 and then find wall temperatures. From the estimated wall temperature, choose
the appropriate correction factor"

Nusselt_h = (0.0225*(Re_h^0.795)*(Pr_h^0.495)*1.13*exp(-0.0225*(ln(Pr_h))^2)*((1+(0.8*(r_star^(-0.16)))^15)^(1/15)))

h_h = (Nusselt_h*k_h)/dh_h

q_dot = (h_h*A_s_h*(T_b_h - T_h_w)) "Determining hot side wall temperature for length L"

"Reynold's number on cold side"


dh_c = d_c

Re_c = (m_dot_c*dh_c)/(Mu_c_b*A_c_c) "Turbulent flow"

"Fanning friction factor, Nusselt Number and heat transfer coefficient on cold side"
f_c = 1.007*((1.58*ln(Re_c)) - 3.28)^(-2)

correction_f_c = ((T_c_w/T_b_c)^0.14) "correction = 1.007"


correction_Nusselt_c = ((T_b_c/T_c_w)^0.25) "correction = 0.9878"

Nusselt_c = ((f_c/2)*(Re_c - 1000)*Pr_c*0.9878)/(1 + (12.7*(sqrt(f_c/2))*((Pr_c^(2/3))-1)))

h_c = (Nusselt_c*k_c)/dh_c

q_dot = (h_c*A_s_c*(T_c_w - T_b_c)) "Determining cold side wall temperature for length L"

"Wall resistance"
R_w = (ln((d_c + (2*th_w))/d_c))/(2*pi*k_w*L)
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 3
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

"Using the formula for UA to find L"


(1/UA) = (1/(h_h*A_s_h)) + R_w + (1/(h_c*A_s_c))

"Darcy Friction factor f_d"


f_d_h = 4*f_h
f_d_c = 4*f_c

"Darcy Weisbach Equation to estimate the presuure drop for the calculated L"
P_delta_h = (f_d_h*L*(m_dot_h^2))/(2*dh_h*Rho_h*(A_c_h^2)) "pressure drop hot side"

P_delta_c = (f_d_c*L*(m_dot_c^2))/(2*dh_c*Rho_c*(A_c_c^2)) "pressure drop cold side"

"Part B"

"given fin parameters"


L_f = 0.0165 [m]
th_f = 0.0009 [m]
N = 16 [-]

"Fin parameter m"


P_f = 2*(L_finned + th_f)
A_c_f = L_finned*th_f
m_f = sqrt((h_h_finned*P_f)/(k_w*A_c_f))

"Condition for modelling convective tip fin to an adiabatic tip fin"


condition = sqrt((h_h_finned*th_f)/(2*k_w)) "less than 0.5 by an order of magnitude"

"Correction of Length of fin"


L_cf = L_f + (th_f/2)

"Fin efficiency eta_f"


eta_f = (tanh(m_f*L_cf))/(m_f*L_cf)

A_s_f = ((2*L_f) + th_f)*(N*L_finned)

A_o_h =A_s_f + ((pi*(d_c + (2*th_w))) - (N*th_f))*L_finned "Fin surface area + outer surface area of the inner tube - fin area
already accounted for in the outer surface area of the inner tube"

"Fin effectiveness"
eta_o = 1 - ((A_s_f/A_o_h)*(1-eta_f))

"Now using updated UA formula with fins to find L_finned"


R_wf = (ln((d_c + (2*th_w))/d_c))/(2*pi*k_w*L_finned)

A_s_cf = (pi*d_c*L_finned)

"Calculating new h on hot side"


A_c_h_f = A_c_h - (N*L_f*th_f) "here effective cross sectional area is equal to area of annulus - N*cross sectional (to fluid flow)
area of fin"

dh_h_finned = (4*A_c_h_f) / (pi*(d_h + d_c + (2*th_w)) + (2*N*L_f) - (N*th_f)) "hydraulic diameter will change because of the fins.
The effective area is considered and the effective perimeter will be (perimeter of the annular region + 2*N*length of fin - N
*thickness of fin). This is only for calculating hydraulic diameter and Reynold's number"

Re_h_finned = (m_dot_h*dh_h_finned)/(Mu_h_b*A_c_h_f)

"Fanning friction factor, Nusselt Number and heat transfer coefficient on hot side"
f_h_finned = (0.9494)*(1 + (0.0925*r_star))*((1.7372*ln((Re_h_finned)/((1.964*ln(Re_h_finned)) - 3.8215)))^(-2))

correction_f_h_finned = ((T_h_w_finned/T_b_h)^0.14) "correction = 0.9494"


File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 4
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

correction_Nusselt_h_finned = ((T_b_h/T_h_w_finned)^0.25) "correction = 1.097"


"First iteration, assume the Mu correction factor to be 1 and then find wall temperatures. From the estimated wall temperature,
choose the appropriate correction factor"

Nusselt_h_finned = (0.0225*(Re_h_finned^0.795)*(Pr_h^0.495)*1.097*exp(-0.0225*(ln(Pr_h))^2)*((1+(0.8*(r_star^(-0.16)))^15)^(1
/15)))

h_h_finned = (Nusselt_h_finned*k_h)/dh_h_finned

q_dot = (h_h_finned*A_o_h*eta_o*(T_b_h - T_h_w_finned)) "Determining wall temperature for length L_finned"

f_c_finned = 1.024*((1.58*ln(Re_c)) - 3.28)^(-2)

correction_f_c_finned = ((T_c_w_finned/T_b_c)^0.14) "correction = 1.024"


correction_Nusselt_c_finned = ((T_b_c/T_c_w_finned)^0.25) "correction = 0.9592"

Nusselt_c_finned = ((f_c_finned/2)*(Re_c - 1000)*Pr_c*0.9592)/(1 + (12.7*(sqrt(f_c_finned/2))*((Pr_c^(2/3))-1)))

h_c_finned = (Nusselt_c_finned*k_c)/dh_c

q_dot = (h_c_finned*A_s_cf*(T_c_w_finned - T_b_c))

(1/UA) = (1/(h_h_finned*A_o_h*eta_o)) + R_w + (1/(h_c_finned*A_s_cf))

"Darcy Friction factor f_d"


f_d_h_finned = 4*f_h_finned

f_d_c_finned = 4*f_c_finned

"Darcy Weisbach Equation to estimate the presuure drop for the calculated L_finned"
P_delta_h_finned = (f_d_h_finned*L_finned*(m_dot_h^2))/(2*dh_h_finned*Rho_h*(A_c_h_f^2)) "pressure drop hot side with fins
and Length L_finned"

P_delta_c_finned = (f_d_c_finned*L_finned*(m_dot_c^2))/(2*dh_c*Rho_c*(A_c_c^2)) "pressure drop cold side with fins and


Length L_finned"
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 5
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

Problem 1

Given

T h,i = ConvertTemp C , K 427 [C]

T c,i = ConvertTemp C , K 25 [C]

m h = 0.2 [kg/s]

m c = 0.3 [kg/s]

q = 55000 [W]

d c = 0.0254 [m]

d h = 0.0635 [m]

th w = 0.0016 [m]

Design Parameters

2
p · dc
A c,c = Inner tube cross sectional area
4

2 2
p · dh p · d c + 2 · th w
A c,h = – Annulus cross sectional area
4 4

A s,h = p · d c + 2 · th w · L Surface area at hot side, we need to find L

A s,c = p · d c · L Surface area at cold side, we need to find L

Avg Temperatures

T h,i + T c,i
T avg =
2

T h,i + T h,o
T avg,h =
2

T c,i + T c,o
T avg,c =
2

Finding Cp at Tavg temperature to find the outlet temperatures

c p,h = 1045 [J/kg*K] Iterated twice to find the convergence

c p,c = 4180 [J/kg*K] Iterated twice to find the convergence

Finding outlet temperatures

C h = m h · c p,h

C c = m c · c p,c

q = Ch · T h,i – T h,o

q = Cc · T c,o – T c,i

Iterating the process above with fluid properties evaluated at the avg inlet and outlet temperatures for both hot and cold
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 6
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

side
accordingly

Bulk temperature calculations

T c,i + T c,o
T b,c =
2

T h,i – T c,o – T h,o – T c,i


T LMTD =
T h,i – T c,o
ln
T h,o – T c,i

T b,h = T b,c + T LMTD

Based on bulk temperatures, finding fluid and pipe properties

m h,b = 0.00002849 [kg/m*s]

m c,b = 0.0005779 [kg/m*s]

r h = 0.6418 [kg/m*m*m]

r c = 989.45 [kg/m*m*m]

Pr h = 0.68 [-]

Pr c = 3.8405 [-]

k h = 0.04357 [W/k*m]

k c = 0.6369 [W/k*m]

k w = 36 [W/k*m]

Part A

Finding Cstar

C min = Ch

C max = Cc

C min
C star =
C max

Finding qmax

q max = C min · T h,i – T c,i

Finding Effectiveness Epsilon

q
e =
q max

Calculating NTU and UA from effectiveness and C star for a counter flow arrangement

1 1 – e · C star
NTU = · ln
1 – C star 1 – e
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 7
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

UA = NTU · C min

Reynold's number on hot side

dh h = d h – d c + 2 · th w Hydraulic diameter at the annulus region

m h · dh h
Re h = Turbulent flow
m h,b · A c,h

Fanning friction factor, Nusselt Number and heat transfer coefficient on hot side

d c + 2 · th w
r star =
dh

– 2
Re h
f h = 0.934 · 1 + 0.0925 · r star · 1.7372 · ln
1.964 · ln Re h – 3.8215

0.14
T h,w
correction f,h = correction = 0.934
T b,h

0.25
T b,h
correction Nusselt,h = correction = 1.13
T h,w

First iteration, assume the correction factor to be 1 and then find wall temperatures. From the estimated wall temperature,
choose the appropriate correction factor

0.795 0.495 2 – 0.16 15 15


Nusselt h = 0.0225 · Re h · Pr h · 1.13 · exp – 0.0225 · ln Pr h · 1 + 0.8 · r star

Nusselt h · k h
hh =
dh h

q = h h · A s,h · T b,h – T h,w Determining hot side wall temperature for length L

Reynold's number on cold side

dh c = d c

m c · dh c
Re c = Turbulent flow
m c,b · A c,c

Fanning friction factor, Nusselt Number and heat transfer coefficient on cold side

– 2
f c = 1.007 · 1.58 · ln Re c – 3.28

0.14
T c,w
correction f,c = correction = 1.007
T b,c

0.25
T b,c
correction Nusselt,c = correction = 0.9878
T c,w

fc
· Re c – 1000 · Pr c · 0.9878
2
Nusselt c =
fc 2 / 3
1 + 12.7 · · Pr c – 1
2
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 8
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

Nusselt c · k c
hc =
dh c

q = h c · A s,c · T c,w – T b,c Determining cold side wall temperature for length L

Wall resistance

d c + 2 · th w
ln
dc
Rw =
2 · p · kw · L

Using the formula for UA to find L

1 1 1
= + Rw +
UA h h · A s,h h c · A s,c

Darcy Friction factor fd

f d,h = 4 · f h

f d,c = 4 · f c

Darcy Weisbach Equation to estimate the presuure drop for the calculated L

2
f d,h · L · m h
P d,h = pressure drop hot side
2
2 · dh h · r h · A c,h

2
f d,c · L · m c
P d,c = pressure drop cold side
2
2 · dh c · r c · A c,c

Part B

given fin parameters

L f = 0.0165 [m]

th f = 0.0009 [m]

N = 16 [-]

Fin parameter m

Pf = 2 · L finned + th f

A c,f = L finned · th f

h h,finned · P f
mf =
k w · A c,f

Condition for modelling convective tip fin to an adiabatic tip fin

h h,finned · th f
condition = less than 0.5 by an order of magnitude
2 · kw

Correction of Length of fin

th f
L cf = L f +
2
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 9
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

Fin efficiency etaf

tanh m f · L cf
hf =
m f · L cf

A s,f = 2 · L f + th f · N · L finned

A o,h = A s,f + p · d c + 2 · th w – N · th f · L finned Fin surface area + outer surface area of the inner tube
- fin area already accounted for in the outer surface
area of the inner tube

Fin effectiveness

A s,f
ho = 1 – · 1 – hf
A o,h

Now using updated UA formula with fins to find Lfinned

d c + 2 · th w
ln
dc
R wf =
2 · p · k w · L finned

A s,cf = p · d c · L finned

Calculating new h on hot side

A c,h,f = A c,h – N · L f · th f here effective cross sectional area is equal to area of annulus - N*cross sectional (to fluid
flow) area of fin

4 · A c,h,f
dh h,finned =
p · d h + d c + 2 · th w + 2 · N · L f – N · th f

hydraulic diameter will change because of the fins. The effective area is considered and the effective perimeter will be
(perimeter of the annular region + 2*N*length of fin - N*thickness of fin). This is only for calculating hydraulic diameter and
Reynold's number

m h · dh h,finned
Re h,finned =
m h,b · A c,h,f

Fanning friction factor, Nusselt Number and heat transfer coefficient on hot side

– 2
Re h,finned
f h,finned = 0.9494 · 1 + 0.0925 · r star · 1.7372 · ln
1.964 · ln Re h,finned – 3.8215

0.14
T h,w,finned
correction f,h,finned = correction = 0.9494
T b,h

0.25
T b,h
correction Nusselt,h,finned = correction = 1.097
T h,w,finned

First iteration, assume the Mu correction factor to be 1 and then find wall temperatures. From the estimated wall temperature,
choose the appropriate correction factor

0.795 0.495 2
Nusselt h,finned = 0.0225 · Re h,finned · Pr h · 1.097 · exp – 0.0225 · ln Pr h · 1 + 0.8
1

– 0.16 15 15
· r star
File:Problem 1_new.EES 10/28/2024 11:01:53 AM Page 10
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

Nusselt h,finned · k h
h h,finned =
dh h,finned

q = h h,finned · A o,h · h o · T b,h – T h,w,finned Determining wall temperature for length Lfinned

– 2
f c,finned = 1.024 · 1.58 · ln Re c – 3.28

0.14
T c,w,finned
correction f,c,finned = correction = 1.024
T b,c

0.25
T b,c
correction Nusselt,c,finned = correction = 0.9592
T c,w,finned

f c,finned
· Re c – 1000 · Pr c · 0.9592
2
Nusselt c,finned =
f c,finned 2 / 3
1 + 12.7 · · Pr c – 1
2

Nusselt c,finned · k c
h c,finned =
dh c

q = h c,finned · A s,cf · T c,w,finned – T b,c

1 1 1
= + Rw +
UA h h,finned · A o,h · h o h c,finned · A s,cf

Darcy Friction factor fd

f d,h,finned = 4 · f h,finned

f d,c,finned = 4 · f c,finned

Darcy Weisbach Equation to estimate the presuure drop for the calculated Lfinned

2
f d,h,finned · L finned · m h
P d,h,finned = pressure drop hot side with fins and Length Lfinned
2
2 · dh h,finned · r h · A c,h,f

2
f d,c,finned · L finned · m c
P d,c,finned = pressure drop cold side with fins and Length Lfinned
2
2 · dh c · r c · A c,c
File:Problem 1_new.EES 10/28/2024 11:01:54 AM Page 11
EES Ver. 11.626: #6461: For use only by students and faculty Mechanical and Materials Engineering University of Cincinnat

SOLUTION
Unit Settings: SI C kPa kJ mass deg
Ac,c = 0.0005067 [m*m] Ac,f = 0.003005 [m*m]
Ac,h = 0.002524 [m*m] Ac,h,f = 0.002287 [m*m]
Ao,h = 2.063 [m*m] As,c = 0.9391 [m*m]
As,cf = 0.2664 [m*m] As,f = 1.811 [m*m]
As,h = 1.057 [m*m] condition = 0.06353 [-]
correctionf,c = 1.007 [-] correctionf,c,finned = 1.024 [-]
correctionf,h = 0.934 [-] correctionf,h,finned = 0.9494 [-]
correctionNusselt,c = 0.9878 [-] correctionNusselt,c,finned = 0.9593 [-]
correctionNusselt,h = 1.13 [-] correctionNusselt,h,finned = 1.097 [-]
Cc = 1254 [W/K] Ch = 209 [W/K]
Cmax = 1254 [W/K] Cmin = 209 [W/K]
cp,c = 4180 [J/kg*K] cp,h = 1045 [J/kg*K]
Cstar = 0.1667 [-] dhc = 0.0254 [m]
dhh = 0.0349 [m] dhh,finned = 0.01139 [m]
dc = 0.0254 [m] dh = 0.0635 [m]
e = 0.6546 [-] hf = 0.4109 [-]
ho = 0.4829 [-] fc = 0.006162 [-]
fc,finned = 0.006266 [-] fd,c = 0.02465 [-]
fd,c,finned = 0.02506 [-] fd,h = 0.01763 [-]
fd,h,finned = 0.02243 [-] fh = 0.004407 [-]
fh,finned = 0.005606 [-] hc = 3624 [W/m*m*K]
hc,finned = 3563 [W/m*m*K] hh = 244.4 [W/m*m*K]
hh,finned = 322.9 [W/m*m*K] kc = 0.6369 [W/K*m]
kh = 0.04357 [W/k*m] kw = 36 [W/k*m]
L = 11.77 [m] Lcf = 0.01695 [m]
Lf = 0.0165 [m] Lfinned = 3.338 [m]
mc,b = 0.0005779 [kg/m*s] mh,b = 0.00002849 [kg/m*s]
mc = 0.3 [kg/s] mh = 0.2 [kg/s]
mf = 141.2 [1/m] N = 16 [-]
NTU = 1.137 [-] Nusseltc = 144.5 [-]
Nusseltc,finned = 142.1 [-] Nusselth = 195.8 [-]
Nusselth,finned = 84.43 [-] Prc = 3.841 [-]
Prh = 0.68 [-] Pd,c = 2023 [N/m*m]
Pd,c,finned = 583.6 [N/m*m] Pd,h = 29067 [N/m*m]
Pd,h,finned = 39157 [N/m*m] Pf = 6.679 [m]
q = 55000 [W] qmax = 84018 [W]
Rec = 26022 [-] Reh = 97048 [-]
Reh,finned = 34971 [-] rc = 989.5 [kg/m*m*m]
rh = 0.6418 [kg/m*m*m] rstar = 0.4504 [-]
Rw = 0.00004457 [K/W] Rwf = 0.0001571 [K/W]
thf = 0.0009 [m] thw = 0.0016 [m]
Tavg = 499.2 [K] Tavg,c = 320.1 [K]
Tavg,h = 568.6 [K] Tb,c = 320.1 [K]
Tb,h = 551.5 [K] Tc,i = 298.2 [K]
Tc,o = 342 [K] Tc,w = 336.2 [K]
Tc,w,finned = 378 [K] Th,i = 700.2 [K]
Th,o = 437 [K] Th,w = 338.7 [K]
Th,w,finned = 380.5 [K] TLMTD = 231.4 [K]
UA = 237.7 [W/K]

No unit problems were detected.

You might also like