- 1School of Mathematical Sciences, Shanghai Jiao Tong University, Shanghai, China
- 2Department of Biomedical Engineering, Pratt School of Engineering, Duke University, Durham, NC, United States
The bidomain equations have been widely used to model the electrical activity of cardiac tissue. While it is well-known that implicit methods have much better stability than explicit methods, implicit methods usually require the solution of a very large nonlinear system of equations at each timestep which is computationally prohibitive. In this work, we present two fully implicit time integration methods for the bidomain equations: the backward Euler method and a second-order one-step two-stage composite backward differentiation formula (CBDF2) which is an L-stable time integration method. Using the backward Euler method as fundamental building blocks, the CBDF2 scheme is easily implementable. After solving the nonlinear system resulting from application of the above two fully implicit schemes by a nonlinear elimination method, the obtained nonlinear global system has a much smaller size, whose Jacobian is symmetric and possibly positive definite. Thus, the residual equation of the approximate Newton approach for the global system can be efficiently solved by standard optimal solvers. As an alternative, we point out that the above two implicit methods combined with operator splittings can also efficiently solve the bidomain equations. Numerical results show that the CBDF2 scheme is an efficient time integration method while achieving high stability and accuracy.
1. Introduction
The monodomain equations or bidomain equations, consisting of a coupled system of partial differential equations (PDEs) and ordinary differential equations (ODEs), are often used to mathematically model the electrical activity of the heart. The PDEs describe the propagation of the electrical signal through the cardiac tissue and the ODEs describe electrochemical reactions in the cells which are usually nonlinear. Modern myocyte models such as the Ohara-Rudy model and anatomically realistic spatial models enable us to achieve a quantitative understanding of the relationship between molecular function and the integrated behavior of the cardiac myocyte in health and disease, e.g., to predict the clinical risk of drug-induced arrhythmias. It is notable that the cardiac electrical activity typically involves multiple and widely varying scales, which makes the monodomain equations and bidomain equations stiff. As a result, it is computationally expensive to get an accurate solution of the electrical activity of the heart (Tung, 1978; Keener and Sneyd, 1998; Sundnes et al., 2007).
In detailed numerical simulations, the finite element method (Sundnes et al., 2005), finite difference method (Pollard et al., 1992), and finite volume method (Johnston, 2010) have all been used for spatial discretization of the domain. While for temporal discretization, the easiest way is to use explicit methods such as the Runge Kutta method and the forward Euler method since they do not require matrix inversion. However, the timesteps allowed in these methods are generally very small in order to satisfy the requirement of stability (dos Santos et al., 2004; Potse et al., 2006). To overcome the drawbacks of explicit methods, the semi-implicit and Crank-Nicolson methods for solving the PDE component of the bidomain equations are proposed (Keener and Bogar, 1998). But the nonlinear term of the bidomain equations still has restriction on the timesteps for stability (Keener and Bogar, 1998). Although fully implicit methods (Hooke, 1992; Pollard et al., 1992; Dal et al., 2012) preferred for stiff systems can guarantee the stability of the numerical schemes and can use large timesteps, they often have the significant drawback of requiring the solution of a large-scale nonlinear system for diffusion and reaction parts of the bidomain equations at each timestep. For example, a fully implicit parallel Newton-Krylov-Schwarz method for solving the bidomain equations has been proposed in Murillo and Cai (2004). They considered a simple case that the conductivity only varies with the co-ordinate system, i.e., the conductivity tensor is a diagonal matrix in the two-dimensional case. The methods proposed in Murillo and Cai (2004) are difficult to implement for more complex geometries and membrane models.
Operator splitting (Qu and Garfinkel, 1999; Trangenstein and Kim, 2004; Sundnes et al., 2005) is a popular technique that can avoid solving the large nonlinear system of the bidomain equations by splitting the equations into more manageable parts, e.g., splitting the bidomain equations into the linear diffusion and nonlinear reaction parts. An operator splitting method combined with a semi-implicit approximation or a Crank-Nicolson approximation to update the transmembrane and extracellular potentials of the bidomain equations has been proposed in Whiteley (2006) which allows for much larger timesteps.
In this work, we present a backward Euler (BE) and a two-stage composite backward differentiation formula (CBDF2) for solving the cardiac electrical dynamics models. The finite element method is applied for the space discretization. The CBDF2 scheme combines the second-order backward differentiation formula and the BE method with the latter used as fundamental building blocks thus it is fully implicit and easily implementable. We point out that the CBDF2 scheme is unconditionally stable and stiffly accurate for stiff problems, i.e., L-stable. After applying the BE method for the bidomain equations, there are two coupled nonlinear systems: space dependent PDEs and space independent ODEs. The nonlinear elimination method (Ying et al., 2008) is used in this work to solve the space dependent PDEs arising from the fully implicit methods for the bidomain equations. The obtained nonlinear system after elimination has a much smaller size and has a symmetric and positive definite Jacobian when the timestep is small. We solve the nonlinear system by an approximate Newton approach where the residual equations in each Newton iteration can be efficiently solved by standard optimal solvers. As an alternative, we also combine the BE and CBDF2 schemes with Godunov splitting and Strang splitting, respectively, to efficiently solve the bidomain equations. From the numerical results, the CBDF2 scheme allows for timesteps four times larger than that of the BE method while achieving the same high numerical accuracy.
2. Materials and Methods
2.1. The Model
The bidomain model describing the electrical activity of the heart or a cardiac tissue can be formulated as a system of nonlinear ordinary and partial differential equations (Keener and Sneyd, 1998). Let Ω ⊂ ℝd (d > 0) be the bounded computational domain; t and x ∈ Ω be the temporal and spatial independent variables, respectively; Φi = Φi(t, x) and Φe = Φe(t, x) be the intracellular and extracellular potentials, respectively; Vm = Vm(t, x) = Φi(t, x)−Φe(t, x) be the transmembrane potential; q represents a set of state variables which can include both gating and ion concentration variables. We consider the bidomain equations of the following form
for t > 0 and x ∈ Ω, subject to the homogeneous Neumann boundary condition
and one constraint on the intra- and extra-cellular potentials
Here, Cm is the membrane capacitance per unit area; β is the surface to volume ratio of the cardiac cells; Di and De are the space dependent intracellular and extracellular conductivity tensors, respectively; n is the unit outward normal on ∂Ω; Iion(Vm, q) and are two known functions, which are typically nonlinear and describe the electrical dynamics of a cardiac myocyte; Istim = Istim(t, x) is an extracellular stimulus current. Provided some appropriate initial conditions on the intracellular potential Φi, extracellular potential Φe, and the vector q of state variables, the bidomain equations can be uniquely solved. We remark that the bidomain equations for the electrical activity of the heart may take different but equivalent forms (Sundnes et al., 2005; Whiteley, 2006; Vigmond et al., 2008).
2.2. The Backward Euler Method
We first introduce the BE method which is used as the fundamental building block of the CBDF2 scheme. Set Δt > 0 as the timestep. Time integration of the bidomain equations by the BE method from time tn to time tn+1 leads to the semi-discrete bidomain equations
where , , , and qn are the finite difference approximations of the variables Φi, Φe, Vm, and q at time tn, respectively.
To eliminate the state variables qn+1 in Equations (5) and (6), we express the ionic current as a function of denoted by
i.e., the vector of state variable qn+1 in Equation (7) can be regarded as a vector value function of the transmembrane potential . In our implementation in each timestep, we first give an initial guess, e.g., extrapolated from and , and numerically solve the nonlinear system (7) to obtain the corresponding state variables qn+1 which is substituted into the ionic current function to estimate . The value of is used in the Newton-type iteration formula for solving Equations (5) and (6) to update . The above steps are performed iteratively until the residual is less than the tolerance.
We rewrite the Equations (5) and (6) as
or
where μ = Cm/Δt.
Assuming that the domain Ω can be partitioned into a quasi-uniform grid if d = 2 or a quasi-uniform mesh if d = 3, the semi-discrete bidomain Equations (10) can be further discretized by using the continuous piecewise linear finite element method on the grid. Let M be the finite element mass matrix; Ki and Ke be the finite element stiffness (non-negative) matrices corresponding to the intracellular and extracellular diffusion operators and , respectively. Let , , , , and Istim be the column vectors whose entries are the discrete values of the potential and current variables at the corresponding grid nodes. The dimensions of the matrices and vectors are the same and both are equal to the number of nodes in the triangular grid. Using the matrix-vector notation, the discrete finite element bidomain equations now read as
which is nonlinear and can be solved with an approximate Newton method.
We denote Jion(Vm) as the derivative of the current function Iion(Vm) with respect to Vm, i.e.,
Let be the diagonal matrix with the diagonal entries being the values of . Then we have the Jacobian matrix of the nonlinear system (11)
Note that the evaluation of the current function involves the solution of a local nonlinear system for the vector of state variables qn+1. Since the derivative function of may not be directly available, for the convenience of implementation, it is computed approximately by the centered difference
where δ is a small positive parameter, typically on the order of 10−6.
Denote and where {ψi} are the piecewise linear basic functions for the finite element method and N is the total number of nodes in the quasi-uniform grid or mesh of Ω. Since the conductivity tensors Di and De are symmetric and positive definite, for a non-zero vector c, the quadratic forms of the stiffness matrices
and
are non-negative and vanish if and only if ∇y≡0 for any x ∈ Ω, which implies that c is parallel to (1, 1, …, 1)T. Therefore, the stiffness matrices Ki and Ke are symmetric positive semi-definite and have a rank of N−1. We then discuss the property of the Jacobian matrix A in Equation (12). Since μ = Cm/Δt, the first part of matrix A in Equation (12) will dominate as Δt approaches zero which is positive semi-definite and has a rank of 2N−1. The second part of the matrix A is symmetric and negligible compared with the first part when Δt approaches zero. Therefore, with a rank of 2N−1, the Jacobian matrix A is irreversible, which is consistent with the fact that the solution of the bidomain equations is not unique if the constraint (4) is absent.
To obtain a unique solution, we take the following discrete formula of the constraint (4) as
where has a dimension of N. Then in each approximate Newton iteration, we use the following matrix
to solve the bidomain equations.
Note that the column vector is an eigenvector corresponding to the eigenvalue 0 of matrix A. Denote the other eigenvectors corresponding to the non-zero eigenvalues of matrix A by W2, W3, … , W2N. Then we have , where W1 is orthogonal to W2, W3 … , W2N. Since matrix A is non-negative definite, we have and , for k = 2, …, 2N. Obviously, we have
and
Therefore, the modified Jacobian matrix B is symmetric and positive definite and the system has a unique solution after adding condition (14).
In principle, we can solve the stabilized system which has a coefficient matrix B by a direct method such as the Gauss elimination method or an iterative method such as the Gauss-Seidel iteration and the (preconditioned) conjugate gradient iteration. Because the bidomain equations often need to be discretized on a fine grid with a large number of nodes, the computational work involved with the solution of the linear equations by the above methods may be large and not optimal. To achieve optimal performance, we can apply the V-cycle geometric multigrid method or multigrid preconditioned conjugate gradient method (Wesseling, 1995; Saad, 2003; Ying, 2005) to solve the stabilized linear system in each Newton iteration.
To numerically solve the bidomain equations by the BE method, we give two nonlinear vector-valued functions from Equations (7) and (11) as
and
The system
and
from time tn to tn+1 can be solved by the following detailed Algorithm 1.
It is worth noting that the updated membrane potential has a corresponding updated qn+1, which is computed by solving the nonlinear system of Equation (18), e.g., by the Newton iteration or the damped Newton iteration method.
2.3. The Composite Backward Differentiation Formula
We then introduce the CBDF2 scheme (Ying et al., 2008, 2009) to solve the bidomain equations. The CBDF2 scheme has second-order accuracy and is L-stable. It uses the BE method as a fundamental building block. As we have presented how to discretize and solve the bidomain equations with the BE method, the CBDF2 scheme can be readily and easily implemented.
For ease of illustration, we first give the CBDF2 scheme for the abstract form
which can then be straightforwardly extended to the bidomain equations. The CBDF2 scheme for Equation (20) is given by
where the parameter γ takes the value of to obtain a second-order numerical accuracy (Ying et al., 2009). Here, un is an approximation of u(tn) at time tn = nΔt and un+γ is an approximation of u(tn+γ) at the intermediate time tn+γ = tn+γΔt. The right hand side of Equation (22) is an approximation of u(tn+1−γ) at time tn+1−γ = tn+1−γΔt which is extrapolated from the solutions at tn and tn+γ. Equation (21) is called the first stage and can be regarded as the BE discretization from time tn to time tn+γ, while Equation (22) is called the second stage and can be regarded as the BE discretization from time tn+1−γ to time tn+1. The form of the two stages of the CBDF2 scheme are the same as that in the BE temporal discretization except that the timestep is replaced by γΔt. Thus, un+γ and un+1 in Equations (21) and (22) can be computed iteratively as previously discussed in Algorithm 1, i.e., the BE method is the building block of the CBDF2 scheme. To extend the CBDF2 scheme to the bidomain equations, we only need to rewrite the system (1)–(3) to a vector form of Equation (20). The detailed CBDF2 scheme for the bidomain equations is given in the following Algorithm 2.
2.4. Stability Analysis of The CBDF2 Scheme
We first analyze the stability function of the CBDF2 scheme of a simple ODE
which is
The stability function S(z) has been proven to be bounded by one for all numbers on the left half complex plane and converge to zero as the real part of the complex number z tends to negative infinity with a particular value of the characteristic constant (Ying et al., 2008), i.e., the CBDF2 scheme is L-stable.
We then derive the global error of the CBDF2 scheme for Equation (20). Assume the function f(u) in Equation (20) is Lipschitz continuous in u over some feasible domain , i.e., there exists some constant L ≥ 0 such that |f(u)−f(u*)| ≤ L|u−u*| for all u and u* in . The local truncation error (LTE) of the CBDF2 scheme (Ying, 2005) has been proven to be
which is on the order of (Δt)3.
From the form of the second stage of the CBDF2 scheme (22), we have
where satisfies
Let Equation (25) subtract Equation (21) and we can obtain
where en = u(tn)−un and . By subtracting Equation (24) from Equation (22), we have the following inequality
i.e.,
where . When LΔt ≤ 1.12, we have and we can further obtain the global error of the CBDF2 scheme at simulation time T as
Similarly, the LTE of the BE method for the abstract form (20) is Δt2f′/2, while its global error satisfies
and has the form at simulation time T as
when LΔt ≤ 0.5. Since the restriction for the CBDF2 scheme is LΔt ≤ 1.12, the CBDF2 scheme allows a larger timestep than the BE method for the abstract form (20).
3. Numerical Results
In this section, we compare the numerical results from the BE and CBDF2 schemes with different spatial step sizes and timestep sizes. The computational domain is partitioned into a quasi-uniform triangular grid in the two-dimensional space and a hexahedral mesh in the three-dimensional space, respectively. A linear approximation is used to obtain the solution on each element. The detailed refinement of a coarser grid to get a finer grid and the numbering principle of the triangular grid are shown in Supplementary Figure 1. Denote the quasi-uniform partition by = {T(1), T(2), …, T(M)} with M being the total number of elements in the partition where T(i) is the i-th element. Denote h as the mesh parameter which measures the maximum of the elements' edges, i.e.,
The transmembrane polarization is driven by an extracellular stimulus which is modeled as a virtual battery with an anode and a cathode in the center of the domain (Vigmond et al., 2008) and is given by
where is a constant, r is the distance between x and the anode and s is the distance between x and the cathode.
The operator splitting technique (Qu and Garfinkel, 1999; Trangenstein and Kim, 2004; Sundnes et al., 2005) is also used to efficiently solve the bidomain equations where the linear diffusion part and the nonlinear reaction part are solved separately. To be specific, the Godunov splitting combined with the BE method and the Strang splitting combined with the CBDF2 scheme are used to solve the bidomain equations (see Supplementary Material for details). The linear system obtained from discretizing the diffusion part is solved by the standard multigrid V-cycle with Gauss-Seidel smoother. Notice that the coefficient matrix of the discrete linear system obtained from the operator splitting does not contain the evaluation of the derivative function , i.e., the second part of matrix A.
In the numerical simulation of the above methods, the membrane capacitance per unit area and the surface-to-volume ratio are set as Cm = 1 (units: μF/cm2) and β = 1, 000 (units: cm−1), respectively. Other constant parameters are set as , , and the number of smoothing iterations νMultigrid = 6. The absolute tolerance in the Newton iteration method for solving the nonlinear system (18) is chosen to be 10−10. The parameter δ in Equation (13) is selected to be 10−6 for all simulations. The units for the time steps, spatial steps, and voltage are milliseconds (ms), centimeters (cm), and millivolts (mV), respectively. The unit of conductivity is millisiemens per centimeter (mS/cm−1). The fully implicit integration methods are implemented with custom codes written in C++ and the numerical simulations are all performed on a 3.6 GHz computer with an Intel Core i3-4160 CPU.
We should mention that the computational domain is not limited to the regular areas. For example, circular regions can be divided into a quasi-uniform triangular grid by the same principle as shown in Supplementary Figure 8 and a solid sphere can be partitioned into a quasi-uniform tetrahedral mesh (Liu and Joe, 1996; Everett, 2010). The additional numerical results solved on a circle and sphere are shown in Supplementary Figures 9–13.
3.1. Numerical Example in Two-Dimensional Space
For the numerical simulations of the bidomain equations in the two-dimensional space, we model the square consisting of fibers which rotate counterclockwise around the point c = (c0, c1) = (−0.5, −0.5). The conductivity tensor is space dependent with unequal anisotropy ratios: in the intracellular space, it is 12.0 along the fiber and 2.0 perpendicular to the fiber; in the extracellular space, it is 8.0 along the fiber and 4.0 perpendicular to the fiber. The conductivity tensors Di(x) and De(x) with x = (x0, x1) can be expressed by
where , , , , , and with and . The positions of the anode and cathode are set as (0.875, 1.0) and (1.125, 1.0), respectively.
In this work, we first use a variant of the FitzHugh-Nagumo (Vfhn) model as the membrane dynamics which is governed by
with the parameters set as Vpeak = 1, G = 20, Vth = 0.125, α = 3, and γ = 1. The gating and ion concentration variables q, the intracellular potential Φi, and the extracellular potential Φe are set to be at rest at time t = 0.
We first discuss the numerical performance of the CBDF2 scheme. Using the same timestep size Δt = 1/32 and spatial step size h = 1/64, we compare the CBDF2 scheme with the other different time integration methods. A high precision solution obtained from the BE method using a very small timestep size Δt = 1/256 and spatial step size h = 1/256 is set as a benchmark. As shown in Figure 1, the CBDF2 scheme using a large timestep can obtain a highly accurate trajectory of the membrane voltage compared with the benchmark while that obtained from the BE method using a large timestep is inaccurate. Besides, the Strang operator splitting (SOS) combined with the CBDF2 scheme is stable but less accurate than the CBDF2 scheme in the membrane voltage trajectory. We point out that the Godunov operator splitting combined with the BE method is unstable using the timestep size Δt = 1/32 and spatial step size h = 1/64. Figure 2 shows the isopotential lines Vm = 0.1 at time T = 8.75 for the bidomain simulations from the above methods, while Figure 3 shows the isopotential lines Vm = 0.1 and the Newton iteration number obtained from the CBDF2 scheme using different timesteps.
Figure 1. The membrane voltage trajectories obtained from different methods with timestep size Δt = 1/32 and spatial size h = 1/64. A high precision solution is obtained from the BE method with a small timestep size Δt = 1/256 and spatial size h = 1/256. The membrane model is the Vfhn model.
Figure 2. The isopotential lines Vm = 0.1 at time T = 8.75 from different methods with timestep size Δt = 1/32 and spatial size h = 1/64. A high precision solution is obtained from the BE method with a small timestep size Δt = 1/256 and spatial size h = 1/256. (A) The isopotential lines in the entire computational domain. (B) A zoomed region of (A) to clearly display the different isopotential lines. (C) Contours for the transmembrane potential Vm of an anisotropic bidomain equation at T = 8.75 from the high precision solution.
Figure 3. (A) The isopotential lines Vm = 0.1 obtained from the CBDF2 scheme using different timesteps in the area around the point (1.4, 1) at T = 8. (B) The number of Newton iteration in each simulation using different timesteps sizes. The spatial step size in (A,B) is h = 1/64.
We next study the convergence of the four different time schemes, i.e., the BE method, the CBDF2 scheme, the Godunov splitting combined with the BE method, and the Strang splitting combined with the CBDF2 scheme with the Vfhn membrane model. Comparing with the high precision numerical solution obtained from the BE method with a quite small timestep size Δt = 1/512 and spatial step size h = 1/512, we compute the errors of the membrane voltage which is summed over the whole space at the discrete times. To be specific, we use the scaled discrete l2-norm of a vector defined as
to compute the error of voltage summed over the whole domain, i.e., . By halving both the timestep and spatial step size, we can obtain a first-order convergence of the BE method and the Godunov splitting combined with the BE method and a second-order convergence of the CBDF2 scheme and the Strang splitting combined with the CBDF2 scheme, respectively, as shown in Table 1.
Table 1. Errors of membrane potentials in the scaled discrete l2-norm of four different time integration methods.
We further consider two more realistic membrane models, i.e., the DiFrancesco and Noble (DFN) model (DiFrancesco and Noble, 1985; Cabo and Barr, 2006) and the Courtemanche et al. (CRN) model (Courtemanche et al., 1998) which have 15 and 20 state variables other than the transmembrane potential, respectively. In each simulation, the state variables q are all assumed to be at rest at time t = 0 and the initial condition of the membrane potential Vm is given by
The iso-contours and trajectories of the membrane voltage obtained from the CBDF2 scheme using the more realistic DFN and CRN models in the two-dimensional space is shown in Supplementary Figure 6.
We study the stability of the four different time integration methods with the DFN membrane model. The simulations for the bidomain equation with the DFN model use timestep sizes of 1/8, 1/16, 1/32, 1/64, 1/128, and spatial step sizes of 1/128. As shown in Table 2, the CBDF2 scheme is stable for the timestep sizes ≤ 1/8 while the BE method is stable for timestep sizes ≤ 1/32. The Strang operator splitting together with the CBDF2 scheme is stable for the timestep sizes less than or equal to 1/8 while the Godunov operator splitting together with the BE method is stable for the timestep sizes less than or equal to 1/16. The numerical results show that the CBDF2 scheme has better stability compared with the BE method which is consistent with the stability analysis in section 2.4.
Table 2. The comparison of CPU times (minutes) and the error of membrane voltage of the four methods.
As shown in Table 2, the Godunov splitting combined with the BE method is less stable than the Strang splitting combined with the CBDF2 scheme. A possible reason is that the BE method is less stable than the CBDF2 scheme. To fairly compare the stability of the Godunov splitting and Strang splitting, we further perform numerical experiments using Strang splitting combined with the BE method which allows using a much larger time step (maximum Δt ≈ 0.20) than the Godunov splitting combined with the BE method. Our experiments indicate that the Strang splitting has better stability than the Godunov splitting for the bidomain equations.
To compare the numerical accuracy of each scheme, a high precision solution is obtained from the BE method with a very small timestep Δt = 1/1, 024 and spatial step size h = 1/128. As shown in Table 2, the CBDF2 scheme using a large timestep Δt = 1/8 is more accurate and efficient compared with the BE method using a small timestep 1/64. Besides, the CBDF2 scheme, combined with the nonlinear elimination method, has better accuracy than the CBDF2 scheme combined with Strang operator splitting although taking a bit more time as shown in Table 2. Note that the errors in Table 2 do not convergence to zero as the timestep size is reduced. This is because the errors depend on both the timestep size and spatial step size which have a lower bound when using a fixed spatial step size.
We emphasize that the computational domain is not limited to the regular areas such as rectangle regions. Numerical results solved on a circular region which is partitioned into a quasi-uniform triangular grid (Liu and Joe, 1996; Everett, 2010) are given in Supplementary Figures 9, 10. The performance of the CBDF2 scheme is as well as that solved on the rectangle region.
3.2. Numerical Example in Three-Dimensional Space
The numerical methods introduced in this work can be straightforwardly extended to the case of three-dimensional space. For ease of illustration, we first simulate the bidomain equations with the Vfhn membrane on a unit cube x ∈ [0, 1]3 (). The extracellular stimulus in the three-dimensional space is given by applying a virtual battery with an anode and a cathode located at (0.375, 0.5, 0.5) and (0.625, 0.5, 0.5) in the center of the domain and is given by
where r is the distance between x and the anode and s is the distance between x and the cathode. The computational domain in three-dimensional space is partitioned into a quasi-uniform hexahedron mesh. We use a linear approximation to the solution on each element. The parameters, tolerances, and modules are set the same as those noted previously in this work.
In the case of three-dimensional space, the axially isotropic conductivity tensors are formulated as
where I is the 3 × 3 identity matrix, , , , and . The readers can refer to Neu and Krassowska (1993) and Ying (2005) for more details of the conductivity tensors.
The iso-contour and iso-surface plots of the membrane potential simulated on a unit cube are shown in Supplementary Figures 2–5. Additional numerical results obtained from simulating the bidomain equations in a solid sphere are shown in Supplementary Figures 11–13.
We then consider the DFN and CRN models in three-dimensional space. In each simulation, the state variables q are all assumed to be at rest at time t = 0 and the initial condition of the membrane potential Vm is given by
The iso-contours and trajectories of the membrane voltage obtained from the CBDF2 scheme using the more realistic DFN and CRN models in the three-dimensional space are shown in Supplementary Figure 7.
4. Discussion
In this work, we have presented two fully implicit methods, the BE and CBDF2 schemes, to numerically simulate the bidomain equations arising from modeling the electrical activity of the heart. The second-order CBDF2 scheme is L-stable for the stiff problems and uses the BE method as building blocks. The CBDF2 scheme has better accuracy and efficiency using a large timestep Δt = 1/8 compared with the BE method using a small timestep Δt = 1/64. When the error of membrane voltage for the CBDF2 and BE schemes are approximately the same, the CBDF2 scheme allows for timestep an order of magnitude larger than that used in the BE method. A further advantage of the CBDF2 scheme is that it allows temporal adaptivity to speedup, i.e., it can use a small timestep during the action potential upstroke period (stiff region) and a much larger timestep when the electrical activity is slowly varying (non-stiff region) (Ying, 2005; Whiteley, 2007). The CBDF2 scheme satisfies the requirement of stability, accuracy, and efficiency well which enable us to achieve a quantitative understanding of the relationship between molecular function and the integrated behavior of the cardiac myocyte in health and disease more effectively, e.g., to predict the clinical risk of drug-induced arrhythmias.
When using fully implicit methods to solve the bidomain equations, the obtained nonlinear systems are generally very large. We use a variant of the nonlinear elimination method (Lanzkron and Rose, 1997) to reduce the size of the system which includes the evaluation of the Jacobian matrix for each timestep. The spatially and temporally discretized nonlinear system (11) is solved with an approximate Newton method where the coefficient matrix of the residual system is symmetric and possibly positive definite consisting of the stiffness matrix, mass matrix, and the derivative function Jion. The linear residual equation can be efficiently solved by standard optimal solvers such as the V-cycle multigrid method (Saad, 2003). The derivative function Jion is time dependent and can be numerically evaluated with sufficient accuracy.
The computational domains in this work are square and cube (see Supplementary Figures 9–13 for results simulated on circle and sphere), but we emphasize that the CBDF2 scheme can be applied to more complicated computational domains since the generation rules of the finite element mesh in both two- and three-dimensional space do not depend on the particularity of the square or cube. The generation rules are applicable to more complex computational domains such as the realistic human left ventricle model (Cai et al., 2015) which will be presented in our future work.
In addition, the CBDF2 scheme using an adaptive mesh refinement algorithm can further improve the computational efficiency (Trangenstein and Kim, 2004; Ying, 2005; Whiteley, 2007). For the parallel implementation, the fully implicit methods proposed here leads to a full space independent system which is highly localized. As the inter-processor communication for updating the state variables by solving Equation (7) will be much less, the speedup for the simulations will be impressive when the membrane model including tens of or more state variables. In future works, we will consider more realistic computational domains such as the human left ventricle domain (Cai et al., 2015) combined with more realistic membrane models such as the Tusscher-Noble-Noble-Panfilov model (ten Tusscher et al., 2004) which can potentially help study new drugs and methods of treatment.
Data Availability Statement
The raw data supporting the conclusions of this article will be made available by the authors, without undue reservation.
Author Contributions
XG and WY: conception, design, code implementation, data analysis, and drafting. CH: design and critical revision. All authors contributed to the article and approved the submitted version.
Funding
This work was supported by National Science Foundation of the USA under Grant DMS 0915023, National Natural Science Foundation of China under Grants DMS 91330203, DMS 11101278, DMS 91130012, DMS 11771290, and Young Thousand Talents Program of China (WY).
Conflict of Interest
The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.
Supplementary Material
The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/fphys.2020.591159/full#supplementary-material
References
Cabo, C., and Barr, R. (2006). Propagation model using the difrancesco-noble equations. Med. Biol. Eng. Comput. 30, 292–302. doi: 10.1007/BF02446967
Cai, L., Gao, H., Luo, X., and Nie, Y. (2015). Multi-scale modelling of the human left ventricle. Sci. Sin. Phys. Mech. Astron. 45:024702. doi: 10.1360/SSPMA2013-00100
Courtemanche, M., Ramírez, R. J., and Nattel, S. (1998). Ionic mechanisms underlying human atrial action potential properties: insights from a mathematical model. Am. J. Physiol. 275, H301–H321. doi: 10.1152/ajpheart.1998.275.1.H301
Dal, H., Göktepe, S., Kaliske, M., and Kuhl, E. (2012). A fully implicit finite element method for bidomain models of cardiac electrophysiology. Comput. Methods Biomech. Biomed. Eng. 15, 645–656. doi: 10.1080/10255842.2011.554410
DiFrancesco, D., and Noble, D. (1985). A model of cardiac electrical activity incorporating ionic pumps and concentration changes. Philos. Trans. R. Soc. Lond. Ser. B Biol. Sci. 1133, 353–398. doi: 10.1098/rstb.1985.0001
dos Santos, R. W., Plank, G., Bauer, S., and Vigmond, E. J. (2004). Parallel multigrid preconditioner for the cardiac bidomain model. IEEE Trans. Biomed. Eng. 51, 1960–1968. doi: 10.1109/TBME.2004.834275
Everett, M. E. (2010). A three-dimensional spherical mesh generator. Geophys. J. R. Astron. Soc. 130, 193–200. doi: 10.1111/j.1365-246X.1997.tb00998.x
Hooke, N. F. (1992). Efficient simulation of action potential propagation in a bidomain. Thesis (Ph.D.). Durham, NC: Duke University. p.198-213.
Johnston, P. R. (2010). A finite volume method solution for the bidomain equations and their application to modelling cardiac ischaemia. Comput. Methods Biomech. Biomed. Eng. 13, 157–170. doi: 10.1080/10255840903067072
Keener, J., and Bogar, K. (1998). A numerical method for the solution of the bidomain equations in cardiac tissue. Chaos 8, 234–241. doi: 10.1063/1.166300
Keener, J. P., and Sneyd, J. (1998). Mathematical Physiology, Vol. 1. New York, NY: Springer. doi: 10.1007/b98841
Lanzkron, P., and Rose, D. (1997). An analysis of approximate nonlinear elimination. SIAM J. Sci. Comp. 17, 538–559. doi: 10.1137/S106482759325154X
Liu, A., and Joe, B. (1996). Quality local refinement of tetrahedral meshes based on 8-subtetrahedron subdivision. Math. Comput. Am. Math. Soc. 65, 1183–1200. doi: 10.1090/S0025-5718-96-00748-X
Murillo, M., and Cai, X.-C. (2004). A fully implicit parallel algorithm for simulating the non-linear electrical activity of the heart. Numer. Linear Algeb. Appl. 11, 261–277. doi: 10.1002/nla.381
Neu, J., and Krassowska, W. (1993). Homogenization of syncytial tissues. Crit. Rev. Biomed. Eng. 21, 137–199.
Pollard, A. E., Hooke, N., and Henriquez, C. S. (1992). Cardiac propagation simulation. Crit. Rev. Biomed. Eng. 20, 171–210.
Potse, M., Dubé, B., Richer, J., Vinet, A., and Gulrajani, R. M. (2006). A comparison of monodomain and bidomain reaction-diffusion models for action potential propagation in the human heart. IEEE Trans. Biomed. Eng. 53, 2425–2435. doi: 10.1109/TBME.2006.880875
Qu, Z., and Garfinkel, A. (1999). An advanced algorithm for solving partial differential equation in cardiac conduction. IEEE Trans. Biomed. Eng. 46, 1166–1168. doi: 10.1109/10.784149
Saad, Y. (2003). Iterative Methods for Sparse Linear Systems, Vol. 82. Chicago: SIAM. doi: 10.1137/1.9780898718003
Sundnes, J., Lines, G. T., Cai, X., Nielsen, B. F., Mardal, K.-A., and Tveito, A. (2007). Computing the Electrical Activity in the Heart, Vol. 1. Berlin: Springer Science & Business Media.
Sundnes, J., Lines, G. T., and Tveito, A. (2005). An operator splitting method for solving the bidomain equations coupled to a volume conductor model for the torso. Math. Biosci. 194, 233–248. doi: 10.1016/j.mbs.2005.01.001
ten Tusscher, K., Noble, D., Noble, P., and Panfilov, A. (2004). A model of human ventricular tissue. Am. J. Physiol. 286, H1573–H1589. doi: 10.1152/ajpheart.00794.2003
Trangenstein, J. A., and Kim, C. (2004). Operator splitting and adaptive mesh refinement for the luo-rudy i model. J. Comput. Phys. 196, 645–679. doi: 10.1016/j.jcp.2003.11.014
Tung, L. (1978). A bi-domain model for describing ischemic myocardial DC potentials (Ph.D. thesis). Massachusetts Institute of Technology, Cambridge, MA, United States.
Vigmond, E., Santos, R., Prassl, A., Deo, M., and Plank, G. (2008). Solvers for the cardiac bidomain equations. Prog. Biophys. Mol. Biol. 96, 3–18. doi: 10.1016/j.pbiomolbio.2007.07.012
Wesseling, P. (1995). Introduction to Multigrid Methods. John Wiley & Sons. Available online at: http://ftp.demec.ufpr.br/multigrid/Bibliografias/Wesseling_An%20Introduction%20to%20MultiGrid%20Methods.pdf
Whiteley, J. (2007). Physiology driven adaptivity for the numerical solution of the bidomain equations. Ann. Biomed. Eng. 35, 1510–1520. doi: 10.1007/s10439-007-9337-3
Whiteley, J. P. (2006). An efficient numerical technique for the solution of the monodomain and bidomain equations. IEEE Trans. Biomed. Eng. 53, 2139–2147. doi: 10.1109/TBME.2006.879425
Ying, W., Henriquez, C., and Rose, D. (2009). Composite backward differentiation formula: an extension of the TR-BDF2 scheme. Appl. Numer. Math.
Keywords: cardiac, bidomain equations, fully implicit methods, operator splitting, composite backward differentiation formula
Citation: Gao X, Henriquez CS and Ying W (2020) Composite Backward Differentiation Formula for the Bidomain Equations. Front. Physiol. 11:591159. doi: 10.3389/fphys.2020.591159
Received: 03 August 2020; Accepted: 24 November 2020;
Published: 14 December 2020.
Edited by:
Sanjay Ram Kharche, Western University, CanadaReviewed by:
Hao Gao, University of Glasgow, United KingdomJoakim Sundnes, Simula Research Laboratory, Norway
Copyright © 2020 Gao, Henriquez and Ying. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.
*Correspondence: Wenjun Ying, wying@sjtu.edu.cn