Manuscript submitted to AIMS’ Journals Volume X, Number 0X, XX 200X
Website: http://AIMsciences.org pp. X–XX
NUMERICAL METHODS FOR STIFF REACTION-DIFFUSION SYSTEMS
Ching-Shan Chou Center for Mathematical and Computational Biology Department of Mathematics University of California, Irvine Irvine, CA 92697-3875, USA
Yong-Tao Zhang Department of Mathematics University of Notre Dame Notre Dame, IN 46556-4618, USA
Rui Zhao Center for Mathematical and Computational Biology Department of Mathematics University of California, Irvine Irvine, CA 92697-3875, USA
Qing Nie Center for Mathematical and Computational Biology Department of Mathematics University of California, Irvine Irvine, CA 92697-3875, USA
(Communicated by K. K. Tung) Dedicated to Frederic Yui-Ming Wan on the occasion of his 70th birthday
Abstract. In a previous study [21], a class of efficient semi-implicit schemes was developed for stiff reaction-diffusion systems. This method which treats linear diffusion terms exactly and nonlinear reaction terms implicitly has excellent stability properties, and its second-order version, with a name IIF2, is linearly unconditionally stable. In this paper, we present another linearly unconditionally stable method that approximates both diffusions and reactions implicitly using a second order Crank-Nicholson scheme. The nonlinear system resulted from the implicit approximation at each time step is solved using a multi-grid method. We compare this method (CN-MG) with IIF2 for their accuracy and efficiency. Numerical simulations demonstrate that both methods are accurate and robust with convergence using even very large size of time step. IIF2 is found to be more accurate for systems with large diffusion while CN-MG is more efficient when the number of spatial grid points is large.
Key words and phrases. Integrating factor methods, Crank-Nicholson, multi-grids, reactiondiffusion equations, morphogen gradients.
1
2
C.-S. CHOU, Y.-T. ZHANG, R. ZHAO, AND Q. NIE
1. Introduction. Mathematical equations for many physical and biological applications are of the form: ∂u = D∆u + F(u), (1.1) ∂t where u ∈ Rm represents a group of physical or biological species, D ∈ Rm×m is the diffusion constant matrix, ∆u is the Laplacian associated with the diffusion of the species u, and F(u) describes the chemical or biological reactions. When the diffusion term is discretized using finite difference methods, the reactiondiffusion system (1.1) is first reduced to a system of ODEs: ut = Cu + F(u),
(1.2)
where Cu is a finite difference approximation of D∆u. Let N denote the number of spatial grid points for the approximation of the Laplacian ∆u, then u(t) ∈ RN ·m and C is a (N · m) × (N · m) matrix. For instance, C is a tri-diagonal matrix in a one dimensional system when a second order central difference is carried out on the diffusion. For a time integrator applied to Eq. (1.2), the time step is constrained by the size of the eigenvalues of the diffusion matrix C, which are proportional to diffusion coefficients and spatial resolutions as well as the stiffness of the nonlinear reaction term F(u). The constraint due to diffusion can be totally removed by treating the term Cu exactly [9, 1, 2]. Different approximations on the temporal integral involving F(u) in this approach result in either Integration Factor (IF) method [18, 21] or Exponential Time Differencing (ETD) method [13, 6, 7, 8]. Although the stability constraint due to diffusion is totally removed in the IF and ETD methods, the time step is still constrained by stiffness of the reaction term F(u) due to their explicit treatment of F(u) through either linear multi-step methods [9, 2] or Runge-Kutta approximations [5]. These methods are efficient for diffusion-dominated systems but not for systems with highly stiff reactions as well as strong diffusive effects, as often is the case in many biological applications. In diffusive morphogen gradient systems [16, 11, 19, 20], for instance, the reaction rate constants usually differ by four to six magnitudes and the system is very stiff as a result. Recently, a new class of semi-implicit integrating factor (IIF) methods [21] has been introduced to address this issue. The new IIF method treats diffusion terms exactly and nonlinear reaction terms F(u) implicitly in such a way that the implicit approximation of the nonlinear terms is decoupled from the global calculation of the diffusion term. Consequently, it avoids solving a large nonlinear system with N · m unknowns; instead, a system of size m, the number of the original differential equations, has to be solved at each spatial grid point. The structure of the the small nonlinear system is particularly suitable for simple iterative nonlinear solvers such as the fixed point iteration. The overall computational cost is of the same order as the explicit IF or ETD methods, and it mainly comes from the matrixvector multiplications due to the exact representation of diffusion operators. The IIF methods have much better stability properties than the explicit IF or ETD methods, and the second-order IIF (IIF2) is unconditionally stable. In this paper, we will compare this semi-implicit method (IIF2) with a fully implicit and unconditionally stable method. In the fully implicit method, a secondorder Crank-Nicholson approximation [4] is applied to Eq. (1.1). As a result, a large system of nonlinear equations with (N · m) equations and (N · m) unknowns has to be solved at every time step. Because the size of the nonlinear system linearly
STIFF REACTION-DIFFUSION SYSTEMS
3
depends on the spatial resolution N , using a standard nonlinear solver for such system is usually very expensive. To speed up the calculation, we incorporate an efficient multi-grid method [3] to solve the system at every time step. Finally, we study accuracy and efficiency for the two methods, IIF2 and the Crank-Nicholson method with multi-grid (CN-MG) based on simulations of a test problem with an analytical solution and a set of fully nonlinear equations which models a morphogen system in developmental biology. The rest of the paper is organized as following. In section 2, we review briefly the IIF schemes, and introduce the Crank-Nicholson scheme with a nonlinear multi-grid solver for the reaction-diffusion equations. In section 3, we compare the accuracy and efficiency between the second-order IIF scheme and CN-MG scheme, using two examples. We conclude the paper in section 4. 2. Two Numerical Methods. In this section, we will briefly describe two unconditionally stable methods with second-order of accuracy for reaction-diffusion systems. 2.1. Implicit Integration Factor (IIF). First, we present the Implicit Integration Factor (IIF) method [21] based on a scalar case of the semi-discrete system (1.2) of the form ut = cu + f (u), t > 0, u(0) = u0 , (2.3) where c is a constant representing the diffusion and f is a nonlinear function representing the reaction. After multiplying (2.3) by an integrating factor e−ct , we integrate the equation over one time step from tn to tn+1 ≡ tn + ∆t to obtain Z ∆t e−cτ f (u(tn + τ ))dτ. (2.4) u(tn+1 ) = u(tn )ec∆t + ec∆t 0
For a scheme of r-th order truncation error, we first approximate the integrand, e−cτ f (u(tn + τ )), using an (r − 1)-th order Lagrange polynomial, p(τ ), with interpolation points at tn+1 , tn , ..., tn+2−r : p(τ ) =
r−2 X
i=−1
eic∆t f (un−i )
r−2 Y
j=−1 j6=i
τ + j∆t . (j − i)∆t
(2.5)
where un is the approximated solution for u(tn ). Next, we integrate the polynomial p(τ ) with respect to τ , and derive ! r−2 X c∆t αn−i f (un−i ) , (2.6) un+1 = e un + ∆t αn+1 f (un+1 ) + i=0
where αn+1 , αn , αn−1 , · · · , αn−r+2 calculated from the integrals of the polynomial p(τ ) are listed in [21]. The second-order scheme (IIF2) is of the following form ∆t ∆t un+1 = ec∆t un + f (un ) + f (un+1 ), (2.7) 2 2 with a local truncation error
1 2 (2.8) c fn − 2cf˙n + f¨n ∆t3 . 12 The IIF method has excellent stability properties compared to explicit integration factor methods and other exponential time difference schemes. In real practice, Eq. −
4
C.-S. CHOU, Y.-T. ZHANG, R. ZHAO, AND Q. NIE
(2.3) is usually a system where u and f are vectors, and ec∆t is a matrix. Unlike most other implicit methods, the dominant computational cost for IIF is usually from the exact treatment of diffusion terms instead of solving the nonlinear systems due to implicit treatment of the nonlinear equations. In particular, in IIF2 the matrix-vector multiplication in the first term of the right-hand side of Eq. (2.7) dominates the cost of calculation for a system of reaction-diffusion equations. From the stability point of view, IIF2 is the best among IIF methods, and it is linearly unconditionally stable. 2.2. A Crank-Nicholson Method with a Multi-Grid Solver (CN-MG). An alternative approach to construct an unconditionally stable method for reactiondiffusion systems is to treat both reaction and diffusion terms implicitly. A CrankNicholson approximation for the diffusion and reaction terms leads to a fully implicit scheme: ! n+1 n+1 n+1 − unj un+1 unj+1 − 2unj + unj−1 1 1 uj+1 − 2uj + uj−1 j + F(un+1 = D· + ) + F(unj ) . j 2 2 ∆t 2 (∆x) (∆x) 2 (2.9) ∆t for a one-spatial dimensional form of Eq. (1.1). Define λ , D (∆x) 2 , then Eq. (2.9) can be re-written as ∆t λ n+1 − un+1 + un+1 ) = Gnj (2.10) F(un+1 uj+1 − 2un+1 j j−1 − j j 2 2 where ∆t λ n Gnj , unj + F(unj ). uj+1 − 2unj + unj−1 + 2 2 This method is linearly unconditionally stable [4], similar to IIF2, and its local truncation error is 1 (2.11) (c + f˙n )2 (cun + fn ) + f¨n (cun + fn )2 ∆t3 − 12 when the Crank-Nicholson scheme (2.10) is applied to Eq. (2.3). In particular, cu represents the finite difference approximation of the diffusion D∆u as in the ODE system (1.2), and the eigenvalues of C are proportional to DN 2 . If the number of spatial grid points N or the diffusion constant D is large enough, terms involving c will dominate in the truncation errors (2.8) and (2.11). In these cases, the truncation error (2.8) of IIF2 has the leading term O(c2 ∆t3 ), while that (2.11) of the Crank-Nicholson scheme has the leading term O(c3 ∆t3 ). So we expect that IIF2 is more accurate than the Crank-Nicholson scheme for diffusion dominated problems. Direct numerical simulations on a test problem in Section 3 indicate that the errors of the solutions computed from IIF2 are no larger than those from the Crank-Nicholson scheme. To advance the Crank-Nicholson scheme from the n-th time step to the (n + 1)th, one has to solve a nonlinear system (2.10) of (m · N ) unknowns at every time step. A direct nonlinear solver usually has at least computational complexity with an order of N 2 and is very expensive. In this paper, we will use one of the nonlinear multi-grid methods, the full approximation scheme (FAS) [3], to speed up solving (2.10). The FAS method is based on a nonlinear Gauss-Seidel relaxation scheme [22] and it has a computational complexity of order of N . More details and the implementations of FAS method are given in the next subsection. We denote the Crank-Nicholson scheme with a multi-grid solver as CN-MG in short.
STIFF REACTION-DIFFUSION SYSTEMS
5
In the multi-level FAS method [3], solutions of a local nonlinear system of m equations are needed at each grid point. The system (2.10) can be written in a form of fixed point iteration: Gnj λ ∆t F(wj ) + (wj+1 + wj−1 ) + , (2.12) wj = 2(1 + λ) 2(1 + λ) 1+λ ∆t ∆t ≪ 1, 2(1+λ) F is likely to be a contractive where wj ∈ Rm , 1 ≤ j ≤ N . When 2(1+λ) mapping [15] which ensures convergence of a fixed point iteration. We also implement a Newton’s method [14, 15] to solve the system (2.12) in addition to the fixed point iteration.
2.3. Implementations of the multi-grid FAS method in CN-MG. In this subsection, we explain in detail the implementations of solving Eq. (2.10) using the FAS method [3]. As mentioned in the Section 2.2, a nonlinear system Eq. (2.10) with (m × N ) unknowns has to be solved at each time step. The system can be rewritten in the general form Au = f (2.13) m where A is a linear or nonlinear operator, u = (u1 ; u2 ; · · · ; uN ), and uj ∈ R , 1 ≤ j ≤ N . Let Ωh denote the grid with grid size h, the total length of the domain divided by N . If N = 2k for some integer k, Ω2h then represents a coarse grid imbeded in Ωh with grid size 2h. The two-grid FAS method for solving system (2.13) is outlined here: 1. Relax ν1 times on Ah uh = f h on Ωh with intial guess vh . 2. Restrict the current approximation and its fine-grid residual to the coarse grid Ω2h : r2h = Ih2h (f h − Ah (vh )) and v2h = Ih2h vh . 3. Solve the coarse-grid problem A2h (u2h ) = A2h (v2h ) + r2h . 4. Compute the coarse-grid approximation to the error: e2h = u2h − v2h . 5. Interpolate the error approximation up to the fine grid and correct the current h 2h fine-grid approximation: vh ← vh + I2h e . h h h h 6. Relax ν2 times on A v = f on Ω with intial guess vh . h where Ih2h and I2h are restriction and interpolation operators, and the superscript h or 2h indicates the operators or variables on the corresponding grid. The number of relaxations ν1 , ν2 are chosen depending on the problem for the best efficiency. l Furthermore, if N = 2L , there is a series of grids {Ω2 h , l = 0, · · · , L}, and the twogrid FAS can be applied to multi-grid by imbedding the two-grid scheme within itself. More detials about the various implemetation of the multi-grid scheme can be found in [3]. In step 1, 3 and 6, one needs to use Gauss-Seidel relaxation scheme for the nonlinear system G(u) = 0 where G = (g1 ; g2 ; · · · ; gN ), gj ∈ Rm , 1 ≤ j ≤ N . Let uk = (uk1 ; uk2 ; · · · ; ukN ) denote the k-th step during the iteration, the Gauss-Seidel relaxation can be outlined as k = 0; Given a initial guess for u0 ; While ||uk − uk−1 || > ε or k = 0 k = k + 1; for l = 1 to N k−1 k solve gl (uk1 , · · · , ukl−1 , ukl , uk−1 l+1 · · · ; uN ) = 0 for ul ; end end
6
C.-S. CHOU, Y.-T. ZHANG, R. ZHAO, AND Q. NIE
In the inner part of the above loop, one needs to solve a nonlinear system at each grid point with m unknowns and m equations. We use either Newton’s method or a fixed point iteration [14, 15] to solve this system. For example, Eq. (2.12) is of a form convenient for a fixed point iteration. 3. Numerical Results. In this section, we will compare the accuracy and efficiency of IIF2 and CN-MG when they are applied to a test reaction-diffusion system and a morphogen system in developmental biology. 3.1. A Test Problem. First, we test both algorithms for a one-dimensional reactiondiffusion system with known analytical solutions. The equations are ut
= d uxx − a u + v
vt
= d vxx − b v
(3.14)
on (0, π2 ) with boundary conditions ux (0, t) = 0,
π u( , t) = 0, 2
vx (0, t) = 0,
The exact solutions of the system are u(x, t) = e−(a+d)t + e−(b+d)t cos(x) ,
π v( , t) = 0. 2
v(x, t) = (a − b) e−(b+d)t cos(x).
Table 3.1. Error, order of accuracy, and CPU time for a diffusion dominated case: (a, b, d) = (0.1, 0.01, 1).
∆t 0.04 0.02 0.01 0.005
CN-MG L∞ error order CPU time 1.09E-04 0.16 2.67E-05 2.02 0.31 6.27E-06 2.09 0.57 1.16E-06 2.43 1.02
∆t 1 0.5 0.25 0.125
IIF2 L∞ error order CPU time 2.73E-05 0.009 6.40E-06 2.09 0.017 1.19E-06 2.42 0.033 1.07E-07 3.48 0.065
Because the reaction terms in Eq. (3.14) are linear, the nonlinear systems in IIF2 can be solved analytically. Similarly, in CN-MG the analytical solution of the local nonlinear system is constructed at each level of the multi-grid method during every time step. In CN-MG, the tolerance for convergence of the multi-grid solver is taken as 10−10 . For the spatial discretization on the Laplacian operator, we use a second-order central difference with a consistent approximation on the no-flux boundary condition at x = 0. In all the numerical experiments, the spatial grid is set to be fine enough such that the errors are dominated by those from the time integration. From the numerical tests, it is found N = 512 is sufficient, and all the results presented for the test problem are based on N = 512. The errors between the numerical solutions and the exact solutions are evaluated at t = 1. The calculations are performed on Opteron CPUs of 1.4GHz and 1GB memory, and the CPU time are presented with a unit of second in this paper. To study how both algorithms behave under different situations, we examine several sets of parameters (a, b, d) in equation (3.14). First, we take (a, b, d) = (0.1, 0.01, 1), a diffusion dominated case. In IIF2 the time integration of the diffusion term should be exact when the reaction term is zero, i.e. a = b = 0. In CN-MG,
STIFF REACTION-DIFFUSION SYSTEMS
7
however, the time integration is only treated approximately. Therefore, for the case with relatively small reactions we expect IIF2 have better accuracy than CN-MG. This is the case as seen in Table (3.1). In IIF2 very small errors are achieved even for a ∆t as large as one. In contrast, it takes ∆t = 0.02 for CN-MG to reach an error of the same size. Overall, the CN-MG needs time steps that are a factor of 50 times smaller than IIF2 to achieve the same accuracy. Consequently, IIF2 is much more efficient than CN-MG for a diffusion-dominated case. Next, a reaction dominated case (a, b, d) = (2, 1, 10−3 ) is considered. In this case, the two methods produce similar errors using the same ∆t, as demonstrated in Table (3.2). Because the errors are dominated by approximation of the reaction terms in this case, the two methods with a similar treatment on reactions are expected to have similar accuracy. However, CN-MG usually takes less CPU time than IIF2 to achieve the same level of accuracy since all IF and ETD type of schemes (see Eq. (2.4)), including IIF2, need a global matrix-vector multiplication of order of N 2 at each time step. In IIF2, the CPU time is doubled when ∆t is halved, as expected, while the CPU time for CN-MG increases slower than linear as seen in Table (3.2). It is observed that the multi-grid method in CN-MG needs a smaller number of iteration to converge for a smaller time-step. In the CN-MG implementation, we always use the solution at the previous time step as the initial guess for the multigrid iteration. As a result, a smaller ∆t results in a better initial guess, consequently a smaller number of iterations. Of course, this initial guess can be improved if one uses extrapolation through the solutions at previous time steps. Table 3.2. Error, order of accuracy, and CPU time for a reaction dominated case: (a, b, d) = (2, 1, 0.001).
∆t 0.04 0.02 0.01 0.005
CN-MG L∞ error order CPU time 1.94E-04 0.06 4.84E-05 2.00 0.09 1.21E-05 2.00 0.13 3.02E-06 2.00 0.23
IIF2 L∞ error order CPU time 1.93E-04 0.20 4.83E-05 2.00 0.40 1.21E-05 2.00 0.80 3.02E-06 2.00 1.63
Lastly, we study (a, b, d) = (100, 1, 10−3 ), which is a reaction dominated case with stiff reaction. In Table (3.3), the overall behavior of IIF2 and CN-MG is similar to the reaction dominated case shown in Table (3.2). Because both schemes are unconditionally stable, they exhibit second order of accuracy even for relatively large ∆t similar to the non-stiff cases. However, the magnitude of errors for both schemes are larger (around a factor of 25) than the non-stiff case in Table (3.2) because of a much larger coefficient in front of the reaction term: a = 100, compared to a = 2 in Table (3.2). 3.2. A Morphogen System. In this section, we apply both IIF2 and CN-MG to a system of nonlinear reaction-diffusion equations arising from modeling morphogen gradients in developmental biology. The system, also studied in [21], describes how Dally-like protein (Dlp) regulates Wingless (Wg) morphogen distribution in an imaginal disc of Drosophila [10, 12].
8
C.-S. CHOU, Y.-T. ZHANG, R. ZHAO, AND Q. NIE
Table 3.3. Error, order of accuracy, and CPU time for a stiff reaction case: (a, b, d) = (100, 1, 0.001).
∆t 0.04 0.02 0.01 0.005
CN-MG L∞ error order CPU time 4.87E-03 0.06 1.22E-03 2.00 0.10 3.04E-04 2.00 0.16 7.60E-05 2.00 0.25
IIF2 L∞ error order CPU time 4.89E-03 0.21 1.21E-03 2.00 0.41 3.03E-04 2.00 0.81 7.58E-05 2.00 1.63
In the model, [L], [LR], [N ∗ ] and [LN ∗ ] denote the concentration of Wg, Wg-Dfz2 (a ligand-receptor complex), the enzymatic modification of Dlp, and the complex produced by interaction between Wg and the enzymatic modification of Dlp respectively; V¯L and V¯N represent the production rate of L and N ∗ respectively; {Kon , Jon }, {Kof f , Jof f }, and {Kdeg , Jdeg } denote binding rates, off rates, and degradation rates respectively. The interaction relationship among those components is illustrated in [21]. The three diffusive species [L], [N ∗ ] and [LN ∗ ] are assumed with the same diffusion coefficient D. The total amount of receptor D-fz2, denoted by R0 , is assumed fixed [19]. The mid-point of the Wg production region, the dorsal-ventral boundary, is denoted as −d¯ ([16, 17]) while the edge of the imaginal wing disc in the dorsal-ventral direction is denoted as Xmax . The governing equations for the four ¯ Xmax ) then have the following form [21]: quantities in (−d, ∂[L] ∂T ∂[LR] ∂T ∂[LN ∗ ] ∂T ∂[N ∗ ] ∂T The boundary
∂ 2 [L] − Kon [L] · (R0 − [LR]) ∂X 2 + Kof f [LR] − Jon [L] · [N ∗ ] + (Jof f + Jdeg )[LN ∗ ] + V¯L (X),(3.15) = D
= Kon [L] · (R0 − [LR]) − (Kof f + Kdeg )[LR], ∂ 2 [LN ∗ ] + Jon [L] · [N ∗ ] − (Jof f + Jdeg )[LN ∗ ], ∂X 2 ∂ 2 [N ∗ ] = D − Jon [L] · [N ∗ ] + Jof f [LN ∗ ] + V¯N (X). ∂X 2 conditions at X = −d¯ are = D
∂[LN ∗ ] ∂[L] ¯ = 0, ¯ = 0, (T, −d) (T, −d) ∂X ∂X The boundary conditions at X = Xmax are [LN ∗ ](T, Xmax ) = 0, ¯ 0], In the Wg production region [−d, V¯L (X) = vL , L(T, Xmax ) = 0,
(3.16) (3.17) (3.18)
∂[N ∗ ] ¯ = 0. (T, −d) ∂X [N ∗ ](T, Xmax ) = 0.
where vL is a constant. In x ∈ (0, Xmax ), VL (x) = 0. Because Dlp is produced ¯ Xmax ) with vN as a constant. everywhere, V¯N (x) = vN in (−d, We use a same set of parameters given in [21]: Xmax = 0.02 cm; d¯ = 0.00125 cm; D = 8.5×10−7 cm2 /s; Kon = 0.12 s−1 µM−1 ; Kof f = 1.0×10−5 s−1 ; Kdeg = 5×10−4 s−1 ; Jon = 285 s−1 µM−1 ; Jof f = 4 × 10−6 s−1 ; Jdeg = 0.54 s−1 ; vL = 8 × 10−4
STIFF REACTION-DIFFUSION SYSTEMS
9
s−1 µM; vN = 2 × 10−3 s−1 µM. The solutions of the system was presented in [21]. Here we mainly compare the efficiency of IIF2 and CN-MG. The implementation of CN-MG is similar to that for the linear system described above, except that a nonlinear system of four unknowns in a form of (2.12) needs to be solved at each grid point during each time step. Here, we use two different approaches to solve the local small nonlinear system at each grid point: a fixed point iteration or a Newton method. In both nonlinear solvers, the iteration tolerance is taken as 10−10 . In the Newton solver, LAPACK is used to solve the linear system involving the Jacobian. Table (3.4) displays the CPU time of CN-MG (with either a fixed point or a Newton method) and IIF2, in which a fixed point iteration method [21] is used to solve the local nonlinear system. As seen in the table, when the time step size is too large, both IIF2 and CN-MG with a fixed point iteration do not converge, but CN-MG with a Newton solver converges. Various numerical tests suggest that this is not due to the stability condition since both methods are unconditionally stable. It is found that the fixed point iteration, which usually is efficient and easy to implement, is sensitive to its initial guess for convergence. When the size of time step is large, the solution at its previous time step, which is used as the initial guess for the fixed point iteration of (2.12) at its current step, is not as good as the case for a smaller time step. This is also the case for IIF2. As a result, the fixed point iteration procedure does not converge at some time during the course of temporal update in either IIF2 or CN-MG. In contrast, the CN-MG with a Newton solver seems to be more robust, and it converges for all time steps tested in Table (3.4). Although the CN-MG with a Newton solver is robust in terms of convergence, it takes the most CPU time among all three implementations as seen in Table (3.4). For the cases with convergent solutions, the CN-MG with a fixed point iteration usually takes less CPU time than IIF2. When N is doubled, the CPU time for IIF2 increases by a factor of four because in any IF and ETD method the exact treatment of diffusion leads to matrix-vector multiplications with an order of N 2 computational complexity [21]. This is not the case for CN-MG, in which the dominated cost comes from solving the nonlinear systems. When N is doubled in both CN-MG methods, the CPU time increases only by a factor of two to three depending on the size of time steps. Clearly, all three implementations can be improved if better nonlinear solvers and better initial guesses are incorporated for the iterative methods. Table 3.4. CPU time (seconds) for IIF2 and CN-MG for a morphogen system up to T = 1800; ”NC” stands for no convergence of the method.
∆t 2 × 10−1 1 × 10−1 5 × 10−2 2 × 10−2 1 × 10−2 5 × 10−3
CN-MG (fixed point) N = 64 N = 128 NC NC 2.95 9.82 5.36 18.17 11.94 25.93 23.31 48.92 45.55 91.24
CN-MG (Newton) N = 64 N = 128 32.61 94.61 39.66 135.37 71.74 245.77 153.83 363.35 294.52 670.12 557.08 1171.54
IIF2 N = 64 N = 128 NC NC NC NC 7.78 27.03 19.61 65.90 39.54 131.49 78.02 268.67
10
C.-S. CHOU, Y.-T. ZHANG, R. ZHAO, AND Q. NIE
4. Conclusion. In this paper, we have presented an unconditionally stable scheme of second order for the stiff reaction diffusion equations. In this method, the diffusion and reaction terms are treated implicitly using the Crank-Nicholson scheme, and the nonlinear system arising from such implicit approximation is solved by a nonlinear multi-grid method. Through numerical simulations of a test problem and a nonlinear system arising from modelling morphogen gradients in developmental biology, we have compared this fully implicit method (CN-MG) with a semi-implicit integration factor method (IIF2). It was found that both methods are accurate and robust. For diffusion-dominated systems, the IIF2 method clearly has better performance because of its exact treatment of diffusion; For reaction-dominated systems, the CN-MG and the IIF2 have similar accuracy for time steps of the same size; however CN-MG is more efficient when the spatial mesh size is small. This is due to a relatively more expensive calculation on the diffusion terms in IIF2 compared to a simple implicit approximation on diffusions in CN-MG. Because both methods handle reactions in a similar fashion, the advantage of IIF2 is significant only when the diffusion term is large enough. Acknowledgement. This research work was supported by the NSF DMS-0511169 Grant, NIH/NSF initiatives on Mathematical Biology through Grants R01GM57309 and R01GM67247 from the National Institute of General Medical Science, and NSFC Grants 10601029 and 60573168. REFERENCES [1] G. Beylkin and J. M. Keiser, On the adaptive numerical solution of nonlinear partial differential equations in wavelet bases, J. Comput. Phys., 1997, 132, 233–259. [2] G. Beylkin, J. M. Keiser and L. Vozovoi, A new class of time discretization schemes for the solution of nonlinear PDEs, J. Comput. Phys., 1998, 147, 362–387. [3] W.L. Briggs, V.E. Henson and S.F. McCormick, A multigrid tutorial, SIAM, 2000. [4] B. Gustafsson, H.-O. Kreiss and J. Oliger, Time dependent problems and difference methods, John Wiley & Sons, Inc, 1995. [5] S. M. Cox and P. C. Matthews, Exponential time differencing for stiff systems, J. Comput. Phys., 2002, 176, 430–455. [6] Q. Du and W. Zhu, Stability analysis and applications of the Exponential Time Differencing Schemes, J. Comput. Math., 2004, 22, 200. [7] Q. Du and W. Zhu, Modified exponential time differencing schemes: analysis and applications, BIT, Numer. Math. 2005, 45 (2) 307–328. [8] Q. Du and W. Zhu, Exponential time differencing Schemes for parabolic equations: stability analysis and applications, SIAM J. Numer. Anal., submitted. [9] T.Y. Hou, J.S. Lowengrub and M.J. Shelley, Removing the stiffness from interfacial flows with surface tension, J. Comput. Phys., 1994, 114, 312. [10] H.J. Jou, P.H. Leo and J.S. Lowengrub, Microstructural evolution in inhomogeneous elastic media, J. Comput. Phys., 1997, 131, 109. [11] J.Kao, Q.Nie, A.Teng, F.Y.M.Wan, A.D. Lander, J.L.Marsh, Can Morphogen Activity be Enhanced by Its Inhibitors?, Proceedings of 2nd MIT Conference on Computational Mechanics, 2003, pp. 1729–1733. [12] G.E. Karniadakis, M. Israeli and S.A. Orszag, High order splitting methods for the incompressible Navier-Stodes equations J. Comput. Phys., 1991, 97, 414. [13] A.-K. Kassam and L. N. Trefethen, Fourth-order time stepping for stiff PDEs, SIAM J. Sci. Comp., 2005, 26 (4) 1214–1233. [14] C.T. Kelly, Iterative methods for linear and nonlinear equations, SIAM, Philadelphia, 1995. [15] C.T. Kelly, Solving nonlinear equations with Newton’s method, SIAM, Philadelphia, 2003. [16] A. Lander and Q. Nie and F. Wan, Do Morphogen Gradients Arise by Diffusion?, Developmental Cell, 2002, 2, 785–796. [17] A. Lander and Q. Nie and F. Wan, Spatially Distributed Morphogen Production and Morphogen gradient Formation, Mathematical Biosciences and Engineering, 2005, 2 (2), 239–262.
STIFF REACTION-DIFFUSION SYSTEMS
11
[18] P.H. Leo, J.S. Lowengrub and Qing Nie, Microstructural Evolution in Orthotropic Elastic Media , Journal of Computational Physics, 2000, 157, 44–88. [19] Y. Lou, Q. Nie and F. Wan, Effects of Sog on Dpp-Receptor Binding, SIAM J. on Applied Math.”, 2005, 66 (5), 1748–1771. [20] C.M. Mizutani, Q. Nie, F. Wan, Y.-T. Zhang, P. Vilmos, R. Sousa-Neves, E. Bier, L. Marsh and A. Lander, Formation of the BMP activity gradient in the Drosophila embryo, Developmental Cell, 8, June (2005), pp. 915-924. [21] Q. Nie, Y.-T. Zhang and R. Zhao, Efficient semi-implicit schemes for stiff systems, Journal of Computational Physics, 214 (2006), 521-537. [22] J.M. Ortega and W.C. Rheinboldt, Iterative solution of nonlinear equations in several variables, Academic Press, San Diego, 1970. Reprinted as vol. 30, Classics in Applied Mathematics, SIAM, Philadelphia, 2000.
Received ????; revised ????. E-mail address:
[email protected],
[email protected],
[email protected],
[email protected]