Skip to main content
  • Methodology article
  • Open access
  • Published:

A specialized ODE integrator for the efficient computation of parameter sensitivities

Abstract

Background

Dynamic mathematical models in the form of systems of ordinary differential equations (ODEs) play an important role in systems biology. For any sufficiently complex model, the speed and accuracy of solving the ODEs by numerical integration is critical. This applies especially to systems identification problems where the parameter sensitivities must be integrated alongside the system variables. Although several very good general purpose ODE solvers exist, few of them compute the parameter sensitivities automatically.

Results

We present a novel integration algorithm that is based on second derivatives and contains other unique features such as improved error estimates. These features allow the integrator to take larger time steps than other methods. In practical applications, i.e. systems biology models of different sizes and behaviors, the method competes well with established integrators in solving the system equations, and it outperforms them significantly when local parameter sensitivities are evaluated. For ease-of-use, the solver is embedded in a framework that automatically generates the integrator input from an SBML description of the system of interest.

Conclusions

For future applications, comparatively ‘cheap’ parameter sensitivities will enable advances in solving large, otherwise computationally expensive parameter estimation and optimization problems. More generally, we argue that substantially better computational performance can be achieved by exploiting characteristics specific to the problem domain; elements of our methods such as the error estimation could find broader use in other, more general numerical algorithms.

Background

In systems biology, mathematical models often take the form of system of ordinary differential equations (ODEs). These are approximations of the underlying mechanisms such as enzyme-catalyzed biochemical reactions that are applicable when molecule numbers are sufficiently high, and when the spatial distributions of components in a cell can be neglected. More specifically, ODE models consider the rate of change in a set of states (e.g. species concentrations) as a function of the system’s current state, its inputs, and its inherent kinetic parameters that capture, for instance, affinities of molecular interactions [1].

In contrast to systems modeling in domains such as physics, however, model parameters and initial conditions for systems biology models are often not known, or they can only be roughly approximated. As few kinetic parameters can be measured directly, parametric uncertainty often prevails [2]. How the system variables depend on these system parameters can therefore be of interest, e.g. to help find parameters such that the simulated system matches some observed or desired behavior. Dependencies between system variables and parameters are captured by the local parameter sensitivities that describe to what extent the state of the system changes when parameter values are perturbed from a reference value. Formally, local parameter sensitivities comprise the set of derivatives of all system variables with respect to the system parameters. As with the state dynamics, the parameter sensitivities’ time evolution follows a system of ODEs [3].

From a computational point of view it is important to note that in all but the simplest cases, starting from a set of initial conditions, there is no direct way to compute the solutions of a system of ODEs (states or parameter sensitivities in our case) for an arbitrary time. The variables are therefore integrated numerically in small steps over time, until the desired end time is reached. Consequently, efficient and accurate numerical integration methods are critical for many applications.

The computational effort for numerical integration is linked to the system size, and over time mathematical models have become increasingly detailed to achieve better predictions. Nevertheless, even models of moderate complexity result in numerical challenges when parameter sensitivities are needed. For instance, the parameter sensitivities can be integrated naively alongside the system variables, but this implies integrating a system of size n x ×(1 + n p ), where n x and n p are the number of system variables and system parameters respectively [3].

Additionally, the solution of a system of ODEs is often used in system identification processes where global optimization or probabilistic inference are required [4, 5]. In such cases, thousands, if not millions of trajectories need to be computed. Assessing the quality of the identified model, for instance with respect to the uncertainty in parameter values, again requires computing the local parameter sensitivities [6]. Although local sensitivity information can often help improve the overall estimation process, sensitivity computations are rarely included for performance reasons. Specific efficient methods exist for cases in which only scalar valued functionals are optimized [7] or oscillatory systems are considered [8]. Yet in many other cases, such as optimal control [9, 10], the identification of relevant parameters [11], model reduction and simplification [12] or parameter training [13], the full parameter sensitivities need to be computed. Consequently, improvements with respect to the speed with which the original ODE systems and their parameter sensitivities can be reliably integrated may affect the entire process significantly.

These issues are not new and they concern many application domains. Considerable efforts have been invested in establishing reliable and efficient general-purpose ODE solvers for dynamic systems and—to a lesser extent—for the associated parameter sensitivities. Here, however, we are concerned with solving systems of ODEs as they typically occur in the simulation of biochemical reaction networks in systems biology [6]. We show that rather general characteristics of such systems allow for the development of application domain-oriented ODE solvers with novel numerical features (with potential broader applicability), and with superior performance compared to state-of-the-art, widely employed general-purpose solvers. To provide some context for this claim, we first briefly review key characteristics of systems biology models in the form of ODEs, and general methods for the numerical integration of ODEs.

Dynamic models of (bio)chemical networks

When the effects of stochastic noise and of discrete molecule numbers are negligible, ODE systems can be used to describe chemical or biological reaction networks. Then x time-dependent state variables x i (t,p), i = 1…n x , which represent the concentrations of the molecules of interest at time t and are usually known at some initial time t = t0, evolve following

x ̇ (t,p):= x ( t , p ) ∂t =f(x(t),p),x( t 0 ,p)= x 0
(1)

where f(x(t),p) is a system of functionsf i (x(t),p) modelling the conversion rate of each respective variable x i (t,p)at time t, and pis a vector of n p system parameters.

The local parameter sensitivities with respect to some parameter p k are defined as

s k (t,p):= x ( t , p ) p k p = p 0
(2)

which is the vector of the derivatives of all variables x i with respect to the parameter p k . Similar to the dynamics in Eq. (1), the parameter sensitivities’ time evolution follows a system of ODEs given by differentiating Eq. (2) with respect to t:

s ̇ k (t,p):= 2 x ( t , p ) p k ∂t = f ( x ( t , p ) , p ) x ( t , p ) : = J f ( x ( t ) , p ) s k (t,p)+ f ( t , p ) p k ,
(3)

where J f (x(t)) is the Jacobian matrix of f(x(t)) with respect to x(t); note that we drop explicit dependencies on pto simplify notation. Initial conditions for Eq. (3) are set according to whether the initial conditions for the states in Eq. (1) depend on the parameters or not [3].

Consider, for example, the biochemical scheme of a Michaelis-Menten type enzymatic reaction

x 1 + x 2 k 2 k 1 x 3 k 3 x 1 + x 4
(4)

where x1−4correspond to enzyme, substrate, enzyme-substrate complex, and product concentrations, respectively. With mass-action kinetics, the reaction network translates to the dynamic system

x ̇ ( t ) = k 1 x 1 x 2 + ( k 2 + k 3 ) x 3 k 1 x 1 x 2 + k 2 x 3 + k 1 x 1 x 2 ( k 2 + k 3 ) x 3 + k 3 x 3 , p = k 1 k 2 k 3 .

Such problems are often well solved by general purpose ODE solvers, but (bio)chemical reaction networks offer a number of features that may be exploited by more specialized solvers, resulting in faster and/or more precise simulations. For instance, in enzyme kinetics, reversible association and dissociation processes are usually much faster than product formation. The resulting stiffness severely limits the types of numerical methods that can be used for ODE integration.

An opportunity for increasing solver efficiency, however, presents itself because most (bio)chemical reaction networks are only weakly interconnected. More specifically, the change in every concentration x i usually depends on the concentration of very few other products. Poor connectivity is reflected in sparse Jacobians J f (x(t)), where non-zero elements correspond to interactions between components (that is, we have a correspondence to the network graph’s adjacency matrix). For the simple example Eq. (4),

J f ( x ( t ) ) = ,

with closed and open circles indicating non-zero and zero elements, respectively. Even in this dense sub-network, the number of non-zeros nn z J =5/8 n x 2 implies that we do not need to compute a substantial number of terms to determine the Jacobian.

Many large-scale biological networks have a scale-free structure, that is, most of their nodes have few interactions, but a small number of hubs with many interactions exist [14]. This prevents an easy decomposition of a large network into subsystems that can be handled (and integrated) independently. Therefore, despite the sparsity of the Jacobian, model size remains a major issue for numerical performance.

Two more general aspects also need to be considered. Firstly, due to the growing use of abstract modeling software, the reactions and the underlying reaction equations are usually available to us as abstract models, such as smbl[15], which we can analyze and manipulate analytically. Secondly, since parametric uncertainty is abundant in biology, sensitivity analysis, i.e. the integration of the parameter sensitivities s k (t), requires particular attention. Hence, an ideal ODE solver for our application domain would efficiently and reliably handle large, stiff dynamic systems including their parameter sensitivities, and optimally exploit the systems’ non-trivial sparsity and analytic access.

Methods for ODE integration

Almost all ODE integrators work under the assumption that the change in each variable x i over time can be modeled using a polynomial in t. Consider the Taylor expansion of the variables x(t) around t = t0 to advance the system by a step of size h:

x( t 0 +h)=x( t 0 )+h x ∂t ( t 0 )+ h 2 2 ! 2 x t 2 ( t 0 )+ h 3 3 ! 3 x t 3 ( t 0 )+
(5)

If the factors kx(t) /  tk / k!decrease sufficiently quickly and the higher-order terms become insignificant as of some degree n, then we can reliably approximate the new solution by a polynomial of degree n in h. In explicit integrators, previously computed values of x(t) and the derivatives x(t) / ∂t are used to construct a polynomial g n (t) of degree n and to extrapolate the value of x(t + h) ≈ g n (t + h). In implicit integrators, a solution x(t + h) is sought such that it matches that of a polynomial g n (t) of degree n interpolated through previous values of x(t) and/or their derivatives, and the derivative at the solution x(t + h)itself. In general, implicit integrators are more accurate for stiff ODEs, where the derivatives in Eq. (5) do not decay sufficiently quickly.

Within the two larger classes, different integrators are characterized by the amount of previous values of x(t) and their derivatives which they use to approximate x(t + h). Table 1 lists some common integration methods; see [16] for a comprehensive review.

Table 1 Common ODE integration schemes and the values that are used to approximate the polynomial in Eq. (5)

Despite the commensurate degree of freedom in designing ODE integrators, and the number of algorithms for the numerical integration of ODEs that have been published over the past 40 years, only very few of them have found wide-spread application. Practical considerations—any method should be easily accessible to its end users, who are usually not interested in manipulating or even formulating the underlying equations themselves—are certainly major causes for this convergence [17]. However, a closer analysis of the most popular solvers for stiff ODE systems reveals another cause, namely incremental evolution.

In this area, the first major piece of software was the GEAR package [18], which by 1996 evolved into cvode[19], a part of the Sundials suite of nonlinear and differential/algebraic equation solvers [20]. The default integrators in Matlab (The MathWorks, Natick, MA) such as ode15s[21] employ similar integration rules and error estimates. Both the Sundials suite and Matlab are used increasingly in systems biology [22], but it is not evident that they are optimal for this application domain.

Methods

A second-derivative integrator

All ODE solvers mentioned above use only values of x(t)and x ̇ (t) to approximate x(t + h). Here, we differ from these methods in that we also employ the second derivatives:

x ̈ (t):= 2 x ( t ) t 2 = f ( x ( t ) ) ∂t = J f (x(t))f(x(t))
(6)

(for notational simplicity, we will write J f (t)and f(t) instead of J f (x(t)) and f(x(t)), respectively). Note that this second derivative with respect to the time t should not be confused with the second-order sensitivities described and used in [9, 10, 23], which are the second derivatives of the system variables with respect to the system parameters.

The use of second derivatives was first suggested in [24] and later studied in detail in [25], [26] and [27], and the resulting formulas were shown to have good stability properties. A more recent study [28] reinforces the stability and potential efficiency gains for stiff systems through second-derivative methods. However, despite several published implementations [27, 28], these methods have not yet found wide acceptance because, despite being A-stable, they are only stable at infinity if only the second derivative at t + h is used [25] (see Section S3 in Additional file 1 and Additional file 2 for details).

The second derivatives in Eq. (6) may seem somewhat clumsy and expensive to evaluate since they require the construction of the Jacobian J f (t) and the evaluation of a matrix-vector multiplication J f (t)f(t). Remember, however, that (bio)chemical reaction network models typically have sparse Jacobians. As a consequence, the cost of constructing J f (t) and of evaluating the product J f (t)f(t)grows only linearly with the number of variables and not quadratically, as the matrix-vector product would imply. Furthermore, since we usually have an abstract representation of the governing equations, we can compute each entry of x ̈ (t) explicitly, much in the same way we evaluate the entries of f(t). For instance, the explicit second derivatives of the system Eq. (4) are:

x ̈ ( t ) = J f ( t ) f ( t ) = k 1 x 2 f 1 k 1 x 1 f 2 + ( k 2 + k 3 ) f 3 k 1 x 2 f 1 k 1 x 1 f 2 + k 2 f 3 k 1 x 2 f 1 + k 1 x 1 f 2 ( k 2 + k 3 ) f 3 k 3 f 3 .

In most cases, the evaluation of the second derivatives is not much more expensive than the evaluation of f(t).

For our second-derivative integrator, we construct an interpolating polynomial g4(t) of degree n = 4 matching x(t)and the first and second derivatives at times t and t+h. This implicit method requires that we find x(t + h) such that

x ( t + h ) = g 4 ( t + h )

which, expanding g4(t + h), gives us

x(t+h)=x(t)+ h 2 x ̇ ( t ) + x ̇ ( t + h ) + h 2 12 x ̈ ( t ) x ̈ ( t + h ) .
(7)

where the right-hand side is the polynomial through x(t), x ̇ (t), x ̈ (t), x ̇ (t+h) and x ̈ (t+h) evaluated at t+h (this is, incidentally, the original scheme proposed in [24]). The solution to this system of equations can be computed iteratively. More specifically, we start from an initial guess x ~ (t+h) that is computed with an explicit formula, and use a simplified Newton’s Method:

x ( t + h ) x ( t + h ) M ( t + h ) 1 g 4 ( t + h ) x ( t + h ) ,
M(t+h):= h 2 J ~ f (t+h) h 2 12 J ~ Jf (t+h)I,
(8)

where M(t + h) is the Newton iteration matrix andJ Jf (t) is the Jacobian of Eq. (6) with respect to x(t):

J Jf (t):= J f ( t ) f ( t ) ∂x = J f ( t ) ∂x f(t)+ J f ( t ) 2
(9)

The Jacobians J ~ f (t+h) and J ~ Jf (t+h) are evaluated at the initial guess x ~ (t+h).

Using a second-derivative scheme, the evaluation of each Newton iteration is roughly twice as expensive as for first-derivative methods of the same degree since, in addition to f(t + h), we must also evaluateJ f (t + h)f(t + h). The advantage of this scheme, however, becomes obvious once we consider the truncation error. By replacing x(t + h) with the Taylor expansion around t, we obtain

g 4 ( t n + 1 )x( t n + 1 ) 1 720 h 5 x ( 5 ) (ξ),ξ[ t n , t n + 1 ]
(10)

for the truncation error of our second-derivative formula. For first-derivative methods of the same degree, assuming a constant step size h, this error is

BDF 4 ( t n + 1 ) x ( t n + 1 ) 72 750 h 5 x ( 5 ) ( ξ ) , ξ [ t n 3 , t n + 1 ] ,
AM 4 ( t n + 1 ) x ( t n + 1 ) 19 720 h 5 x ( 5 ) ( ξ ) , ξ [ t n 3 , t n + 1 ] ,

in the case of the BDF and the Adams-Moulton formula of degree four, respectively. These truncation errors are 72 times and 19 times larger than the error of our second-derivative formula (assuming the fifth derivative x(5)(t) is approximately constant in [tn−3,tn + 1], see Section S2 and Figure S1A in Additional file 1 and Additional file 2 for details). The large difference stems from the dependence of the interpolation error on the width of the interpolation interval, e.g. for the BDF and the Adams-Moulton formula, this interval is four times larger.

Error estimates and step size adjustment

In any ODE integration scheme, the local error estimate and the step-size adjustment are crucial to both its accuracy and its efficiency. The step-size adjustment uses the error estimate of a previous integration step to predict the largest possible next step h satisfying the required tolerance. With imprecise error estimates, the step-size adjustment has to be conservative to preserve accuracy, or it risks producing an imprecise result.

In most implicit ODE solvers, the local error is either estimated from the difference between the initial estimate x ~ (t+h), usually computed with an explicit rule, and the final converged step x(t + h), or as the difference between two rules of different degree over the previous x(t) and the converged step x(t + h). These approaches mainly consider computational efficiency because, ideally, to estimate the error of a formula of degree d1, we need to compute a better approximation of degree d2 > d1. The difference between both converged solutions x1(t + h) and x2(t + h) can then be used to approximate the difference between the lower-degree estimate and the exact solution x(t + h). However, this requires two Newton iterations to compute both solutions and if both rules have different weights for the values of x ̇ (t+h) and x ̈ (t+h), we would need to invert or decompose two different matrices to compute a Newton iteration (Eq. (8)).

We propose a different approach that may better reconcile accuracy with computational cost. We first compute the converged lower-degree solutionx1(t + h)and use it as an initial estimate for the Newton iteration of the higher-degree solution. Since we are not actually interested in the exact solution x2(t + h), but only in an approximation of the difference between the two solutions, it suffices to compute just one Newton step to get a first-oder approximation of that difference. Note that, in principle, this still requires the inversion or decomposition of a different matrix for the Newton iteration.

However, for our second-derivative solver, we can compute the second approximation as the polynomial g5(t) that interpolates x(t) at the same nodes as g4(t) plus the second to last node x(th−1). In this case, the weights in the Newton iteration matrix are similar. If the current step size h and the previous step size h−1 are equal, the weights for J f (t + h) and J Jf (t + h) are 14/31 and 2/31, respectively, which is close to the values for g4(t)of 1/2 and 1/12. We therefore re-use the Newton iteration matrix in Eq. (8) to compute the first approximation x1(t + h) and obtain the local error estimate

ε:= M ( t + h ) 1 g 5 ( t + h ) x ( t + h ) .
(11)

Note that the estimate ε approximates the truncation error Eq. (10). Assuming that x(5)(t)varies only slowly between two time steps, we can compute a scaling σ such that the error of the next step of size σh is equal to a prescribed tolerance τ:

ε= h 5 720 x ( 5 ) (ξ),τ= ( σh ) 5 720 x ( 5 ) (ξ)σ= τ ε 1 / 5 .
(12)

Note that if the assumptions on x(5)(t)do not hold, the error estimate in the next time step will fail, causing the step size to be reduced automatically. Furthermore, if we adjust h to fulfill the requested tolerance τ exactly, the error estimate will be larger than τapproximately half of the time. Therefore, in practice, we choose σ such that the next error will be τ/2. This gives us a recipe to adjust the step size from one integration step to the next and, hence, the last key ingredient of a functional second-derivative ODE solver (see Section S2 and Figure S1B of the Additional file 1 and Additional file 2 for details).

Parameter sensitivities

For n x variables and n p parameters, the naive approach to sensitivity calculation implies integrating a system of n x ×(1 + n p ) variables and, by consequence, inverting or decomposing matrices of that size within the Newton iteration. However, the system variables x(t)do not depend on the parameter sensitivities, yet the sensitivities depend on x(t). Hence, we can, in each step, first compute the values x(t + h) and, once they have converged, compute the s k (t + h)in a separate step using the same integration rule. This staggered approach was first introduced in Caracotsis & Stewart [29], then extended by Maly & Petzold [30], and finally implemented in the Sundials cvodes ODE solver, a modified version of cvode capable of sensitivity analysis [31].

To integrate the parameter sensitivities in our second-derivative solver in a similar way, we need to compute the second derivatives

s ̈ k ( t ) : = 2 s k ( t ) t 2 = ∂t J f ( t ) s k ( t ) + f ( t ) p k = J Jf s k ( t ) + x ̈ ( t ) p k .
(13)

The equation in the implicit step using the second-derivative rule in Eq. (7) for the parameter sensitivities s k (t) thus becomes

s k ( t + h ) = s k ( t ) + h 2 × s ̇ k ( t ) + J f ( t + h ) s k ( t + h ) + f ( t + h ) p k + h 2 12 s ̈ k ( t ) J Jf ( t + h ) s k ( t + h ) x ̈ ( t + h ) p k ,
(14)

which, after isolating the sole unknown term s k (t + h)leads to

I h 2 J f ( t + h ) + h 2 12 J Jf ( t + h ) s k ( t + h ) = s k ( t ) + h 2 s ̇ k ( t ) + f ( t + h ) p k + h 2 12 s ̈ k ( t ) x ̈ ( t + h ) p k .
(15)

We then have two alternatives to compute s k (t + h): either iteratively using Newton’s method to solve Eq. (14), or directly by inverting or decomposing the matrix on the left-hand side of Eq. (15). The iterative approach via Eq. (14) is equivalent to the one suggested in [30], and we can re-use the inverted or decomposed iteration matrix used to compute the variables x(t + h)in Eq. (8). However, one has to re-evaluate the Jacobians at each iteration to compute s ̇ k (t) and s ̈ k (t) because J ~ f (t+h) and J ~ Jf (t+h) are evaluated at the initial estimate x ~ (t+h), and not at the converged solution x(t + h). To compute s k (t + h)directly, which corresponds to the original approach in [29], we need to re-compute the Jacobians and the inverse or decomposition of the left-hand side of Eq. (15). For small n x , however, this extra matrix computation may be advantageous over running the Newton iteration for each parameter p k .

Furthermore, if the Jacobians do not vary significantly over time, they can be re-used as the matrices J ~ f (t) and J ~ Jf (t) for the Newton iteration of the next step. Such an approach offers an advantage if the cost of running an additional n p Newton iterations to compute the parameter sensitivities iteratively outweighs the cost incurred by the slower convergence due to using older Jacobians in the next step. In our second-derivative integrator, we therefore compute the parameter sensitivities directly as per Eq. (15).

Framework for conversion of SBML models

In order to generate the matrices J f (t) and J Jf (t), as well as the second derivative x ̈ (t) automatically, we established a framework that automatically translates arbitrary models from the standard SBML format [15] to Matlab functions or C-language code. The framework also generates routines to compute the parameter derivatives f(t)/ pand x ̈ (t)/p necessary for the parameter sensitivity computations. This conversion, which needs to be done only once per model, exploits the sparsity of the corresponding matrices by generating compact expressions for their non-zero entries only, making them efficient to evaluate. It uses the Matlab Symbolic Toolbox to manipulate, differentiate and simplify the resulting expressions automatically (see Sections S1.3 and S1.4 in the Additional file 1 and Additional file 2 for details).

Results and discussion

Implementation and testing

We implemented the second-derivative ODE integrator as odeSD in Matlab and as odeSD mex in the C programming language, using the Matlab mex interface with calls to the LAPACK and BLAS libraries for the linear algebra operations. Both solvers provide an interface similar to that of the Matlab default integrators. Additionally, a native C-language version, odeSD c , was implemented for use outside of the Matlab programming environment. All implementations could operate on any type of ODE-based model, but the overall implementation is targeted to systems biology models in standard SBML format, for which we developed an automatic model conversion framework (see Methods). The implementation details are described in Sections S1.1 and S1.2 of the Additional file 1 and Additional file 2.

We compared our algorithm against three integrators which use Newton’s method to compute each implicit step:

  1. 1.Matlab’s

    default integrator for stiff systems, ode15s[21], which uses a 5-point Numerical Differentiation Formula (NDF), a more stable variant of the BDF integration rules; it is used as the default integrator in SBToolbox2 [22],

  2. 2.the

    cvode integrator from the Sundials suite [20] which employs variable-order BDFs of up to degree 4; it is the integrator used in the SBML ODE Library (SOSlib) [32], and

  3. 3.the

    radau5 integrator, a fifth-order three-stage implicit Runge-Kutta method for stiff systems described in [33] and implemented in Matlab [34].

The Matlab interface supplied by the sundialsTB toolbox [35] served to run the Sundials integrators which are implemented in C.

For performance evaluation, we selected a number of curated systems biology models from the BioModels database [36] (Table 2). This set comprises systems of different sizes (up to the largest models available in the database) and characteristics, namely convergence to steady-state and (stiff) oscillatory behavior. Note that all models have sparse Jacobians, as is evident from the number of non-zero elements nnz(J f ).

Table 2 Systems biology test models and their key characteristics, namely number of states (n x ), number of parameters (n p ), number of non-zeros of the Jacobians nnz(J f ), integration time interval (t), and biological system described by the model

Integrator performance without parameter sensitivities

The results of the performance comparison without sensitivity analysis for a wide range of integration tolerances are summarized in Figure 1 (see Additional file 1: Figures S2-3 for details). The average computational times for our integrator were comparable (odeSD mex vs. cvode) to, or slightly lower (odeSD vs. ode15s or radau5) than those of the first-derivative solvers (Figure 1A), except for low numerical tolerances. Importantly, the second-derivative integrator required approximately half as many steps as ode15s or cvode (Figure 1B), despite these three integrators using rules of the same degree of precision. The radau5 integrator used less steps than odeSD, but it computes two additional intermediate steps per full step. The smaller number of steps in odeSD is due to a combination of both the smaller truncation error of the second-derivative rule and the better accuracy of the improved error estimate. For more detailed results and discussion, see Section S3 and Figure S2 of the the Additional file 1 and Additional file 2.

Figure 1
figure 1

Performance comparison without parameter sensitivities. Performance comparison for integration of ODE-based systems biology models without parameter sensitivities. (A) Computation times, (B) number of integration steps, (C) number of r.h.s. evaluations f(x), and (D) number of evaluations of the Jacobian J f (x)as a function of the relative numerical tolerance. Symbols specify the integrators ode15s (open red squares), radau5 (open green diamonds), odeSD (open black circles), and odeSD mex (filled black circles), respectively. Performance metrics are normalized to the corresponding measures for cvode and averaged (mean ±std.) over all models, which were integrated over the time spans given in Table 2; the dashed line indicates performance equal to cvode. (E) Computation times and (F) number of integration steps as a function of numerical precision (see main text for definition) in analogy to (A) and (B).

To assess the relative accuracy of odeSD, we compared the results of all models computed with different relative tolerances with an ‘accurate’ reference solution computed using radau5 with the relative tolerance set to 10−15, analogously to the precision/work tests in [26]. The measured precision for each model and integrator is the maximum relative error in the final step for each state larger than machine precision in the reference solution. Figure 2 shows these results for all models in Table 2. These results are summarized in Figure 1E with the CPU time averaged over all models and the precision binned to the closest power of 10. Overall, without computing the parameter sensitivities, the new integrator is competitive, in terms of accuracy and efficiency, with highly optimized state of the art solvers for hard numerical problems in our application domain.

Figure 2
figure 2

Precision/work diagrams without parameter sensitivities. Precision-work diagrams for integration without parameter sensitivities. (A-J) Computation times for the individual models (see X-axis for model specifications) as a function of precision using odeSD (open black circles), odeSD mex (filled black circles), ode15s (red squares), radau5 (green diamonds), and cvodes (blue squares). All models were integrated for the time spans shown in Table 2.

Integrator performance with parameter sensitivities

The performance comparison with sensitivity calculations requires two additional considerations: Since ode15s and radau5 do not provide any special functionality for computing parameter sensitivities, we used an augmented system of size n x ×(n p + 1)including an analytic sparse Jacobian for each model, and the sensitivities s k (t), k=1…m were integrated alongside the system variables. cvodes, the sensitivity analysis-enabled version of cvode from the sundials package, uses a simultaneous integrator based on the method of Maly & Petzold [47]. Optionally, the staggered integrator of Feehery et al.[30] can be selected, but this did not produce better results.

In all cases, parameter sensitivities were integrated to the same precision as the system variables. As with the integration without sensitivities, precision/work diagrams were computed for all models with sensitivities, omitting the cases in which ode15s failed completely.

As one detailed example, Figure 3A shows the computation times for a relative tolerance of 10−6. In most cases, the compute times with sensitivities are substantial (see also Additional file 1: Figure S3 for other tolerances). For ode15s and radau5, the size of the augmented system quickly becomes a problem as the solution of the linear system of equations in the Newton iteration scales cubically with the number of variables. In terms of the additional effort for the sensitivity computation, we note that the second-derivative integrators are more efficient, often increasing the compute time only two- or three-fold, whereas the overhead is substantial for cvodes (Figure 3B). The results for cvodes are best explained if we keep in mind that whenever the right-hand side f(·) is evaluated, the algorithm also computes s ̇ k (t), k=1…n p , which, as per Eq. (3), requires an evaluation of the Jacobian J f (·). As a consequence, our second-derivative integrator outperforms the Sundials solver when implemented in C using the Matlab mex interface (odeSD mex ), and even in native Matlab (odeSD) for all larger models. Note that the higher compute times for odeSD mex vs. odeSD in some cases are the result of a more refined handling of near-singular matrices by Matlab in the latter.

Figure 3
figure 3

Performance comparison with parameter sensitivities. Performance comparison with parameter sensitivities. (A) Computation times for the individual models listed in Table 2 with relative tolerance of 10−6using odeSD (white bars), odeSD mex (black), ode15s (red), radau5 (green), and cvodes (blue). Due to the explosion in compute time, the three largest steady-state models were not evaluated with ode15s and radau5. (B) CPU times with sensitivity calculation as in (A) relative to CPU times without sensitivity calculation. (C) Average, normalized (see below) CPU times with sensitivities as a function of the relative numerical tolerance for odeSD (open circles) and odeSD mex (filled circles) relative to cvodes. (D) Relative numbers of integration steps (open black circles), of function evaluations f(x)(filled black circles), and of evaluations of the Jacobians J·(·)(open red squares) for odeSD mex compared to cvodes, respectively. In all cases, model and sensitivity equations were integrated for the time spans shown in Table 2. Performance metrics in (C, D) are normalized to the corresponding measures for cvodes and averaged (mean ±std.); the dashed line indicates performance equal to cvodes.

In order to obtain results independent of any potential inefficiencies of the Matlab interface, the same performance analysis was run using odeSD c and cvodes with natively compiled C-language functions for the right-hand sides. The results of this comparison are summarized in Figure 4 (see Additional file 1: Figure S4 in the Additional file 1 and Additional file 2 for the detailed precisionwork diagrams).

Figure 4
figure 4

Performance comparison of C-language integrators with parameter sensitivities. Performance comparison with parameter sensitivities of the C-language version odeSD c with cvodes using the automatically generated, compiled C-language right-hand side and Jacobian functions. (A) Computation times for the individual models listed in Table 2 with relative tolerance of 10−6using odeSD (white bars) and cvodes (black). (B) Average, normalized (see below) CPU times as a function of the relative numerical tolerance for odeSD relative to cvodes. In all cases, model and sensitivity equations were integrated for the time spans shown in Table 2. Performance metrics in (B) are normalized to the corresponding measures for cvodes and averaged (mean ±std.); the dashed line indicates performance equal to cvodes.

The higher efficiency of odeSD, odeSD mex and odeSD c holds also for averages over all models and for a wide range of numerical tolerances (Figure 3C). Except for high-precision integration, we achieve approximately two to three-fold speed-ups. These general findings also hold when compute time is assessed as a function of numerical precision (Figure 5).

Figure 5
figure 5

Precision/work diagrams with parameter sensitivities. Precision-work diagrams for integration with parameter sensitivities. (A-G) Computation times for all models for which the systems dynamics were solved with all ODE integrators (see X-axis for model specifications) as a function of precision using odeSD (open black circles), odeSD mex (filled black circles), ode15s (red squares), radau5 (green diamonds), and cvodes (blue squares). The models were integrated for the time spans shown in Table 2.

To explain the performance, consider that although odeSD and odeSD mex also evaluate the Jacobians in each step, both the much smaller number of steps required (Figure 3D), which is of no particular advantage when the parameter sensitivities are not computed, and the re-use of the Jacobians for sensitivity computations lead to significantly shorter execution times since substantially fewer evaluations of f(·) and of the Jacobians J(·)(·)are needed (Figure 3D). Since the latter dominates the integration cost, all three versions of odeSD outperform cvodes in all but the smallest systems. These results are not a consequence of the sparsity of the systems per se, but of the more precise integration rule which can be computed efficiently thanks to sparsity. The better error estimate and the computation of local parametric sensitivities are therefore particular strengths of our ODE solver based on second derivatives.

Conclusions

We have presented an integrator for ODE systems resulting from the modeling of chemical and biological reaction networks, which are often stiff and sparse. For the realistic systems biology models tested, the new integrator outperforms commonly used state of the art integrators when parameter sensitivities are required. It is competitive in integrating the system equations alone, despite limitations for specific models near the steady state. The improvements with respect to sensitivity calculations are critical for many applications to drive highly compute-intensive (global) optimization and estimation processes.

The improvements themselves are due to a combination of several factors: The more accurate second-derivative rule allows us, in combination with a better error estimate, to take larger steps, which in turn allows us to reduce the number of otherwise expensive sensitivity calculations. The re-use of the Jacobians from the sensitivity calculations further reduces the total computational costs. Although each integration step is more expensive than in first-derivative methods, due to the additional second-derivative information that needs to be computed, far less steps are required in total, resulting in a more efficient method.

To be of practical relevance for applications in systems biology, odeSD and odeSD mex are accessible via Matlab interfacesa, and we plan to make them more easily available through integrated modeling environments such as the SBToolbox2 [22] and COPASI [48], e.g. via the native C-language interface. To accelerate larger optimization and estimation processes, further efficiency improvements through the use of sparse matrix routines and by more elaborate step size control schemes are possible.

In terms of numerical algorithms, to our knowledge, this is the first practical application of a second-derivative integration method with good performance. Key, novel features of our integrator, such as a more precise error estimator and direct computation of parameter sensitivities with re-use of the Jacobians, may well be suited for other problems or types of integrators. Importantly, while our integrator has been developed for (bio)chemical and reaction networks, it is still quite general in targeting stiff and sparse ODE systems. Overall, we feel that a lot is to be gained by adapting general algorithms to specific problem domains, and that results from the work on specific problems can spill over to the broader field.

Availability

The integrator (Matlab and C-language versions) and the model conversion framework are available via http://www.csb.ethz.ch/tools.

Endnotes

aWe note that it is not possible to execute odeSD mex in the 64-bit Windows version of Matlab R2010a as well as in 64-bit Linux versions prior to R2010a in our testing environments, for reasons of memory allocation problems in Matlab.

References

  1. Chen WW, Niepel M, Sorger PK: Classic and contemporary approaches to modeling biochemical reactions. Genes Dev 2010,24(17):1861-1875. http://dx.doi.org/10.1101/gad.1945410 10.1101/gad.1945410

    Article  CAS  Google Scholar 

  2. Gutenkunst RN, Waterfall JJ, Casey FP, Brown KS, Myers CR, Sethna JP: Universally sloppy parameter sensitivities in systems biology models. PLoS Comput Biol 2007,3(10):1871-1878. http://dx.doi.org/10.1371/journal.pcbi.0030189

    CAS  Google Scholar 

  3. Turányi T, Rabitz H: Local methods. In Sensitivity analysis. Edited by: Saltelli A, Chan K, Scott E. Chichester, UK: John Wiley & Sons, Ltd.; 2000:81-100.

    Google Scholar 

  4. Banga JR, Balsa-Canto E: Parameter estimation and optimal experimental design. Essays in Biochem: Syst Biol 2008, 45: 195-209.

    Article  CAS  Google Scholar 

  5. Cheng H, Sandu A: Efficient uncertainty quantification with the polynomial chaos method for stiff systems. Math Comput Simul 2009,79(11):3278-3295. 10.1016/j.matcom.2009.05.002

    Article  Google Scholar 

  6. Doyle FJ, Stelling J: Systems interface biology. J R Soc Interface 2006,3(10):603-616. 10.1098/rsif.2006.0143

    Article  Google Scholar 

  7. Cao Y, Li S, Petzold L, Serban R: Adjoint Sensitivity Analysis for Differential-Algebraic Equations: The Adjoint DAE System and Its Numerical Solution. SIAM J Sci Comput 2003,24(3):1076-1089. 10.1137/S1064827501380630

    Article  Google Scholar 

  8. Wilkins AK, Tidor B, White J, Barton PI: Sensitivity Analysis for Oscillating Dynamical Systems. SIAM J Sci Comput 2009,31(4):2706-2732. 10.1137/070707129

    Article  Google Scholar 

  9. Vassiliadis VS, Canto EB, Banga JR: Second-order sensitivities of general dynamic systems with application to optimal control problems. Chem Eng Sci 1999,54(17):3851-3860. 10.1016/S0009-2509(98)00432-1

    Article  CAS  Google Scholar 

  10. Balsa-Canto E, Banga JR, Alonso AA, Vassiliadis VS: Efficient Optimal Control of Bioprocesses Using Second-Order Information. Ind Eng Chem Res 2000,39(11):4287-4295. 10.1021/ie990658p

    Article  CAS  Google Scholar 

  11. Sher A, Wang K, Wathen A, Mirams G, Abramson D, Gavaghan D: A Local Sensitivity Analysis Method for Developing Biological Models with Identifiable Parameters: Application to L-type Calcium Channel Modelling. IEEE Sixth International Conference on e-Science 2010, 176-181.

    Google Scholar 

  12. Liu G, Swihart MT, Neelamegham S: Sensitivity, principal component and flux analysis applied to signal transduction: the case of epidermal growth factor mediated signaling. Bioinformatics 2005,21(7):1194-1202. 10.1093/bioinformatics/bti118

    Article  CAS  Google Scholar 

  13. Chen WW, Schoeberl B, Jasper PJ, Niepel M, Nielsen UB, Lauffenburger DA, Sorger PK: Input-output behavior of ErbB signaling pathways as revealed by a mass action model trained against dynamic data. Mol Syst Biol 2009.,5(239):

  14. Barabási AL, Oltvai Z: Network biology: understanding the cell’s functional organization. Nat Rev Genet 2004, 5: 101-13. 10.1038/nrg1272

    Article  Google Scholar 

  15. Hucka M, Finney A, Sauro H, Bolouri H, Doyle J, Kitano H, Arkin A, Bornstein B, Bray D, Cornish-Bowden A, Cuellar A, Dronov S, Gilles E, Ginkel M, Gor V, Goryanin I, Hedley W, Hodgman T, Hofmeyr J, Hunter P, Juty N, Kasberger J, Kremling A, Kummer U, Novere NL, Loew L, Lucio D, Mendes P, Minch E, Mjolsness E, Nakayama Y, Nelson M, Nielsen P, Sakurada T, Schaff J, Shapiro B, shimizu T, Spence H, Stelling J, Takahashi K, Tomita M, Wagner J, Wang J: The Systems Biology Markup Language (SBML): a medium for representation and exchange of biochemical network models. Bioinformatics 2003,19(4):524-31. 10.1093/bioinformatics/btg015

    Article  CAS  Google Scholar 

  16. Gupta GK, Sacks-Davis R, Tischer PE: A Review of Recent Developments in Solving ODEs. ACM Comput Surv 1985, 17: 5-47. 10.1145/4078.4079

    Article  Google Scholar 

  17. Cash JR: Efficient numerical methods for the solution of stiff initial-value problems and differential algebraic equations. Proc R Soc London Series a-Math Phys Eng Sci 2002,459(2032):797-815.

    Article  Google Scholar 

  18. Hindmarsh AC: GEAR: Ordinary Differential Equation System Solver.. Technical Report UCID-30001, Rev. 3, Lawrence Livermore National Laboratory 1974

  19. Cohen SD, Hindmarsh AC: CVODE, a stiff/nonstiff ODE solver in C. Comput Phys 1996,10(2):138-143.

    Article  Google Scholar 

  20. Hindmarsh AC, Brown PN, Grant KE, Lee SL, Shumaker DE, S WC, R S: SUNDIALS: Suite of Nonlinear and Differential/Algebraic Equation Solvers. ACM Trans on Math Software 2005,31(3):363-396. 10.1145/1089014.1089020

    Article  Google Scholar 

  21. Shampine LF, Reichelt MW: The MATLAB ODE Suite. SIAM J Sci Comput 1997, 18: 1-22. 10.1137/S1064827594276424

    Article  Google Scholar 

  22. Schmidt H, Jirstrand M: Systems Biology Toolbox for MATLAB: a computational platform for research in systems biology. Bioinformatics 2006,22(4):514-5. [Schmidt, Henning Jirstrand, Mats Research Support, Non-U.S. Gov’t England Bioinformatics (Oxford, England) Bioinformatics. 2006 Feb 15;22(4):514-5. Epub 2005 Nov 29.]. 10.1093/bioinformatics/bti799

    Article  CAS  Google Scholar 

  23. Özyurt DB, Barton PI: Cheap second order directional derivatives of stiff ODE embedded functionals. SIAM J Sci Comput 2005,26(5):1725-1743. 10.1137/030601582

    Article  Google Scholar 

  24. Obrechkoff N: Sur les quadrature mecaniques. Spisanic Bulgar Akad Nauk 1942, 65: 191-289. [Reviewed in Mat. Rev. 10:70]

    Google Scholar 

  25. Enright WH: Second derivative multistep methods for stiff ordinary differential equations. SIAM J Numer Anal 1974,11(2):321-331. 10.1137/0711029

    Article  Google Scholar 

  26. Hairer E, Norsett S, Wanner G: Solving Ordinary Differential Equations I. Berlin: Springer Verlag; 1987.

    Book  Google Scholar 

  27. Addison CA, Gladwell I: Second derivative methods applied to implicit first- and second-order systems. Int J Numer Methods Eng 1984,20(7):1211-1231. 10.1002/nme.1620200704

    Article  Google Scholar 

  28. Corliss G, Griewank A, Henneberger P, Kirlinger G, Potra F, Stetter H: High-order stiff ODE solvers via automatic differentiation and rational prediction. In Numerical Analysis and Its Applications, Volume 1196 of Lecture Notes in Computer Science. Edited by: Vulkov L, Wasniewski J, Yalamov P. Berlin /Heidelberg; 1997:114-125.

    Google Scholar 

  29. Caracotsios M, Stewart WE: Sensitivity analysis of initial value problems with mixed ODEs and algebraic equations. Comput Chem Eng 1985,9(4):359-365. 10.1016/0098-1354(85)85014-6

    Article  CAS  Google Scholar 

  30. Feehery WF, Tolsma JE, Barton PI: Efficient sensitivity analysis of large-scale differential-algebraic systems. Appl Numer Math 1997, 25: 41-54. 10.1016/S0168-9274(97)00050-0

    Article  Google Scholar 

  31. Serban R, Hindmarsh AC: CVODES, the sensitivity-enabled ODE solver in SUNDIALS. Proceedings of the ASME International Design Engineering Technical Conferences and Computers and Information in Engineering Conference, Vol 6, Pts A-C 2005, 257-269.

    Google Scholar 

  32. Machné R, Finney A, Müller S, Lu J, Widder S, Flamm C: The SBML ODE Solver Library: a native API for symbolic and fast numerical analysis of reaction networks. Bioinformatics 2006,22(11):1406-1407. 10.1093/bioinformatics/btl086

    Article  Google Scholar 

  33. Hairer E, Wanner G: Solving Ordinary Differential Equations II: Stiff and Differential-Algebraic Problems. Berlin: Springer Verlag; 1991.

    Book  Google Scholar 

  34. Engstler C: Matlab implementation of the Radau IIA method of order5 by Ch. Engstler after the Fortran Code RADAU5 of Hairer/Wanner. 1999.http://na.uni-tuebingen.de/projects.shtml

    Google Scholar 

  35. Serban R: sundialsTB v2.4.0, a Matlab interface to Sundials.. 2009. Technical Report UCRL-SM-212121, Lawrence Livermore National Laboratory

    Google Scholar 

  36. Li C, Donizelli M, Rodriguez N, Dharuri H, Endler L, Chelliah V, Li L, He E, Henry A, Stefan MI, Snoep JL, Hucka M, Novère NL, Laibe C: BioModels Database: An enhanced, curated and annotated resource for published quantitative kinetic models. BMC Syst Biol 2010, 4: 92. http://dx.doi.org/10.1186/1752-0509-4-92 10.1186/1752-0509-4-92

    Article  Google Scholar 

  37. Hornberg JJ, Bruggeman FJ, Binder B, Geest CR, de Vaate AJMB, Lankelma J, Heinrich R, Westerhoff HV: Principles behind the multifarious control of signal transduction. ERK phosphorylation and kinase/phosphatase control. FEBS J 2005, 272: 244-258.

    Article  CAS  Google Scholar 

  38. Kholodenko BN, Demin OV, Moehren G, Hoek JB: Quantification of short term signaling by the epidermal growth factor receptor. J Biol Chem 1999,274(42):30169-30181. 10.1074/jbc.274.42.30169

    Article  CAS  Google Scholar 

  39. Singh A, Jayaraman A, Hahn J: Modeling regulatory mechanisms in IL-6 signal transduction in hepatocytes. Biotechnol Bioeng 2006,95(5):850-862. 10.1002/bit.21026

    Article  CAS  Google Scholar 

  40. Borisov N, Aksamitiene E, Kiyatkin A, Legewie S, Berkhout J, Maiwald T, Kaimachnikov NP, Timmer J, Hoek JB, Kholodenko BN: Systems-level interactions between insulin-EGF networks amplify mitogenic signaling. Mol Syst Biol 2009, 5: 256.

    Article  Google Scholar 

  41. Ung CY, Li H, Ma XH, Jia J, Li BW, Low BC, Chen YZ: Simulation of the regulation of EGFR endocytosis and EGFR-ERK signaling by endophilin-mediated RhoA-EGFR crosstalk. FEBS Lett 2008,582(15):2283-2290. 10.1016/j.febslet.2008.05.026

    Article  CAS  Google Scholar 

  42. Elowitz MB, Leibler S: A synthetic oscillatory network of transcriptional regulators. Nature 2000,403(6767):335-338. 10.1038/35002125

    Article  CAS  Google Scholar 

  43. Leloup Goldbeter: Chaos and birhythmicity in a model for circadian oscillations of the PER and TIM proteins in Drosophila. J Theor Biol 1999,198(3):445-459. 10.1006/jtbi.1999.0924

    Article  CAS  Google Scholar 

  44. Wolf J, Sohn H, Heinrich R, Kuriyama H: Mathematical analysis of a mechanism for autonomous metabolic oscillations in continuous culture of Saccharomyces cerevisiae. FEBS Lett 2001,499(3):230-234. 10.1016/S0014-5793(01)02562-5

    Article  CAS  Google Scholar 

  45. Goldbeter A, Pourquié O: Modeling the segmentation clock as a network of coupled oscillations in the Notch, Wnt and FGF signaling pathways. J Theor Biol 2008,252(3):574-585. 10.1016/j.jtbi.2008.01.006

    Article  CAS  Google Scholar 

  46. Xie Z, Kulasiri D: Modelling of circadian rhythms in Drosophila incorporating the interlocked PER/TIM and VRI/PDP1 feedback loops. J Theor Biol 2007,245(2):290-304. 10.1016/j.jtbi.2006.10.028

    Article  CAS  Google Scholar 

  47. Maly T, Petzold LR: Numerical methods and software for sensitivity analysis of differential-algebraic systems. Appl Numer Math 1996,20(1-2):57-79. 10.1016/0168-9274(95)00117-4

    Article  Google Scholar 

  48. Mendes P, Hoops S, Sahle S, Gauges R, Dada J, Kummer U: Computational modeling of biochemical networks using COPASI. Methods Mol Biol 2009, 500: 17-59. http://dx.doi.org/10.1007/978-1-59745-525-1_2 10.1007/978-1-59745-525-1_2

    Article  CAS  Google Scholar 

Download references

Acknowledgements

We thank Ernst Hairer for comments and discussions. This work was supported by the EU FP6 project BaSysBio (LSHG-CT-2006-037469), the EU FP7 project UniCellSys (HEALTH-F4-2008-201142), the Swiss Initiative for Systems Biology SystemsX.ch (RTD project YeastX), by an ETH Excellence Scholarship (LW), and by Swiss National Science Foundation’s Individual Support Fellowships Nr. PBEZP2-127959 and Nr. PA00P2-134146 (PG).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Jörg Stelling.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

PG developed the second-derivative integration scheme for the parameter sensitivities and the new error estimate, as well as the final Matlab, mex and C-language versions. SD developed the automatic generation of the right-hand sides. LW implemented and tested the first versions of the integrator. JS designed and conducted the experiments. Both PG and JS wrote the manuscript, which was read and approved by all authors.

Electronic supplementary material

12918_2011_986_MOESM1_ESM.pdf

Additional file 1:Supplementary Text and Figures for A Specialized ODE Integrator for the Efficient Computation of Parameter Sensitivities. (PDF 349 KB)

12918_2011_986_MOESM2_ESM.zip

Additional file 2:Supplementary Source Code for A Specialized ODE Integrator for the Efficient Computation of Parameter Sensitivities. (ZIP 260 KB)

Authors’ original submitted files for images

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Gonnet, P., Dimopoulos, S., Widmer, L. et al. A specialized ODE integrator for the efficient computation of parameter sensitivities. BMC Syst Biol 6, 46 (2012). https://doi.org/10.1186/1752-0509-6-46

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1752-0509-6-46

Keywords