Download as docx, pdf, or txt
Download as docx, pdf, or txt
You are on page 1of 23

Q: 1.

Figure 1 depicts a stainless steel pipe whose inner and outer diameters are 20 mm and
25 mm, respectively; i.e., D1 = 20 mm and D2 = 25 mm. This pipe is covered with an insulation
material whose thickness is 35 mm. The temperature of the saturated vapor (steam) flowing
through the pipeline is Ts = 150°C, and the external and internal convective heat transfer
coefficients are, respectively, measured to be hi = 1,500 W/m2⋅K and h0 = 5 W/m2⋅K. Besides,
the thermal conductivity of the stainless steel and the insulation material are ks = 45 W/m⋅K and
ki = 0.065, respectively. If the ambient temperature is Ta = 25°C, 35 oC, 40 oC and45 oC,
determine the internal and external wall temperatures of the stainless steel pipe, T1 and T2 ,
and the exterior wall temperature of the insulation material, using MATLAB for the given
ambient
temperatures. Also plot the given ambient temperatures against the calculated T1, T2 and T3
values.

GIVEN DATA
D1=20/1000; Inner Diameter of stainless steel pipe from mm to meters
D2=25/1000; Outer Diameter of stainless steel pipe from mm to meters
Thi=35/1000; Thickness of insulation material from mm to meters
Ts=150+273; Temperature of steam from °C to Kelvin
hi=1500; Internal Heat transfer coefficient in W/m2.K
h0=5; outer heat transfer coefficients in W/m2.K
ks=45; Thermal conductivity of stainless steel in W/m.K
ki=0.065; Thermal conductivity of insulation material in W/m.k
Ta1=25+273;Given 1st Ambient temperatures from °C to Kelvin
Ta2=35+273;Given 2nd Ambient temperatures from °C to Kelvin
Ta3=40+273;Given 3rd Ambient temperatures from °C to Kelvin
Ta4=45+273; Given 4rth Ambient temperatures from °C to Kelvin
Ta=Ta1, Ta2, All Ambient Temperatures
D3=D2+2*Thi; Total diameter of pipe insulating material

REQUIRED
We have to find the exterior wall temperature of insulation T1,T2 and T3.
Plot graph between ambient temperature values and T1,T2, and T3 values.

GIVEN FORMULAS
Heat transfer from steam to pipe
(T 1−T 2)
hi π D1 (T s −T 1 )=
ln(D2 / D1) /2 π k s
Heat transfer from pipe to insulation
(T 1−T 2) (T 2−T 3 )
=
ln ( D 2 / D 1) /2 π k s ln (D 3 /D 2 )/2 π k i

Heat transfer from insulation to surrounding


(T 2−T 3 )
=h π D 3(T 3−T a )
ln ( D 3 / D 2 )/2 π k i o

And using the above balances we prepared a matrix of A and B


Equation from first balance
2 π ki 2 π ki
hi πD 1 T s=T 1 ( +h1 πD1 )−T 1 ( )+T 3 (0)
ln(D 2 / D 1) ln (D 2 / D 1)

Equation from second Balance


ks ks ki ki
T 1( )−T 2( + )+T 3 ( )=0
ln(D 2 /D 1 ) ln (D 2 / D 1) ln ( D 3 / D 2) ln( D 3 / D 2)

Equation from third balance


2 ki 2 ki
h o D 3 T a =T 1 ( 0)−T 2 ( )+T 3 ( +h D )
ln (D 3 /D 2 ) ln(D 3 / D 2) o 3

STEP=1
First we make the matrices from formulas giving names A, T AND B.

(2 k s /log ( D 2 / D 1))+hi D 1−(2∗k s /log( D2 / D 1))0

[
A= k s /log (D 2 / D 1)−((k s /log ( D 2/D 1))+(k i / log (D 3 /D 2 ))) k i / log( D 3 / D2 )
0−2k i /log(D 3 / D 2)(2 k i /log (D 3 / D 2))+ ho D 3 ]
A=[(2ks/log(D2/D1))+hi*D1 -(2*ks/log(D2/D1)) 0;
ks/log(D2/D1) -((ks/log(D2/D1))+(ki/log(D3/D2))) ki/log(D3/D2);
0 -2*ki/log(D3/D2) (2*ki/log(D3/D2))+h0*D3 ]
B1= [hi D1 T s 0 h o D3 T a 1]'

B2= [hi D 1 T s 0 h o D 3 T a 2 ]'

B3= [hi D1 T s 0 h o D3 T a 3 ]'

B4 = [hi D 1 T s 0 h o D 3 T a 4]'

B1=[hi*D1*Ts 0 h0*D3*Ta1]
B2=[hi*D1*Ts 0 h0*D3*Ta2]
B3=[hi*D1*Ts 0 h0*D3*Ta3]
B4=[hi*D1*Ts 0 h0*D3*Ta4]

As we have to find exterior temperatures

A*T=B

T =B/A
A-1= Adj[A]/det[A]
as det should not be zero.

STEP=2
finding the temperatures by using the following equations.

T1=A\B1
T2=A\B2
T3=A\B3
T4=A\B4

STEP=3
WE PLOT the graph between ambient temperatures and calculated temperatures.
RESULTS
STEP=4
%%Assignment 1
%
%MATLAB solution Written by:
%Group 10
%
%
%
%
%
%Given Parameters
%
D1=20/1000; %Inner Diameter of stainless steel pipe from mm to meters
D2=25/1000; %Outer Diameter of stainless steel pipe from mm to meters
Thi=35/1000; %Thickness of insulation material from mm to meters
Ts=150+273; %Temperature of steam from °C to Kelvin
hi=1500; %Internal Heat transfer coefficient in W/m2.K
h0=5; %outer heat transfer coefficients in W/m2.K
ks=45; %Thermal conductivity of stainless steel in W/m.K
ki=0.065; %Thermal conductivity of insulation material in W/m.k
Ta1=25+273;%Given 1st Ambient temperatures from °C to Kelvin
Ta2=35+273;%Given 2nd Ambient temperatures from °C to Kelvin
Ta3=40+273;%Given 3rd Ambient temperatures from °C to Kelvin
Ta4=45+273; %Given 4rth Ambient temperatures from °C to Kelvin
Ta=[Ta1 Ta2 Ta3 ]; %Array of all Ambient Temperatures
D3=D2+2*Thi; %Total diameter of pipe+insulating material
%
%
%To be required
% T1, T2, T3 values in kelvin
%Plot graph between ambient temperature values and T1,T2, and T3 values
%
%Matric A
A=[(2*ks/log(D2/D1))+hi*D1 -(2*ks/log(D2/D1)) 0;
ks/log(D2/D1) -((ks/log(D2/D1))+(ki/log(D3/D2))) ki/log(D3/D2);
0 -2*ki/log(D3/D2) (2*ki/log(D3/D2))+h0*D3 ];
%
%Vector B
B1=[hi*D1*Ts 0 h0*D3*Ta1]';
B2=[hi*D1*Ts 0 h0*D3*Ta2]';
B3=[hi*D1*Ts 0 h0*D3*Ta3]';
B4=[hi*D1*Ts 0 h0*D3*Ta4]';
%
%Check whether Matrix A is singlar or not, if A is dsingular(det(A)=0)
%solution will not exist
if det(A)==0
fprintf('\n Rank of A=%i', rank(A))
error('Matrix A have determinant 0 so solution doesnt exist. ') %%If the determinant will be
zero than exit without solving
end
%
%
%if det(A)~=0 then unique solution will exist
%
T1=A\B1;%finding solutions
T2=A\B2;
T3=A\B3;
T4=A\B4;
%
%displaying results
%
fprintf('\n For Ambient Temperature Ta1=298 K:\n \n T11=%2.4f K, T12=%2.4f K, T13=%2.4f
K',T1)%% Displaying Ambient Temperatures sepearately
fprintf('\n \n For Ambient Temperature Ta2=308 K:\n \n T21=%2.4f K, T22=%2.4f K, T23=
%2.4f K', T2)
fprintf('\n \n For Ambient Temperature Ta3=313 K:\n \n T31=%2.4f K, T32=%2.4f K, T33=
%2.4f K', T3)
fprintf('\n \n For Ambient Temperature Ta4=318 K:\n \n T44=%2.4f K, T42=%2.4f K, T43=
%2.4f K', T4)
plot(Ta,T1,'s:',Ta,T2,'o--',Ta,T3,'d-.',Ta,T4,'x--')
legend('For 298 K Ambient Temperature','For 308 K Ambient Temperature','For 313 K Ambient
Temperature','For 318 K Ambient Temperature')
xlabel('Ambient Temperatures (Kelvin)')
ylabel('Calculated Temperatures (Kelvin)')
title('Ambient VS Calculated Temperatures')

Q: 2. In petroleum industries, it is common that the molecular weight of an oil fraction is


unknown and thus must be estimated by using a correlation. A correlation that is widely used is
developed by Riazi and Daubert, which is also referred to as the API (American Petroleum
Institute) method. The correlation can be applied to hydrocarbons with molecular weight ranging
from 70-700, which is nearly equivalent to boiling point range of 300-850 K, and the API gravity
range of 14.4-93. This molecular weight (M) correlation is given as a function of the average
boiling point (Tb) and the specific gravity at 60°F {SG) of the oil fraction of interest as follows:
Where, Tb is in K and SG is related to the API gravity {API):
 Estimate the molecular weight of an oil fraction that has an average boiling point of
344.7°C and an API gravity of 50.
 Plot on the same graph M vs.T (400 < Tb< 600 K) with API gravity = 20, 40, and 60.
GIVEN DATA
TB=344.7+273 Boiling Temperature values from °C to kelvin
API=50 Given API value of oil
Tb=400:600 Boiling Temperature range in kelvin
APIo=20:20:60 Given API values
SOLUTIONS
Given formulas
M=42.965*exp(2.097e-4*(TB)-(7.78712*SG)+(2.08476e-
3*(TB)*SG))*(TB^1.26007)*(SG^4.98308)
SGo=141.5./(APIo+131.5) SG values for given APIo values
STEP=1
IN PART(A)
We find the specific gravity by putting the values of API=50 AND TB=344.7+273(KELVIN)
STEP=2
WE find the molecular weight by putting the values of specific gravity.
M=42.965*exp(2.097e-4*(TB)-(7.78712*SG)+(2.08476e-
3*(TB)*SG))*(TB^1.26007)*(SG^4.98308)
PART(B)
STEP=1
we find the specific gravity by using the range of API=20:20:60
SGo=141.5./(APIo+131.5)
STEP=2
By putting the values of TB(boiling temperature)and specific gravity.we find the molecular
weight.
M1=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(1)+2.08476e-
3.*(Tb*SGo(1))).*Tb.^1.26007*SGo(1)^4.98308
M2=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(2)+2.08476e-
3.*(Tb*SGo(2))).*Tb.^1.26007*SGo(2)^4.98308
SGo(2)in g/gmole
M3=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(3)+2.08476e-
3.*(Tb*SGo(3))).*Tb.^1.26007*SGo(3)^4.98308
Molecular Weight for SGo(3)in g/gmole
STEP=3
we plot the graphs molecular weight and ambient temperature.
RESULTS

M=292.8225 g/gmole

STEP=4

%%Assignment 1
%
%MATLAB solution Written by:
%Group 10
%
%
%
%Part(a) Solution
%
%Given Data
%
TB=344.7+273; %Boiling Temperature values from °C to kelvin
API=50; %Given API value of oil
%
%To be required
%Molecular weight of an oil fraction(M)
%
%Given formula
SG=141.5/(API+131.5); %Specific gravity relation with API
%
fprintf('\n Part (a) Molecular Weight of Oil fraction: \n')
M=42.965*exp(2.097e-4*(TB)-(7.78712*SG)+(2.08476e-
3*(TB)*SG))*(TB^1.26007)*(SG^4.98308); % Molecular weight relation
fprintf('\n M=%3.4f g/gmole ',M )
%
%Part (b)
Tb=400:600; %Boiling Temperature range in kelvin
APIo=20:20:60; % Given API values
SGo=141.5./(APIo+131.5); %SG values for given APIo values
%
%Molecular Weight Calculations
%
M1=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(1)+2.08476e-
3.*(Tb*SGo(1))).*Tb.^1.26007*SGo(1)^4.98308; %Molecular Weight for SGo(1)in g/gmole
M2=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(2)+2.08476e-
3.*(Tb*SGo(2))).*Tb.^1.26007*SGo(2)^4.98308; %Molecular Weight for SGo(2)in g/gmole
M3=42.965*exp(2.097e-4.*(Tb)-7.78712*SGo(3)+2.08476e-
3.*(Tb*SGo(3))).*Tb.^1.26007*SGo(3)^4.98308; %Molecular Weight for SGo(3)in g/gmole
plot(M1,Tb,'x--',M2,Tb,'o--',M3,Tb,'s:')
title('Molecular weight VS Boiling Temperatures')
xlabel('Molecular Weight (g/gmole)')
ylabel('Boiling Temperatures (Kelvin)')
legend('APIo=20','APIo=40','APIo=60')

Q: 3. In chemical industry, the cost of piping system (pipes and fittings) and pumping are
important costs that should be considered. The annual cost of a pipeline with a standard
carbon steel pipe and a motor-driven centrifugal pump is given by:
where L is the length of the pipeline in ft, D is the pipe diameter in inch, and P is the power of
the pump in ph which can be calculated from:
In the
above equation, Q is the volumetric flow rate of the fluid in gpm.
(a) Plot the annual cost as a function of pipe diameter, say from 0.25 to 6 in, for 1000 ft
pipeline with a fluid rate of 20 gpm.
(b) What is the annual cost needed if a pipe with a diameter of 1 in is used? Is there an
optimum diameter for this pipeline? Explain why it is expensive when a very small pipe
diameter is used.

GIVEN DATA
D1=0.25:6 Diameter of pipe in inches
L=1000 Length of Pipe in feets
Q=20 Volumetric Flow rate in gpm units

REQUIRED
We have to find the annual cost (C) of pipe and plot the graph of annual cost and given
diameters.
GIVEN FORMULAS

where L is the length of the pipeline in ft, D is the pipe diameter in inch, and P is the power of
the pump in hp, which can be calculated from

Here Q is the volumetric flow rate in gpm.

SOLUTION
STEP=1
Calculation of power (p)
First we calculate the value of power P by putting the values of diameter (D), length (L) and
volumetric flow rate (Q)

P=((4.4e-8)*(L*Q^3)./D.^5)+((1.92e-9)*(L*Q^2.8)./D.^4.686)

STEP=2
Calculation of annual cost of pipe (C)
By putting the values of power in the following formula we calculated the annual cost of pipe.

C=0.45*L+(0.245*L.*D.^1.5)+(325.*sqrt(P))+(61.6.*P.^0.925)+102
STEP=3

In the last we plotted graph between diameters of pipe(in inches) and annual cost of pipe (in
PKR).
RESULTS
STEP=4

%%Assignment 1
%
%MATLAB solution Written by:
%Group 10
%
%
%
%
%
%Part(a) Solution:
%
%Given data
%
D=0.25:6; %Diameter of pipe in inches
L=1000; %Length of Pipe in feets
Q=20; %Volumetric Flow rate in gpm units
%
%To be required
%
%1-find annual cost by first finding power
%2-Plot annual cost values VS Diameter of pipe
%
%
disp('Calculated Power Values are: ')
%
%
P=((4.4e-8)*(L*Q^3)./D.^5)+((1.92e-9)*(L*Q^2.8)./D.^4.686); % Formula for Power
calculations in hp unit
%
%
fprintf('\n P1= %1.5f hp \n P2=%1.5f hp \n P3=%1.5f hp \n P4=%1.5f hp \n P5=%1.5f hp \n P6=
%1.5f hp', P)
%
%
fprintf('\n \n Calculated Annual cost values \n')
%
C=0.45*L+(0.245*L.*D.^1.5)+(325.*sqrt(P))+(61.6.*P.^0.925)+102; % Formula for the
calculation of annual cost from Power
%
fprintf('\n C1=%3.3f PKR \n C2=%3.3f PKR \n C3=%3.3f PKR \n C4=%3.3f PKR \n C5=%3.3f
PKR \n C6=%3.3f PKR \n', C)
plot(D,C,'x--')
title('Plot of Diamter of Pipe VS Annual cost')
xlabel('Diameter of Pipe (Inches)'), ylabel('Annual cost (PKR)')
%
%
%Part(b)
%Finding Annual cost
Dp=1; %if Diameter of pipe is 1 inch
%
%To find
%Annual cost at 1 Diameter
Pb=((4.4e-8)*(L*Q^3)/Dp^5)+((1.92e-9)*(L*Q^2.8)/Dp^4.686); % Formula for Power
calculations of (b) part in hp unit
%
fprintf('\n Power calculation for pipe of 1 inch diameter =Pb= %3.4f hp', Pb)
%
%
Cb=0.45*L+(0.245*L*Dp^1.5)+(325*sqrt(Pb))+(61.6*Pb^0.925)+102; % Formula for the
calculation of annual cost from Power for 1 inch pipe dia
%
%
fprintf('\n Annual cost for pipe of 1 inch diameter =Cb= %3.2f PKR',Cb)

Q: 4. A first order reaction is carried out in a series of N equal-size mixed flow reactors. The
total conversion (X) achieved for this system is given by reaction constant (= 0.075 hr-1)
and τ is the mean residence time in a single mixed reactor.

1. Plot the total conversion of this reaction as a function of τ (0 < τ < 40 hrs) for N = 4.
2. Plot on the same graph the total conversion as a function of τ for N= 2.
3. Calculate the total conversion if the number of equal-size mixed reactors is 6 and the
residence time of the fluid in a single reactor is 5 hrs.

4. Suppose we allocate a total of 10 hrs for this reaction ( =10 hrs, the summation is
over all reactors) and a large conversion is desired, would you suggest having a lot of
small mixed reactors or a few large mixed reactors? Explain your reasoning using some
calculations. Hint: a larger reactor has a larger fluid residence time.
Determination of residence time with different number of reactors.
K=0.0751/hr
T=1/K =13.33hr
Formula:
X=1-1/(1+Ti+ K )n
MATLAB SUCRIPT:
%Question #4 first order reaction in a mixed flow reactor
%PART (a)
%K=reaction constant (1/hr)
%T=mean resisdence time(hr)
K=0.075;'1/hr';
T=1/K; 'hr';
%Given range of residence time
Ti=[13.33:5:40];'hr';
%N=Number of reactors
N=4;
%X=Total conversion
Xa=(1-(1./((1+Ti*K).^N)))
%PART(b)
N=2;
Xb=(1-(1./((1+Ti*K).^N)))
%PART (c)
N=6;T=5;'hr';
Xc=(1-(1./((1+Ti*K).^N)))
%
%Graph plotting
plot(Ti,Xa, 'x--', Ti, Xb,'x--',Ti,Xc,'x--')
xlabel('conversion');
ylabel('resisdence time hr');
%PART (d)
%Conversion in system 1
K=0.075;'1/hr';
T=10;'hr'; Na=4;
Xa1=(1-(1./((1+T*K).^Na)));
%Conversion in system 2
Nb=2;
Xb2=(1-(1./((1+T*K).^Nb)));
%conversion in system 3
Nc=6;
Xc3=(1-(1./((1+T*K).^Nc)));
%conversion in system 4
Ns=1;
Xs4=(1-(1./((1+T*K).^Ns)));
% Large reactors conversion will be large but residence time will high.
Results:

Q: 5. A mixture containing 50 wt% toluene (T), 35 wt% benzene (B), and 15 wt% xylene (X) is
fed to a distillation column. The top product from the column contains 6.3 wt% toluene, 91.4 wt
% benzene, and 2.3 wt% xylene. The bottom product is fed to a second column. The top product
from the second column contains 91.6 wt% toluene, 4.25 wt% benzene, and 4.15 wt% xylene. 10
wt% of the toluene fed to the process is recovered in the bottom product from the second column,
and 83.3 wt% of the xylene fed to the process is recovered in the same stream. Determine the
compositions and flow rates of all streams if the feed flow rate is 100 kg/minute.
Determination of compositions and flow rates of all streams of toluene benzene and xylene

Given Data
F=100(Kg/min)
Feed
Wtf=0.5 wbf=0.35 wxf=0.15
Stream 1
Wt1=0.063 wb1=0.914 wx1=0.023
Stream 2
Nt2 =? Nb2=? Nx2=?
Stream 3
Wt3=0.916 wb3=0.0425 wx3=0.0415
Stream 4
Nt4=0.1*0.5=0.05 Nb4= ? Nx4=0.833*0.15=0.12
Nb4=1-Nt4+Nx4=1-0.12+0.05=0.82
Overall mass balance

Feed and S1 Stream 2 and 3


Toluene
100*0.5=50=0.063S1+Nt2 Nt2=0.916S3+0.05
Benzene
100*0.35=35=0.914S1+Nb2 Nb2=0.0425+0.82
Xylene
100*0.15=15=0.023S1+Nx2 Nx2=0.0415+0.12
Mass Balance
S2=S3+S4

0.5 0.916 0 0.05 S 3

[ ][
F* 0.35
0.15
= 0.0425 0 0.82 0
0.0415 0 0.12 S 4][ ]
(b) Mass balance S1=F-S2
Determination of compositions and flow rates of all streams with 100(Kg/min)
To determine S1,S2,S3,S4,nT2,nB2,nX2
flow balance on S1 & S2 column
A=[ 0.916 0.05; 0.0425 0.8250; 0.0416 0.1250];
B=[50;35;15];
F=100(Kg/min)
X=A\B;
S3=X(1);
S4=X(2);
%Overall balance result for S3 and S4
S2=S3+S4;
%S1=F-S2;
S1=100-S2;
fprintf(‘FLOW RATES OF STREAMS (Kg/min)’);
fprintf(‘\n F=100 S1=6.2373 S2=93.7627 S3=52.6642 S4=41.0985’);
%Balance on column 1
%100*TF = S1*TS1 + S2*TS2;
%100*BF = S1*BS1 + S2*BS2;
%100*XF = S1*XS1 + S2*XS2;
nT2=(50 – 6.2327*0.063)/93.7627;
nB2=(35 – 6.2327*0.914)/93.7627;
nX2=(15 – 6.2327*0.023)/93.7627;
fprintf(‘\n nT2=0.5291 nB2=0.3125 nX2=0.1584 \n’);

Results:
Q: 6. (a) Determine the bubble temperature (t) of a liquid binary mixture containing 20 mol%
acetone (xi) and 80 mol% methanol at 1 atm (P). Also calculate the mol fraction of acetone in
vapor phase (yi) at that bubble temperature. From thermodynamics, the following equations can
be set up:

(a)Plot the bubble point temperature as a function of the mol fraction of component 1 in the
liquid phase (x1). Note: y-axis: t, x-axis: x1
Solution: Determination of bubble Temperature
x1=0.2 x2=0.8 P=101.3KPa
A1=14.3916 B1=2795.82 C1=230
A2=16.59138 B2=3644.30 C2=239.79
 Find Gamma 1 Gamma2 with given values of x1
 Find assume temperatures with given value of Pressure from

Bi
antoion equation T= +Ci
Ai−ln ⁡(P)
 Find saturated vapor Pressures from antoion equation.
Bi
. lnP1sat=Ai-
T −Ci
 Find alpha values and bubble temperature from antoion equation
again.
ɣ 1 P 1 sat
 ⍺=ln( )
ɣ 2 P 2 sat
 Find values of alpha x and y1.
 Plot Temperature vs x

MAT LAB SCRIPT


%Determination of bubble temperature and mole fraction of acetone yi
%Given Data
x1=0.2; x2=0.8; P=101.3;'KPa';
gamma1=exp(0.64*(1-x1)^2);
gamma2=exp(0.64*(x1)^2);
A1=(14.3916);B1=(2795.82);C1=(230);
A2=(16.59138);B2=(3644.30);C2=(239.79);
T1sat=(B1/(A1-log(P))-C1)
T2sat=(B2/(A2-log(P))-C2)
Ti=[56,58,60,62,64];
P1sat=-(B1./(Ti+C1))
P1satA=exp(A1+P1sat)
P2sat=-(B2./(Ti+C2))
P2satB=exp(A2+P2sat)
Alpha=(P2satB./P1satA)
T=((B1./(A1-log(P1satA)))-C1)
P=101.3;'KPa';
y1=(x1a*gamma1.*P1satA)/(P)
y2=y1-1
%results plotting
x=[0.2 0.4 0.6 0.8 1]
y=[56,58,60,62,64]
% Plot y versus x
plot(x,y)
xlabel('composition')
ylabel('Temperature in degree')
Title('Graph between bubble temperature and mol fraction')

Results:
Q: 7. The mean molar heat capacity of nitrogen between 298 K and T at 1 atm has been
tabulated as follow:

T [K] 373.0 473.0 573.0 673.0 773.0 873.0 973.0

Cp 29.19 29.29 29.46 29.68 29.97 30.27 30.56


[J/mol.K]

Determine the mean molar heat capacity of nitrogen between 298 K


and a. 450 K
b. 525 K
c. 740 K
Based upon this data find mean molar heat capacity at different values of temperature
298K,450K,525K and 740K.
x=temperature ℃
y=heat capacity Cp (J/mloK)
yi = interp1(x, y, xi, method)
MATLAB SCRIPT
%The mean molar heat capacity of nitrogen between 298 K and T at 1 atm has
%been given below
x=[298]; %fixed temperature
T=[373 473 573 673 773 873 973]; %T temperature
Cp=[29.19 29.29 29.46 29.68 29.97 30.27 30.56]; %Cps at given temps
%
%Determine the mean molar heat capacity of nitrogen between 298 K and
%a) 450 K
%b) 525 K
%c) 740 K
%
%Solution
%
z=T-x; %T2-T1
T=[z];
Cp=[29.19 29.29 29.46 29.68 29.97 30.27 30.56]; %Cps at given temps
%
%interpolation
%
Ti=[450 525 740]; %T temp of interest
To=[Ti-x]; %T2-T1
Toi=[To];
y1=interp1(T,Cp,Toi); %interpolation
disp('Temperature Molar Specific Capacity ')
for i=1:length(Toi)
fprintf('\n %1i %20.3f',Toi(i),y1(i))
Results:
Q: 8. The vapor pressure (P) of water and the specific volume (v) of saturated water vapor are
tabulated in a steam table:

T [oC] 0.01 3.0 6.0 9.0 12.0 15.0 18.0

P (kPa) 0.6113 0.7577 0.9349 1.1477 1.4022 1.7051 2.0640

v (m3/kg) 206.136 168.132 137.734 113.386 93.784 77.926 65.038

Determine the vapor pressure of water and the specific volume (v) of saturated water vapor
at: a. 1°C
b. 10°C
c. 14°C
Interpolation of vapor pressure at specific volume and temperature
yi = interp1(x, y, xi, method)
MATLAB SCRIPT
%The vapor pressure (P) of water and the specific volume (v) of saturated water vapor in a steam
table

T=[0.01 3 6 9 12 15 18]; %Given temps


P=[0.6113 0.7577 0.9349 1.1477 1.4022 1.7051 2.0640]; %Given V.pressure
V=[206.136 168.132 137.734 113.386 93.784 77.926 65.038]; %Given S.volume
%
%Determine the vapor pressure of water and the specific volume (v) of saturated water vapor at:
% a) 1°C
% b) 10°C
% c) 14°C
%
%Solution
%
%interpolation
%
xi=[1 10 14]; %Temp of interest
y1=interp1(T,P,xi,'linear'); %V.pressure
y2=interp1(T,V,xi,'linear'); %S.volume
disp('Temperature Vapour Pressure Specific volume')
for i=1:length(xi)
fprintf('\n %1.2i %18.3f %23.4f',xi(i),y1(i),y2(i))
end.
Reslts:

You might also like