CRE Notes 13-A Methanol Reactor
CRE Notes 13-A Methanol Reactor
CRE Notes 13-A Methanol Reactor
The methanol mole fraction at the reactor outlet is small such that reactants are separated from the
methanol product and recycled to the reactor in a methanol plant. The methanol mole fraction is limited to
a low values by thermodynamic equilibrium constraints.
Chen et al. used the kinetics of Vanden Bussche and Froment in an Aspen Plus reactor model. They also
had access to plant data for a large methanol reactor with 1620 each, 7-meter-long tubes. Below is a table
comparing data from the plant, the results of their reactor model, and the results of this model.
methanol
mole fraction
T out (C)
0.0630
255
66.7
0.0629
256
66.7
0.0627
257
66.7
0.0630
256
66.7
Although we used the same reaction kinetics as Chen et al., there are differences between the two models
that would produce the somewhat different results. For example, they used a model of a counter-current
heat exchange reactor in Aspen Plus for the boiling water (steam raising) reactor in the plant, whereas we
used a single heat transfer jacket temperature.
R. K. Herz, [email protected], Part 13-A, p. 1 of 11
In the first entry for this model in the table, the jacket temperature was set to 231.2 C, which was the
outlet steam temperature of Chen et al.'s reactor. The cooling water entered their reactor at 220 C such that
part of their tubes were exposed to a somewhat cooler temperature than the steam temperature. In the last
entry for this model in the table, the constant jacket temperature was lowered by 0.8C and closer
agreement to the plant data was obtained.
The second figure shows the same reactor model except that it is run with adiabatic operation.
The third figure plots the operating lines of the cooled and adiabatic cases on a percent methanol vs.
temperature plot. The equilibrium line at the outlet pressure of the cooled reactor case is also plotted. The
adiabatic reactor operating line goes past the 66.7 bar equilibrium line because equilibrium is established in
the middle of the adiabatic reactor where the pressure and temperature are higher than they are at the
outlet, where equilibrium is also obtained (66.7 bar, 567 K, 3.55 % at outlet). The temperature falls near
the end of the reactor as the pressure continues to fall because equilibrium is shifting to lower conversion
to methanol and the reverse methanol synthesis reaction is endothermic.
References
K. M. Vanden Bussche and G. F. Froment, A Steady-State Kinetic Model for Methanol Synthesis and
the Water Gas Shift Reaction on a Commercial Cu/ZnO/Al2O3 Catalyst, J. Catalysis, vol. 161, pp.
1-10, 1996.
L. Chen, Q. Jiang, Z. Song, and D. Posarac, Optimization of Methanol Yield from a Lurgi Reactor,
Chemical Engineering & Technology, vol. 34, pp. 1-7, 2011.
The screenshot below shows a similar reactor. Note the people at the bottom of the photograph of the
disassembled reactor. The catalyst is inside the tubes. The top right panels show that this company models
the coolant flow profiles and temperature variations and in the shell. Our model assume a constant coolant
temperature.
clear all
fprintf('-----------------------run separator----------------------------------\n')
% -------- SPECIFY INPUTS --------------% INPUT VALUES HERE ARE FROM Chen et al., 2011:
%
L. Chen, Q. Jiang, Z. Song, and D. Posarac,
%
"Optimization of Methanol Yield from a Lurgi Reactor,"
%
Chemical Engineering & Technology, vol. 34, pp. 1-7, 2011.
% INPUT INLET TEMPERATURE AND PRESSURE OF REACTANT GAS
Tin = 225 + 273.15; % K
Pin = 69.7; % bar
% INPUT REACTOR CATALYST BED PROPERTIES
Bdiam = 0.04; % m, ID of one catalyst tube
Blen = 7; % m, length of tubes
Btubes = 1620; % number of tubes
% NOTE: Chen et al., 2011 had cylindrical pellets 5.4 mm in diam x 5.2 mm long
Bdp = 0.0054; % m, diam of catalyst pellets
Bvoid = 0.285; % bed void fraction, voids between pellets
Bcatdens = 1190; % kg/m3, catalyst pellet density, where bed dens = cat dens*(1-Bvoid)
% INPUT HEAT TRANSFER DATA
%
for an adiabatic bed, set U = 0
%
to approach a true isothermal bed, set Tj = Tin and U = large value, e.g., 1e4 or 1e5
%
for a boiling water reactor (steam raising), enter appropriate Tj and U
Tj = 231.2 + 273.15; % K, heat transfer jacket temperature, Chen et al. steam temp 231.2 C
U = 118.44; % J/s/m2/K, heat transfer coefficient
% STOICHIOMETRIC EQUATIONS DEFINING EXTENTS e()
%
extent 1 for: CO2 + 3H2 = CH3OH + H2O
%
extent 2 for: CO2 + H2 = CO + H2O
% initial values of extents
ein = [0, 0]; % mol/s
% INPUT INITIAL VALUES OF COMPONENT MOLAR FLOW RATES
%
order of components in vectors: H2, CO, CO2, MeOH, water, N2, CH4
% ONE WAY is to specify total molar flow rate and components as relative molar flows
%
and then compute vector of inlet molar flow rates, Fin
FtotIn = 1740.2; % mol/s, 1740.2 = 6264.8 kmol/h, 28.44 mol/s = 225.52 lbmol/h
% first list component flows as relative molar flow rates
% must have H2 and CO2 non-zero or will get div by zero in MeOHrates
% H2, CO, CO2, MeOH, water, N2 (inert), CH4 (inert)
xin = [9586.5/2 10727.9/28 23684.2/44 756.7/32 108.8/18 8072/28 4333.1/16];
z = Blen*W/Wcat;
[AX,H1,H2] = plotyy([z z],[P/Pin T/Tin],z,100*xm); % ,'r--',z,T/Tin,'b--')
title('Methanol Reactor, left axis blue = P/Pin, green = T/Tin, right axis red = % methanol')
xlabel('distance down reactor (m)')
axis(AX(1),[0 8 0 1.4])
axis(AX(2),[0 8 0 14])
set(AX(1),'ytick',[0; 0.2; 0.4; 0.6; 0.8; 1.0; 1.2])
set(AX(2),'ytick',[0; 2; 4; 6; 8; 10])
set(get(AX(1),'ylabel'),'string','P / Pin or T / Tin')
set(get(AX(2),'ylabel'),'string','% methanol')
% from separate experiments to get equilibrium T & xMeOH at Pout = 66.7 bar
Teq = [569.9; 566.68; 563.63; 559.17; 556.2; 553.3; 545.21; 538.96; 533.11];
xmeq = [0.0330; 0.0355; 0.0380; 0.0419; 0.0445; 0.0472; 0.0558; 0.0613; 0.0672];
figure
plot(T,100*xm,'b',Teq,100*xmeq,'g')
title('Methanol Reactor, blue = with cooling, green = equilibrium at 66.7 bar')
ylabel('% methanol')
xlabel('T (K)')
dydt(1,1)
dydt(2,1)
dydt(3,1)
dydt(4,1)
=
=
=
=
MeOHenergy(T,P,F,Bprop,r1,r2); % dT/dW
MeOHpress(T,P,F,Bprop,Fin); % dP/dW
r1; % de(1)/dt = dFmeoh/dW
r2; % de(2)/dt = dFco/dW
Vis(4)
Vis(5)
Vis(6)
Vis(7)
=
=
=
=
polyval(Viscoef(4,:),Thalf);
polyval(Viscoef(5,:),Thalf);
polyval(Viscoef(6,:),Thalf);
polyval(Viscoef(7,:),Thalf); % (micro-Pa s)
for i = 1:7
for j = 1:7
tNum = ( 1 + (Vis(i)/Vis(j))^0.5 * (MW(i)/MW(j))^0.25 )^2;
tDenom = ( 8*(1+MW(i)/MW(j)) )^0.5;
phi(i,j) = tNum/tDenom;
end
end
visc = 0;
for i = 1:7
tDenom(i) = 0;
for j = 1:7
tDenom(i) = tDenom(i) + x(j)*phi(i,j);
end
visc = visc + x(i) .* Vis(i) ./ tDenom(i);
end
% HOWEVER, gas viscosity increases with P at high P
% so later should include this
% for now just multiply by a factor to get agreement with
% Chen et al. (2011) plant data
% visc = visc*(1 + 0.01146*(P - 1.0133));
visc = visc*(1 + 0.013*(P - 1.0133));
pco2 = P*x(3);
pm = P*x(4); % m = methanol
pw = P*x(5); % w = H2O
% rate
A(1) =
B(1) =
A(2) =
B(2) =
A(3) =
B(3) =
A(4) =
B(4) =
A(5) =
B(5) =
% rate coefficients
k = A .* exp(B/R/T);
% equilibrium constants
% K1 for CO2 + 3H2 = CH3OH + H2O
log10K1 = 3066/T - 10.592;
K1 = 10^log10K1;
% K3 for CO + H2O = H2 + CO2
log10invK3 = -2073/T + 2.029;
invK3 = 10^log10invK3;
K3 = 1/invK3;
denom = (1+k(3))*pw/ph2 + k(1)*sqrt(ph2) + k(2)*pw;
% r(1,1) = de(1)/dW = rate of methanol formation, CO2 + 3H2 = CH3OH + H2O
r(1,1) = k(4)*pco2*ph2*(1 - pw*pm/ph2^3/pco2/K1)/denom^3; % mol/s/kg
% r(2,1) = de(2)/dW = rate of reverse water gas shift, CO2 + H2 = CO + H2O
r(2,1) = k(5)*pco2*(1 - K3*pw*pco/pco2/ph2)/denom; % mol/s/kg
FC = -dH2/Ftot/Cp*r2;
% K/kg
dTdW = FA + FB + FC;
% K/kg