CVD Numerical
CVD Numerical
CVD Numerical
REPORT 06-07
ISSN 1389-6520
Delft 2006
Copyright 2006 by Delft Institute of Applied Mathematics Delft, The Netherlands.
Abstract
In this study various numerical schemes for simulating 2D laminar reacting gas
flows, as typically found in Chemical Vapor Deposition (CVD) reactors, are proposed
and compared. These systems are generally modeled by means of many stiffly coupled
elementary gas phase reactions between a large number of reactants and intermediate
species. The purpose of this study is to develop robust and efficient solvers for
the stiff heat-reaction system, whereby the velocities are assumed to be given. For
non-stationary CVD simulation, an optimal combination in terms of efficiency and
robustness between time integration, nonlinear solvers and linear solvers has to be
found. Besides stability, which is important due to the stiffness of the problem,
the preservation of non-negativity of the species is crucial. It appears that this extra
condition on time integration methods is much more restrictive towards the time-step
than stability. For a set of suitable time integration methods necessary conditions are
represented. We conclude with a comparison of the workload between the selected
time integration methods. This comparison has been done for a 2D test problem.
The test problem does not represent a practical process, but represents only the
computational problems.
1 Introduction
Chemical Vapor Deposition (CVD) is a process that synthesizes a thin solid film from
the gaseous phase by a chemical reaction on a solid material. Applications of thin solid
films as, for instance, insulating and (semi) conducting layers, can be found in many
technological areas such as micro-electronics, optical devices and so on.
A CVD system is a chemical reactor, wherein the material to be deposited is injected
as a gas and which contains the substrates on which deposition takes place. The energy to
drive the chemical reaction is (usually) thermal energy. On the substrates surface reactions
will take place resulting in deposition of a thin film.
∗
Delft University of Technology, Delft Institute of Applied Mathematics, Mekelweg 4, 2628 CD Delft,
The Netherlands ([email protected], [email protected])
†
Delft University of Technology, Department of Multi Scale Physics, Prins Bernardlaan 6, 2628 BW
Delft, The Netherlands ([email protected])
1
In CVD literature, and also other reactive flow literature, one is usually looking for
the steady state solution of the so-called species equations (6). The species equations
describe the transport of mass due to advective and diffusive transport, and due to the
chemical reactions in the reactor. The usual procedure to find this steady state solution
is to perform a (damped/relaxed) Newton iteration with an (arbitrary) initial solution.
Hopefully, the Newton iteration then converges to the steady state. If this is not the case
one performs some (artificial) time stepping in order to find a better initial solution for
the next Newton iteration. In this paper we present suitable time integration methods for
stiff problems. Furthermore, we compare these integration methods by their performance,
in terms of efficiency.
In our research we are not looking for the steady state solution only, but we also want
to approximate the transient solution. Since the time scales of advection and diffusion
differ orders of magnitude from the time scales of the chemical reactions the system of
species equations becomes stiff. Thus, in order to integrate the species equations in time in
a stable manner, time integration methods have to be found that can handle stiff systems.
Besides the stability issue for time integration, also the preservation of non-negativity of
the species during time integration is important. It appears that this last condition on
time integration methods is much more restrictive towards the time step than stability.
In this report issues on stability of time integration methods are discussed, as well
as the positivity properties, see Section 3 and 4. The next step is to make a selection of
suitable time integration methods, which will be presented in Section 5. This report will be
concluded with numerical results, Section 6, obtained with the representative test problem
proposed in Section 2.
2
assumed to be laminar (low Reynolds number flow). Since no large velocity gradients
appear in CVD gas flows, viscous heating due to dissipation will be neglected. We also
neglect the effects of pressure variations in the energy equation.
The composition of the N component gas mixture is described in terms of the dimen-
sionless mass fractions ωi = ρρi , i = 1, . . . , N, having the property
N
X
ωi = 1. (2)
i=1
The transport of mass, momentum and heat are described respectively by the continuity
equation (3), the Navier-Stokes equations (4) and the transport equation for thermal energy
(5) expressed in terms of temperature T :
∂ρ
= −∇ · (ρv), (3)
∂t
∂(ρv) T
2
= −(∇ρv) · v + ∇ · µ ∇v + (∇v) − µ(∇ · v)I − ∇P + ρg, (4)
∂t 3
∂(ρT )
cp = −cp ∇ · (ρvT ) + ∇ · (λ∇T ) +
∂t !
N N
X DTi ∇fi X Hi
+∇ · RT + ∇ · ji
i=1
M i fi i=1
mi
N X
X K
− Hi νik Rkg , (5)
i=1 k=1
with ρ gas mixture density, v mass averaged velocity vector, µ the viscosity, I the unit
J W
tensor, g gravity acceleration,cp specific heat ( mol·K ), λ the thermal conductivity ( m·K )
and R the gas constant. Gas species i has a mole fraction fi , a molar mass mi , a thermal
diffusion coefficient DTi , a molar enthalpy Hi and a diffusive mass flux ji . The stoichiometric
coefficient of the ith species in the k th gas-phase reaction with net molar reaction rate Rkg
is νik .
We assume that in the gas-phase K reversible reactions take place. For the k th reaction
the net molar reaction rate is denoted as Rkg m mole
3 ·s . For an explicit description of the
net molar reaction rate, we refer to [9, 16]. The balance equation for the ith gas species,
i = 1, . . . , N, in terms of mass fractions and diffusive mass fluxes is then given as
K
∂(ρωi ) X
= −∇ · (ρvωi ) − ∇ · ji + mi νik Rkg , (6)
∂t k=1
where ji is the diffusive flux. This mass diffusion flux is decomposed into concentration
diffusion and thermal diffusion, e.g.,
ji = jC T
i + ji . (7)
3
The first type of diffusion, jC
i , occurs as a result of a concentration gradient in the system.
Thermal diffusion is the kind of diffusion resulting from a temperature gradient. For a
multicomponent gas mixture there are two approaches for the treatment of the ordinary
diffusion, namely the full Stefan-Maxwell equations and an alternative approximation de-
rived by Wilke. In this case, we have chosen for Wilke’s approach. Then, the species
concentration equations become
∂(ρωi )
= −∇ · (ρvωi ) + ∇ · (ρD′i ∇ωi ) + ∇ · (DTi ∇(ln T )) +
∂t
XK
+mi νik Rkg , (8)
k=1
where D′i is an effective diffusion coefficient for species i and DTi the multi-component
thermal diffusion coefficient for species i.
The main focus of our research is on efficient solvers for the above species equation(s)
(8). Typically the time scales of the slow and fast reaction terms differ orders of magnitude
from each other and from the time scales of the diffusion and advection terms, leading to
extremely stiff systems.
For the moment we only focus on the development of efficient solvers for species equa-
tions. Therefore, we will omit the surface reactions in our system, because these boundary
conditions will need some extra attention. Another simplification is that we assume that
both the velocity field, temperature field, pressure field and density field are given. To be
more precise, they are computed via another simulation package which was developed by
Kleijn [10]. Furthermore, we omit thermal diffusion.
4
inflow
T=300 K f_{SiH4}= 0.001 f_{He}= 0.999 v= 0.10 m/s
0.10 m
dT/dr = 0 solid
v=0 wall
u=0
z
θ
T=1000 K u, v = 0 susceptor
dT/dz = 0 outflow
dv/dz = 0 0.15 m
0.175 m
5
At a distance of 10 cm. below the inlet a susceptor with temperature T = 1000 K and a
diameter 30 cm. is placed. As mentioned before, on this surface no reactions (will) take
place. Unlike the problem considered in [10] the susceptor does not rotate.
6
Reaction Ak βk Ek
G1 1.09 · 1025 −3.37 256000
G2 3.24 · 1029 −4.24 243000
G3 7.94 · 1015 0.00 236000
G4 1.81 · 108 0.00 0
G5 1.81 · 108 0.00 0
7
Besides the chemical model of the reacting gases, also some other properties of the gas
mixture are needed. As mentioned before, the inlet temperature of the mixture is 300 K,
and the temperature at the susceptor is 1000 K. The pressure in the reactor is 1 atm.,
which is equal to 1.013 · 105 Pa. Other properties are given in Table 3. The diffusion
coefficients, according to Fick’s Law, are given in Table 4.
300
Density ρ(T ) 1.637 · 10−1 · T
[kg/m3 ]
Specific heat cp 5.163 · 103 [J/kg/K]
T
0.7
Viscosity µ 1.990 · 10−5 300
[kg/m/s]
T
0.8
Thermal conductivity λ 1.547 · 10−1 300
[W/m/K]
T 1.7
4.77 · 10−6
SiH4 300
T 1.7
5.38 · 10−6
SiH2 300
T 1.7
3.94 · 10−6
H2 SiSiH2 300
T 1.7
3.72 · 10−6
Si2 H6 300
T 1.7
3.05 · 10−6
Si3 H8 300
T 1.7
8.02 · 10−6
H2 300
8
where w(t) = (wj (t))m m
j=1 ∈ R , with m proportional to the number of grid points in spatial
direction. The next step is to integrate the ODE system (13) with an appropriate time
integration method.
We remark that the stiff reaction terms in CVD motivates to integrate parts of F (t, w(t))
implicitly. In general, due to the nonlinearities in the reaction term, (huge) nonlinear
systems have to be solved. Most nonlinear solvers will need solutions of linear systems.
In order to approximate the solution of a system of species equations, choices have to
be made with respect to
1. Spatial Discretization,
2. Time Integration,
4. Linear Solver.
The topic of this research is to find the best combination in terms of efficiency. Of course,
efficiency becomes a hot topic in the case of transient 3D simulations, where the simulation
times become huge. In the case of 2D simulations the simulation times are, with the
nowadays PCs,s, acceptable. Note that if the computational cost of one time step is (very)
expensive, then a time integration method that needs more, but computational cheaper,
time steps is better in terms of efficiency.
Besides the efficiency criteria, also some other properties are desired, for example posi-
tivity, see Section 3.2. In order to make choices for spatial discretization, time integration,
nonlinear and linear solvers, we formulate criteria in order of importance.
3.1 Stability
As already mentioned in Section 2 the system of species equations is stiff. First we pay
some attention to this notion.
While the intuitive meaning of stiff is clear to all specialists, much controversy is going
on about it’s correct ‘mathematical definition’. We cite Hundsdorfer & Verwer [7] :
9
3.2 Positivity
An important property of chemical systems is positivity. By positivity we mean preser-
vation of non-negativity for all components, which is a natural property for chemical species
concentrations. As a consequence, it should also hold for the mathematical model of the
process. Whenever numerical simulations of reactive flows will be done, the positivity
property has to be fulfilled on four levels, i.e.
1. Mathematical Model,
2. Spatial Discretization,
3.3 Efficiency
Having stiff reaction terms in the species equations implies doing parts of the time
integration implicitly. As remarked before, choosing the ‘best’ time integration method in
terms of number of time steps, does not imply that this is the most efficient way to solve
the system of (N − 1) species equations.
Nonlinear Solvers
Integrating nonlinear ODEs implicitly gives rise to nonlinear equations F (x) = 0, x ∈
n
R . In order to solve these equations one has a limited choice of methods. Roughly
speaking, we have the following methods :
1. (Pseudo) Newton Iteration,
10
2. Fixed Point Iteration, and
3. Broyden’s Method.
To solve n dimensional systems F (x) = 0, with F : Rn → Rn and x ∈ Rn , the Newton
iteration is defined as
xk+1 = xk − F ′ (xk )−1 F (xk ). (14)
Importance of the above method rests on the fact that in a neighborhood of x the error
kxk+1 − xk (remark that x is a solution of F (x) = 0) can be estimated by the inequality
Inequality (15) yields for a c ∈ R and a certain norm defined on Rn . The above inequality
states that the (k + 1)th error is proportional to the k th error squared.
Difficulties with the Newton iteration are that in each step a linear system has to be
solved. In practical applications where the dimensions of the linear systems can be up to
one million, or even larger, an appropriate solver has to be found. It appears that the
computational costs of one time step depends mainly on the linear solver as well as the
evaluation of F (x) and F ′ (x). Another difficulty is that convergence of the iteration is
assured in a neighborhood of the solution. To get global convergence one can extend the
Newton algorithm with, for example, line-search. Adding the line-search will guarantee
that the succeeding iterates are norm reducing in the sense that
for some norm defined on Rn . More on the topic of global convergence can be found in
[8, 16].
The fixed point iteration has the advantage that it converges globally, as long as the
spectral radius of the Jacobian of F (x) is less than one. A disadvantage is that we have
only first order convergence. This method is only attractive when the function evaluations
are cheap.
Finally, the Broyden method is an extension of the secant method to n dimensions. In
order to solve the scalar equation f (x) = 0 the secant method is given as
where xk is the current iteration and xk−1 the iteration before. As can be found in [16],
the secant method converges with order equal to the golden ratio. Broyden’s method is
useful in the case that the Jacobian is not explicitly available, or computable.
Linear Solvers
As mentioned above, the computational costs of one time step depends mainly on the
computational costs of solving linear systems that appear in the nonlinear solver. Iterative
11
linear solvers will come into play for three dimensional systems. In the case that two
dimensional systems are considered, one can suffice with direct solvers. Via reordering of
the unknowns and the discrete species equations, one can obtain band matrices with a
‘small’ bandwidth, such that the LU-factorization is still attractive.
Application of an one-step method, like for example Euler Forward or Runge-Kutta method,
gives approximations
wn+1 = R(τ λ)wn . (19)
The function R(z) (z = τ λ) is called the stability function of the method. The set
12
π
Definition 4.3. A method is called A(α)-stable (for α < 2
) if the stability region S =
{z ∈ C : |R(z)| ≤ 1} is a subset of
S ⊃ {z ∈ C− : z = 0, ∞ or |arg(−z)| ≤ α} (21)
From the above definition we see that A(α)-stability is a weaker form of stability than
A-stability. For certain values of α, also these methods are interesting for time integration
of species equations.
Example 4.1. The BDF methods, see Section 5.1, are for k = 1, 2 A-stable. For 3 ≤ k ≤ 6
the BDF methods is A(α)-stable, with α depending on k. See Table 5.
k 1 2 3 4 5 6
π π
α in rad 2 2
1.501 1.2741 0.8901 0.2967
α in degrees 90◦ 90◦ 86◦ 73◦ 51◦ 17◦
2 2
1 1
0 0
−1 −1
−2 −2
−3 −3
−4 −3 −2 −1 0 1 2 −4 −3 −2 −1 0 1 2
Figure 2: Stability regions of the BDF-2 method (left) and the BDF-3 method (right).
In Figure 2 the stability regions for the BDF-2 method and the BDF-3 method2 are
given. Notice that the BDF-3 method is indeed not A-stable, as can be seen in Figure 2.
IMEX
Instead of using a fully implicit time integration, one can also integrate only the ex-
tremely stiff part in an implicit way. Suppose we have the nonlinear system or semi-
discretization
w ′ (t) = F (t, w(t)),
2
BDF methods are extensively described in, for example, [7, 5, 16]
13
where F (t, w(t)) has the natural splitting
where the parameter θ ≥ 12 . This method is a combination of the Euler Forward method,
which is explicit, and the implicit θ -method. Methods that are mixtures of IM plicit and
EX plicit methods are called IMEX methods. The method given in (22) is called the IMEX-
θ Method.
Consider the test equation
and let zj = τ λj for j = 0, 1. Applying the IMEX- θ method to this test equation gives
1 + z0 + (1 − θ)z1
R(z0 , z1 ) = . (23)
1 − θz1
Stability of the IMEX- θ method thus requires
|R(z0 , z1 )| ≤ 1. (24)
2. Assume the explicit part of the method to be stable and investigate the stability region
of the implicit part.
Starting with the first point, we assume the implicit part of the IMEX- θ method to be
A-stable. Define the set
14
3. For a detailed derivation of this boundary, we refer to [16]. A similar way of reasoning
can be done to derive the boundary of D1 , whereby
and S0 the stability region of Euler Forward. The boundary of D1 is also given in Figure
3.
We remark that for θ = 1 the IMEX method has favorable stability properties. It could
be seen as a form of time splitting where we first solve the explicit part with Euler Forward
and the implicit part with Euler Backward. However, using this IMEX method we do not
have errors as consequence of
If one uses this IMEX- θ method with θ = 12 , then one has to pay a little more attention
to stability. If, for instance, one has a system with complex eigenvalues, then the IMEX
method will not be unconditionally stable for θ = 12 .
The general idea of IMEX methods has been explained. We conclude with the remark
that IMEX extensions can also be applied to multi-step methods, Runge-Kutta methods
and so on. The IMEX - θ method is the simplest example of an IMEX-Runge-Kutta
method.
1.5
1.5
1
1
0.5
0.5
0
0
−0.5
−0.5
−1
−1
−1.5
−1.5
−3 −2.5 −2 −1.5 −1 −0.5 0 0.5 1 −3 −2.5 −2 −1.5 −1 −0.5 0 0.5 1
Figure 3: Boundary of regions D0 (left) and D1 (right) for θ = 0.5 (circles), 0.51 (-·-), 0.6 (- -) and 1 (solid)
4.2 Positivity
Definition 4.4. An ODE system
15
It is easy to prove, for instance by using Theorem 4.5, which is given below, that linear
systems
w ′ (t) = Aw(t), w(t) ∈ Rn , A ∈ Rn×n , A = (aij ), (28)
are positive if and only if aij ≥ 0 for i 6= j. The next theorem provides a simple criterion
on F (t, w(t)) to tell us whether the system
is positive.
Theorem 4.5. Suppose that F (t, w) is continuous and satisfies a Lipschitz condition with
respect to w 3 . Then the system (29) is positive if and only if for any vector w ∈ Rm and
all i = 1, . . . , m and t ≥ 0,
w ≥ 0, wi = 0 =⇒ Fi (t, w) ≥ 0. (30)
whereby a(x, t) is the space and time dependent advection coefficient, and d(x, t) the space
and time dependent diffusion coefficient. Furthermore, d(x, t) > 0 and spatial periodic
boundary conditions are assumed.
Discretizing (31) by means of central differences gives
1
wj′ = aj− 1 (wj−1 + wj ) − aj+ 1 (wj + wj+1 ) +
2h 2 2
1
d 1 (wj−1 − wj ) − dj+ 1 (wj − wj+1 ) , (32)
h2 j− 2 2
Using Theorem 4.5 it follows, after an elementary calculation, that the central discretization
(32) is positive if and only if the cell Péclet numbers, defined as ah/d, satisfy
|a(x, t)|h
max ≤ 2. (34)
x,t d(x, t)
3
The condition
kF (t, ṽ) − F (t, v)k ≤ Lkṽ − vk,
m m m
with ṽ, v ∈ R and F : R × R → R , is called a Lipschitz condition with Lipschitz constant L.
16
Discretizing (31) by means of first order upwind for the advection part, and second order
central differences for the diffusive part, gives
1 +
wj′ = aj− 1 wj−1 + (a+ 1 − a
j− 2
−
1 )wj + a
j− 2
−
1 wj+1 )
j− 2
h 2
1
d 1 (wj−1 − wj ) − d 1 (wj − wj+1 ) , (35)
h2 j− 2 j− 2
where a+ = max(a, 0) and a− = min(a, 0). Hence, the semi-discrete system (35) is uncon-
ditionally positive.
where p(t, v) is a vector and L(t, v) a diagonal matrix. It can be found in [7] that source
terms in this form are positive as long as p(t, v) is positive.
Furthermore, we mention that the above results with respect to the one-dimensional
advection-diffusion equation are easily generalized to higher dimensions. Therefore, dis-
cretizing the species concentrations equations in space by means of a hybrid scheme4 ensures
positivity of the semi-discretization.
A last remark with respect to upwind discretization. For higher order upwinding, for
example third order upwinding, positivity is not ensured for all step-sizes.
Condition 4.6. There is an α > 0, with α as large as possible, such that ατ ≤ 1 and
17
Application of Euler Forward to the nonlinear system w ′(t) = F (t, w(t)) gives
Provided that wn ≥ 0, Condition 4.6 guarantees positivity for wn+1 computed via Euler
Forward (38).
Furthermore, assume that F (t, w(t)) also satisfies the following condition :
According to the following theorem we have unconditional positivity for Euler Back-
ward.
Theorem 4.8. Conditions 4.6 and 4.7 imply positivity for Euler Backward for any step
size τ .
Remark 4.9. Unlike Condition 4.6, Condition 4.7 is not easy to be verified. As remarked
in [7], it is sufficient to hold that F (t, v) is continuously differentiable and
whereby C is a positive constant and JF (t, v) the Jacobian of F (t, v) with respect to v.
Existence and uniqueness of the solution of
then follows from Hadamard’s Theorem and the Implicit Function Theorem. The fact that
the solution u of (42) depends continuously of τ , v and t also follows from the Implicit
Function Theorem. Remark that condition (41) is easier to verify than Condition 4.7.
Both Hadamard’s Theorem and the Implicit Function Theorem can be found, for example,
in [11].
18
Remark 4.10. Application of Euler Backward to the nonlinear system w ′ (t) = F (t, w(t))
gives
wn+1 − τ F (tn , wn+1 ) = wn . (43)
As proven in Theorem 4.8, for every time step τ positivity of wn+1 is ensured as long as
wn is positive and F (t, w) satisfies conditions (4.6) and (4.7). In practice it is impossible
to compute the solution wn+1 of the nonlinear equation (43) exactly, thus one will use an
iterative nonlinear solver. For example, the Newton Raphson iteration is in most applica-
tions a good choice. Since iterative nonlinear solvers will only give an approximation of
the solution, it might be possible that it contains (small) negative components. Therefore,
in practice even Euler Backward can produce negative concentrations.
As mentioned before, negative components of the concentration solution vector can
cause a blow up in finite time. In the case the negative components of the solution are
the result of rounding errors, then it is justified to set them to zero. We remark that in
the case of rounding errors the negative components are very small (compared with the
relative error, condition number and the machine precision). In the case one has negative
components in the solution as consequence of the nonlinear (Newton) solver, then the most
common method to avoid negative concentrations is clipping. A disadvantage of applying
clipping is that mass is added, i.e., the integration method does not preserve mass any
longer. A possible solution is given in [12], where for the positive integration of chemical
kinetic systems a projection method is proposed. This projection method works as follows.
First, a numerical approximation is computed via a traditional (read Runge Kutta or
Rosenbrock method) scheme, which preserves mass. If there are negative components in
the solution, then the nearest vector in the reaction simplex is found using a primal-dual
optimization routine. The resulting vector, is a better approximation of the true solution
and preserves mass. In the case of advection-diffusion-reaction systems, no references are
available to do this.
19
4.3 Relation Positivity and TVD
If the system of ODEs w ′ (t) = F (t, w(t)), with a appropriate initial condition w(0) =
w0 , stands for a semi-discrete version of a conservation law, it is important that the fully
discrete process is monotonic in the sense that
The above monotonicity property reduces to the Total Variation Diminishing (TVD) prop-
erty when we use the seminorm
n
X
|y|T V = |yj − yj−1|, with y0 = yn , for y ∈ Rn , (45)
j=1
in (44). When a numerical scheme satisfies this TVD property, then localized over- and
undershoots are prevented.
The TVD property is developed for studying the properties of numerical schemes for
solving hyperbolic conservation laws. In particular TVD and monoticity are important in
the study of shocks in fluid flows.
In this section we will discuss some general results for TVD. It turns out that the
conditions giving the TVD property are the same as giving the positivity property.
Then, the above condition can be seen as a condition on the time step τ such that Euler
Forward is TVD.
We remark that this condition is equivalent with the condition for positivity for Euler
Forward (4.6). This can be seen as follows. Considering a positive nonlinear system
w ′ (t) = F (t, w(t)), we have to find an α such that (4.6) holds. Taking
1
α= , (47)
τ∗
and considering v ≥ 0, then (46) implies v + τ F (t, v) ≥ 0.
Applying the Backward Euler method to w ′ (t) = F (t, w(t)) gives
This method is TVD under Assumption (46) without any step size restriction. This can
easily be seen from
τ τ
1 + ∗ wn+1 = wn + ∗ (wn+1 + τ ∗ F (tn+1 , wn+1 ).) (49)
τ τ
20
Using the TV seminorm we obtain
τ τ
1 + ∗ |wn+1|T V ≤ |wn |T V + ∗ |wn+1 |T V , (50)
τ τ
showing that |wn+1 |T V ≤ |wn |T V for any τ > 0.
For other one-step methods like Diagonally Implicit Runge Kutta methods step size
restrictions can be derived to have the TVD property. These conditions are identical to
those for positivity of DIRK methods. For TVD results for multistep, or other general
results for TVD we refer to [3, 7, 20]. In [3] the rather disappointing result concerning
the nonexistence of implicit TVD Runge Kutta or multistep methods of order higher than
1 has been proven. By adding some explicit stages to an explicit higher order RK or
multistep scheme the TVD property can be recovered. In our case of stiff systems, this
last artifact to save the TVD property is useless, because then the stiff reaction parts have
to be integrated explicitly.
To conclude this section we would like to remark the following. With respect to positiv-
ity and TVD, implicitness of the method seems to have little added value, in clear contrast
with stability. For example, the implicit trapezoidal rule
τ
wn+1 = wn + (F (tn , wn ) + F (tn+1 , wn+1 )) , (51)
2
has a time step restriction in order to be TVD, when applied to time integration of ut +
a · ux = 0, whereby the advection term is discretized using limiters. Then, as can be found
in [7, 20], the TVD property holds if the Courant number ν = τ a/h ≤ 1. Comparing this
with the Euler Backward method, which is unconditionally TVD, we see that implicitness
has little added value in this case.
• Explicit,
• Implicit,
• Stiff,
• Positivity,
• TVD,
21
• IMEX.
A time integration method that would be suitable to integrate the species equations needs
to have a few of the above mentioned properties. Combinations of the properties that are
possible are :
1. Positivity, Implicit, At Most First order Accurate and Stiff,
2. TVD, Implicit, At Most First order Accurate and Stiff,
3. IMEX, Higher Order Integration Methods, Positivity or TVD, Stiff,
4. Explicit, Higher Order Integration Methods, TVD,
5. Implicit, TVD, Higher Order Integration Methods, Adding explicit stages.
The last two combinations of properties, i.e., 4. and 5., are not suitable for solving the stiff
species equations, because they contain explicit stages. Integrating the reactions terms
explicitly will give a strong restriction on the time step. The latter is not preferred in
practice.
Rosenbrock Methods
Definition 5.1. An s-stage Rosenbrock method is defined as
i−1
X i
X
ki = τ F (wn + αij kj ) + τ A γij kj ,
j=1 j=1
s
X
wn+1 = wn + bi ki (52)
i=1
22
where A = An is the Jacobian F ′ (w(t)).
Definition 5.1 is taken from [7]. The coefficients bij , αij and γij define a particular
method and are selected to obtain a desired level of consistency and stability.
Remark that computing an approximation wn+1 from wn , in each stage i a linear system
of algebraic equations with the matrix (I − γii τ A) has to be solved. To save computing
time for large dimension systems w ′ (t) = F (w(t)) the coefficients γii are taken constant,
e.g., γii = γ. Then, in every time-step the matrix (I − γii A) is the same. To solve these
large systems LU decomposition or (preconditioned) iterative methods could be used.
Define
i−1
X i−1
X
βij = αij + γij , ci = αij and di = βij .
j=1 j=1
In Table 5.1, taken from [7], the order conditions for s ≤ 4 and p ≤ 3 and γii = γ =
constant can be found. In particular the two stage method
wn+1 = wn + b1 k1 + b2 k2
k1 = τ F (wn ) + γτ Ak1
k2 = τ F (wn + α21 k1 ) + γ21 τ Ak1 + γτ Ak2 , (53)
with coefficients
1 γ
b1 = 1 − b2 , α21 = and γ21 = − ,
2b2 b2
is interesting. This method is of order two for arbitrary γ as long as b2 6= 0 . The stability
function is given as
1 + (1 − 2γ)z + (γ 2 − 2γ + 21 )z 2
R(z) = . (54)
(1 − γz)2
√
The method is A-stable for γ ≥ 41 and L-stable if γ = 1 ± 21 2. By selecting for γ the
√
larger value γ+ = 1 + 12 2, we have the property that R(z) ≥ 0, for all negative real z.
For diffusion-reaction problems, which have negative real eigenvalues, this property ensures
positivity of the solution. In the case that advection is added to the system, the matrix
has eigenvalues with negative real parts and relatively small imaginary parts. Then, the
23
positivity property is no longer guaranteed. It appears that the second order Rosenbrock
method performs quite well with respect to the positivity property, as has been experienced
in [17]. In [17] it is conjectured that the property that R(z) ≥ 0 for all negative real
z plays a role. We conclude this section with a remark on the implementation of the
second order Rosenbrock √ scheme (56). In our code it is implemented with the parameters
1 1
b1 = b2 = 2 and γ = 1 + 2 2. The matrix-vector multiplication in the second stage of (56)
can be avoided by introducing
which uses the k past values wn , . . . , wn+k−1 to compute wn+k . Remark that the most
advanced level is tn+k instead of tn+1 .
The method is explicit when βk = 0 and implicit otherwise. Furthermore, we will
assume that αk > 0.
The BDF are implicit and defined as
βk 6= 0 and βj = 0 for j = 0, . . . , k − 1.
The coefficients αi , see Definition 5.2, are chosen such that the order is optimal, namely
k. 5 The 1-step BDF method is Backward Euler. The 2-step method is
3 1
wn+2 − 2wn+1 + wn = τ F (tn+2 , wn+2), (58)
2 2
5
A linear k-step method is of order p if and only if
k
X k
X k
X
αi = 0 αi ij = 0 = j βi ij−1 for j = 1, 2, . . . , p.
i=0 i=0 i=0
24
and the three step BDF is given by
11 3 1
wn+3 − 3wn+2 + wn+1 − wn = τ F (tn+3 , wn+3). (59)
6 2 3
In chemistry applications the BDF methods belong to the most widely used methods to
solve stiff chemical reaction equations, due to their favorable stability properties. The
BDF-1 and BDF-2 methods are both A-stable. The 3,4,5 and 6 step BDF methods are
A(α)-stable, with α given in Example 4.1. For k > 6 the BDF-methods are unstable, see
[4, Theorem 3.4, page 329].
Remark 5.3. A disadvantage of linear multi-step methods is that the first k − 1 approx-
imations cannot be computed with the linear k-step scheme. To compute the first (k − 1)
approximations, one could use a
2. use for the first step a linear 1-step method, for the second approximation a linear
2-step method, . . . and for the (k − 1)st approximation a linear (k − 1)-step scheme.
As for Runge-Kutta methods the requirement of positivity does place a severe step size
restriction on (implicit) BDF methods (and also on implicit multistep methods). Under
Condition 4.6 and 4.7 we obtain positivity of w ′ (t) = F (t, w(t)) whenever ατ ≤ γR . The
parameter γR is the largest γ such that the stability function R(z) is absolutely monotonic
on [−γ, 0]. It is easy to check that for the BDF-2 method we have γR = 12 . Thus, positivity
for BDF-2 is ensured whenever
1
ατ ≤ , (60)
2
provided that w1 is computed from w0 by a suitable starting procedure. By suitable we
mean that w1 has to be computed from a method that ensures w1 to be positive, such
as for example BDF-1 (which is Euler Backward). Implementation of the methods is
straightforward.
Definition 5.4. The stability boundary β(s) is the number β(s) such that [−β(s), 0] is the
largest segment of the negative real axis contained in the stability region
S = {z ∈ C : |R(z)| ≤ 1} .
25
To construct the family of RKC methods we start with the explicit Runge-Kutta meth-
ods which have the stability polynomial
R(z) = γ0 + γ1 z + · · · + γs z s . (61)
wn0 = wn ,
wn1 = wn + µ̃1 τ F (tn + c0 τ, wn0 ),
wnj = (1 − µj − νj )wn + µj wn,j−1 + νj wn,j−2 + j = 1, . . . , s
+µ̃1 τ F (tn + cj−1 τ, wn,j−1) + γ̃j τ F (tn + c0 τ, wn0 ), (63)
wn+1 = wns ,
with coefficients
ε Ts′ (ω0 )
ω0 = 1 + , ω1 = , (64)
s2 Ts′′ (ω0 )
Tj′′ (ω0 ) Ts′ (ω0 ) Tj′′ (ω0 ) j2 − 1
bj = ′ , cj = ′′ ≈ 2 , (65)
(Tj (ω0 ))2 Ts (ω0 ) Tj′ (ω0 ) s −1
2bj ω0 bj
µ̃1 = b1 ω1 , µj = , νj = − , (66)
bj−1 bj−2
2bj ω1
µ̃j = , γ̃j = −aj−1 µ̃j . (67)
bj−1
The stability function of this method is given as
Ts′′ (ω0 )
Bs (z) = 1 + (Ts (ω0 + ω1 z) − Ts (ω0 )) (68)
(Ts′ (ω0 ))2
with
ε Ts′ (ω0 )
ω0 = 1 + ω1 = .
s2 Ts′′ (ω0 )
6
This can be verified by considering the test equation y ′ = λy. The local error of the test equation
satisfies
ez − R(z)
= O(τ p ). (62)
τ
To achieve pth order consistency the coefficients γi has to be chosen in such a way that (62) satisfies for p.
26
The parameter ε is a damping parameter to create a wider stability region. Compare in
Figure 4 the undamped and damped case. For practical applications one would always use
the damped stability function. The stability boundary is in the damped case equal to
2 2
β(s) = (s2 − 1)(1 − ε),
3 15
which is about 80% of the optimal value.
Second Order Chebyshev Polynomial
5
−5
−20 −18 −16 −14 −12 −10 −8 −6 −4 −2 0 2
Second Order Damped Chebyshev Polynomial
5
−5
−20 −18 −16 −14 −12 −10 −8 −6 −4 −2 0 2
Figure 4: Stability region of B5 (z) without damping (upper) and with damping (lower).
The IMEX extension of the above scheme is as follows. Suppose we have an ODE
system w ′(t) = F (t, w(t)), where F (t, w(t)) can be split as
In Eqn. (69) the term FI (t, w(t)) is the part of F which is (supposed to be) too stiff to be
integrated by an explicit Runge-Kutta Chebyshev method. Obviously, the term FE (t, w(t))
is the moderate stiff part of F that can be integrated in an explicit manner using RKC
methods.
The first stage of (63) becomes in the IMEX-RKC scheme
with µ̃1 as defined before. Note that the highly stiff part of F is treated implicitly. The
other (s − 1) subsequent stages of (63) will be modified in a similar way.
With respect to stability of this IMEX extension of (63) we remark the following. The
implicit part is unconditionally stable, whereas the stability condition for the explicit part
remains unchanged. Another pleasant property is that steady states are returned exactly.
It takes an elementary calculation to prove this. Note that with operator splitting, or in
this case time splitting, where the subsystems w ′(t) = FE (t, w(t)) and w ′ (t) = FI (t, w(t))
are integrated completely decoupled within the time-steps, steady states are not returned
exactly.
27
We conclude with some remarks on the implementation and use of the IMEX-RKC
schemes in practice. We use a variable time step controller as is normal for Method of
Lines solvers. Then, it would be desirable that for relatively small τn the code automatically
switches to a lower number of stages s. For relatively large τn the same is desired, of course.
This is only important for the integration of advection diffusion part of the right hand side
of (13).
We will briefly describe the idea behind this variable number of stages procedure,
which is taken from [19]. In [20] time step size conditions are given for the standard spatial
discretizations of the m-dimensional scalar model
m
X m
X
ut + ak uxk = d u xk xk , (71)
k=1 k=1
guaranteeing eigenvalues emerging from von Neumann stability analysis to lie inside geo-
metric figures like squares, ellipses, half ellipses and ovals. For the explicit integration of
advection and diffusion via the RKC method one has to fit an appropriate figure inside the
stability region S. In [19] ovals are selected. In Figure 12 stability regions with inscribed
ovals 2
x y 4
+1 + = 1, (72)
β/2 α
for s = 6 and ε = 0.1, 1, 10. Recall that epsilon is a damping factor, see (64). For β the
value β(s) has been taken, while α has been derived numerically. Assume that for diffusion
0 0
−5 −5
−25 −20 −15 −10 −5 0 −20 −15 −10 −5 0
(a) (b)
s = 6, ε = 10, α = 3.63, β = 14.116
5
−5
−14 −12 −10 −8 −6 −4 −2 0 2
(c)
28
second order central discretization, while for advection the κ-scheme
dw a
= ((1 − κ)wj−2 + (3κ − 5)wj−1 + (3 − 3κ)wj + (1 + κ)wj+1 ), (73)
dt 4h
is used. The κ-scheme is the second order central scheme for κ = 1, the second order
upwind scheme for κ = −1 and third order upwind-biased scheme for κ = 31 . The diffusion
step size condition is then the familiar condition
β(s)
τ≤ Pm −2 , (74)
2d k=1 hk (2 + (1 − κ)Pk )
where Pk = |akd|hk is a mesh Péclet number. Violation of (74) will give instability. Also
taken from [20] is the advection time step restriction
13 X m 4 31
4dα4 (s)
ak
τ ≤ q1 / 2
, (75)
β(s) k=1
hk
where the parameter q1 depends on the choice of κ, see Table 5.1. For the actual imple-
κ q1
1
3
0.635
1 1
−1 0.323
Table 7: Values for q1 for popular κ values
α4 (s)
mentation the following lower bound for the ratio β(s)
has been used
2
s = 2,
α4 (s) 4(6 − s) + 6.15(s − 4) s = 4, 6,
= (76)
β(s)
6.15 (10−s)
2
+ 15.5 (s−6)
4
s = 8,
15.5 s = 10, 12, . . .
4
As maximum of the ratio αβ(s) (s)
the value 15.5 has been taken, which corresponds with
s = 10. For larger values of s the slope in the curve, by which we mean the upper half of
the oval (72), becomes too small.
Next, we will describe how to choose the number of stages s. Suppose a step size τ ∗
has been obtained by a local error estimator. Then, it can be checked whether τ ∗ satisfies
the inequalities (74) and (75). If necessary, τ ∗ can be adjusted such that these inequalities
hold. Simultaneously, the number of stages can be adjusted such that the number of stages
needed to satisfy (74) is larger or equal than the number of stages needed to satisfy (75).
29
We remark that it makes no sense to spend more stages on advection than required for
diffusion. Introduce the parameters
1 4dq13
Ψ1 = Pm −2 , and, Ψ2 = . (77)
2d k=1 hk (2 + (1 − κ)Pk ) Pm a4k 31 3
k=1 h2k
The actual algorithm that is used in the code is given in Algorithm 1. For more background
and let the Newton-step be s = 2−m d. Condition (78) is called the sufficient decrease of
kF k. The parameter ̟ in (78) is a small number, chosen such that the sufficient decrease
condition is satisfied as easy as possible. In [8, 16] ̟ is taken equal to 10−4 .
2D Problems
In most 2D applications direct solvers like LU factorization are still applicable to solve
linear systems. To reduce the amount of work one usually reorders the unknowns (and the
30
equations), in order to reduce the bandwidth of the matrix. Also in our case it is possible
to reduce the bandwidth of the Jacobian considerably.
Using a finite volume discretization of the right hand side of (6), where the unknowns
are arranged per species and lexicographic in the grid, we get a Jacobian matrix with
a structure as in Figure 6. We change the arrangement of unknowns into: unknown
0
50
100
150
200
250
300
350
400
450
Figure 6: Jacobian matrix belonging to the test-problem, where 6 chemical species are considered. Num-
ber of grid-points in r direction is 10 and in z direction 8. This Jacobian matrix is with lexicographic
arrangement per species. We see that the upper and lower bandwidth are both (N − 1) · G, where N is
the number of species and G the number of grid points.
3D Problems
For 3D problems direct solvers like the LU factorization are no longer applicable. To
approximate the solution linear systems one has roughly speaking two options, e.g. Krylov
subspace methods and multigrid, or a combination.. For this application, simulating re-
acting gas flow simulations, the latter choice is the more obvious one.
In the 2D case with a gas phase chemistry model with a large number of species the
complexity of solving resulting linear systems will become equal to the complexity of solving
linear systems of 3D discrete systems. In that case iterative linear solvers will become more
and more attractive.
31
0
50
100
150
200
250
300
350
400
450
Figure 7: Jacobian matrix belonging to the test-problem, where 6 chemical species are considered. We
have the same number of grid-points in r and z direction. This Jacobian matrix is constructed with the
re-arrangement of the unknowns as described in Section 5.3. In this re-arranged case the bandwidth is
equal to N · Gr , where Gr is the number of grid points in the r direction.
6 Numerical Simulation
Before giving the results of the numerical simulations, where we mainly considered the
efficiency of the time integration methods, we give details on the simulation itself. In
this simulation a variable time step algorithm is used, which will also be explained in this
section.
kyn+1 − yn k2
≤ ϑ, (79)
kyn k2
32
In order to describe the algorithm that is used for CVD simulation we introduce the
function ‘time integration’ as follows. As input we have yn , the approximated solution of
w on time t = tn , τ = tn+1 − tn , m the molar mass field and f the vector of molar fractions.
The output is yn+1 , i.e., the approximated solution of w on time tn+1 . Summarized
The exact description of the function ‘time integration’ depends on the choice of time
integration method. See Section 5.
Based on the inlet concentrations of silane SiH4 an initial mass fraction profile can
be constructed. The outline of the algorithm to perform the CVD simulation is given as
Algorithm 2. As mentioned earlier, for ϑ the value ϑ = 10−6 has been taken.
Algorithm 2 Simulation
1: Initial values for y0 and fi
ky1 −y0 k
2: while ky ≥ ϑ do
0k
3: Compute average molar mass of gas mixture m
4: y1 = time integration(y0 , τ, m, f )
5: Check whether y1 ≥ 0, if not then τ = 21 τ and go to 4
6: Estimate the local (time integration) error Dn
7: if Dn > T ol then
8: τ = r · τ , r estimated such that Dn ≤ T ol, and go to 4
9: end if
10: Compute mole fractions f
11: y0 = y1
12: end while
It is also possible to put bounds on the growth factor r of the new step size. This is simply
done by giving bounds on r.
33
6.2.1 Local Error Estimation for Euler Backward
The local error of the Euler Backward method
satisfies
1
δn = − τ 2 w ′′ (tn ) + O(τ 3 ). (84)
2
The local truncation error δn can be estimated as
1
dn = − (wn+1 − wn − τ F (tn , wn )) . (85)
2
See, for example, [7].
34
6.3 Numerical Results for the Simplified CVD System
In this part we present the numerical results of the simplified test problem as defined
in Section 2.1 to 2.3. In this section we distinguish two different simulations, namely, the
simulation with physical initial conditions, see Section 6.3.1, and the simulation with a
constant initial profile, see Section 6.3.2.
The experiments are done in FORTRAN. The computations are done on a serial Pen-
tium 4 (2.8 GHz) computer with 1Gb memory capacity. Moreover, the code is compiled
with FORTRAN g77 on LINUX.
kun+1 − un k2
≤ 10−6 . (91)
kun k2
For a comparison between the workloads of the various TIM, we look to the amount of
CPU time, the number of time steps and the total number of Newton iterations (if needed)
it takes to reach steady state.
The solutions computed by different TIM also have been compared with a reference
solution uref , which has been computed with high accuracy. It appeared that the solutions
of the different TIM, denoted by uT IM , all had the same quality, by which we mean that
kuT IM − uref k2
= O(10−7 ). (92)
kuref k2
In Figure 8 the residual kF (w(t))k2 versus the time step, for different TIM, is given. Recall
that F (w(t)) is the semi-discretization resulting from the Method of Lines approach, see
(13). In Figure 9 the time step size versus the time step are given. Recall that the time
step sizes are computed using the time step controller of Section 6.2.
With respect to the IMEX Runge-Kutta-Chebyshev method we have the following
remarks. Because the advection and diffusion part are integrated explicitly, there is always
a stability condition on the time step. This stability condition makes the IMEX RKC
method not suitable for computing a steady state solution. We implemented the IMEX
RKC scheme with a variable step size controller and a variable stage controller as described
in Section 5.1. The number of stages per time step is given in Figure 10, whereas the time
step size and kF (w(t))k2 are given in Figure 11.
We conclude with the contour plots of the steady state solution in Figure 12.
35
TIM CPU time # time steps # Newton iterations
Euler Backward 1061 CPU sec 120 236
ROS2 579 CPU sec 190 0
BDF-2 689 CPU sec 99 182
IMEX-RKC 13141 CPU sec 1127 9075
Table 8: Workloads of various TIM for simulation with physical initial conditions.
0
10
EA
ROS2
−1 BDF2
10
−2
10
−3
10
−4
10
−5
10
−6
10
−7
10
−8
10
0 20 40 60 80 100 120 140 160 180 200
Figure 8: Residual kF (w(t))k2 versus time step for simulation with physical initial conditions
2
10
EA
BDF2
1
ROS2
10
0
10
−1
10
−2
10
−3
10
−4
10
−5
10
0 20 40 60 80 100 120 140 160 180 200
Figure 9: Time step size versus time step for simulation with physical initial conditions
36
11
10
0
0 200 400 600 800 1000
Figure 10: Number of stages of IMEX Runge Kutta Chebyshev scheme versus time step for simulation
with physical initial conditions
0 −1
10 10
−4 −3
10 10
norm residual
−6 −4
10 10
Figure 11: Residual kF (w(t))k2 and time step size versus time step for the IMEX Runge-Kutta-Chebyshev
scheme for simulation with physical initial conditions
37
Mass fraction SiH Mass fraction SiH
4 x 10
−3 2 x 10
−5
7 2
0.09 0.09
6.5 1.8
0.08 6 0.08
1.6
5
0.06 0.06
1.2
4.5
0.05 0.05 1
4
0.04 0.04 0.8
3.5
0.03 0.03 0.6
3
0.02 0.02 0.4
2.5
0
0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16 0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16
(a) (b)
Mass fraction H2SiSiH2 −3
Mass fraction Si2H6 −3
x 10 x 10
5
0.09 0.09
4.5
0.08 0.08 1
4
0.07 0.07
3.5
0.8
0.06 0.06
3
0.04 2 0.04
0.4
0.03 1.5 0.03
0.02 1 0.02
0.2
0 0
0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16 0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16
(c) (d)
Mass fraction Si3H8 −4
Mass fraction H2 −4
x 10 x 10
0.09 0.09
12
0.08 0.08
2
0.07 10 0.07
0.06 0.06
1.5
8
0.05 0.05
6
0.04 0.04 1
0.03 0.03
4
2
0.01 0.01
0
0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16 0.02 0.04 0.06 0.08 0.1 0.12 0.14 0.16
(e) (f)
Figure 12: Contour plots of the steady state mass fractions of SiH4 (a), SiH2 (b), H2 SiSiH2 (c), Si2 H6 (d),
Si3 H8 (e) and H2 (f). The outflow boundary is situated on r = 15.0 cm. to r = 17.5 cm.
38
6.3.2 Constant Initial Profile
In order to test the robustness of the code we perform a test proposed by Kleijn. This so
called ‘Constant Initial Profile’ test starts at t = 0 with a constant initial profile consisting
of silane SiH4 and helium He, such that
fSiH4 = 0.001 and fHe = 0.999, (93)
on the whole computational domain. In Figures 13 and 14 and Table 9 results for the
different time integration methods, except IMEX Runge-Kutta-Chebyshev, are given. The
result for the IMEX RKC scheme are presented in Figure 15 and 16. The steady state
solution that has been found is identical as the one found in the simulations of Section
6.3.1.
From Table 9 we see that with the constant initial profile as initial condition a smaller
number of time steps is needed to converge to steady state. This observation is easily
explained by the fact that for the constant initial profile no silane has to flow into the
reactive zone. In this case the gas phase reactions will start immediately, such that towards
a chemical equilibrium can be computed.
7 Conclusions
Based on Table 8 and 9 can be concluded that for the simplified CVD system as
introduced in Section 2, the second order Rosenbrock method is the most efficient time
integration method in terms of CPU time. The difference between Rosenbrock, Euler
Backward and BDF is minimal. We expect that for 2D systems with a larger number
of species and reactions, these methods perform equally well, to compute a steady state
solution.
The opposite is true for the IMEX RKC scheme. As mentioned before, this method is
not suitable for simulation until steady state. We expect that in the case of 3D and a large
number of reactive species this scheme will perform much better, under the assumption
that for future work transient simulation is considered. This expectation depends highly
on the fact that the nonlinear systems in the IMEX RKC scheme will become (relatively)
cheaper to solve if the number of dimensions (and species) increases.
39
1
10
EA
0 ROS2
10 BDF2
−1
10
−2
10
−3
10
−4
10
−5
10
−6
10
−7
10
−8
10
0 10 20 30 40 50 60 70 80
Figure 13: Residual kF (w(t))k2 versus time step for constant initial profile simulation
2
10
EA
ROS2
1 BDF2
10
0
10
−1
10
−2
10
−3
10
−4
10
−5
10
−6
10
0 10 20 30 40 50 60 70 80
Figure 14: Time step size versus time step for constant initial profile simulation
40
9
0
100 200 300 400 500 600 700
Figure 15: Number of stages of IMEX Runge Kutta Chebyshev scheme versus time step for constant initial
profile simulation
1 −1
10 10
0
10
−2
10
Time step size
Norm residual
−3 −3
10 10
−4
10
−5 −4
10 10
norm residual
−6
10
−7 −5
10 10
0 100 200 300 400 500 600 700 800
Figure 16: Residual kF (w(t))k2 and time step size versus time step for the IMEX Runge-Kutta-Chebyshev
scheme for constant initial profile simulation
41
References
[1] A. Berman and R.J. Plemmons, Nonnegative Matrices in the Mathematical Sci-
ences, SIAM, Philadelphia, (1994)
[5] E. Hairer and G. Wanner, Solving Ordinary Differential Equations II : Stiff and
Differential-Algebraic Problems, Second Edition, Springer Series in Computational
Mathematics, 14, Springer, Berlin, (1996)
[6] R.A. Horn and C.R. Johnson, Matrix Analysis, Cambridge University Press,
Cambridge, (1999)
[8] C.T. Kelley, Solving Nonlinear Equations with Newton’s Method, Fundamentals
of Algorithms, SIAM, Philadelphia, (2003)
[9] C.R. Kleijn, Transport Phenomena in Chemical Vapor Deposition Reactors, PhD
thesis, Delft University of Technology, Delft, (1991)
[10] C.R. Kleijn, Computational Modeling of Transport Phenomena and Detailed Chem-
istry in Chemical Vapor Deposition- A Benchmark Solution, Thin Solid Films, 365,
pp. 294-306, (2000)
[11] J.M. Ortega and W.C. Rheinboldt, Iterative Solution of Nonlinear Equations
in Several Variables, Reprint of the 1970 original, Classics in Applied Mathematics
30, SIAM, Philadelphia, (2000)
[12] A. Sandu, Positive Numerical Integration Methods for Chemical Kinetic Systems,
Technical Report at Michigan Technological University, CSTR-9905, (1999)
42
[14] B.P. Sommeijer, L.F. Shampine and J.G. Verwer, RKC: An Explicit Solver
for Parabolic PDEs, J. Comput. Appl. Math. 88, pp. 315-326, (1997)
[15] M.N. Spijker, Contractivity in the Numerical Solution of Initial Value Problems,
Numer. Math. 42, pp. 271-290, (1983)
[16] S. van Veldhuizen, Efficient Solution Methods for Stiff Systems of Advection-
Diffusion-Reaction Equations, Literature Study, Technical Report at the Delft Uni-
versity of Technology, TWA-05-05, Delft, (2005)
[17] J.G. Verwer, E.J. Spee, J.G. Blom and W. Hundsdorfer, A Second-Order
Rosenbrock Method Applied to Photochemical Dipersion Problems, SIAM Journal on
Sci. Comp., 20, pp.1456-1480, (1999)
[19] J.G. Verwer, B.P. Sommeijer and W. Hundsdorfer, RKC Time-Stepping for
Advection-Diffusion-Reaction Problems, Journal of Comp. Physics, 201, pp. 61-79,
(2004)
43