Abstract
Birth-death processes track the size of a univariate population, but many biological systems involve interaction between populations, necessitating models for two or more populations simultaneously. A lack of efficient methods for evaluating finite-time transition probabilities of bivariate processes, however, has restricted statistical inference in these models. Researchers rely on computationally expensive methods such as matrix exponentiation or Monte Carlo approximation, restricting likelihood-based inference to small systems, or indirect methods such as approximate Bayesian computation. In this paper, we introduce the birth/birth-death process, a tractable bivariate extension of the birth-death process, where rates are allowed to be nonlinear. We develop an efficient algorithm to calculate its transition probabilities using a continued fraction representation of their Laplace transforms. Next, we identify several exemplary models arising in molecular epidemiology, macro-parasite evolution, and infectious disease modeling that fall within this class, and demonstrate advantages of our proposed method over existing approaches to inference in these models. Notably, the ubiquitous stochastic susceptible-infectious-removed (SIR) model falls within this class, and we emphasize that computable transition probabilities newly enable direct inference of parameters in the SIR model. We also propose a very fast method for approximating the transition probabilities under the SIR model via a novel branching process simplification, and compare it to the continued fraction representation method with application to the 17th century plague in Eyam. Although the two methods produce similar maximum a posteriori estimates, the branching process approximation fails to capture the correlation structure in the joint posterior distribution.
Keywords: stochastic models, birth-death process, infectious disease, SIR model, transition probabilities
1 Introduction
Birth-death processes have been used extensively in many applications including evolutionary biology, ecology, population genetics, epidemiology, and queuing theory (see e.g. Novozhilov et al, 2006; Crawford and Suchard, 2012; Doss et al, 2013; Rabier et al, 2014; Crawford et al, 2015). However, establishing analytic and computationally practical formulae for their transition probabilities is usually difficult (Novozhilov et al, 2006). The state-of-the-art method for computing the transition probabilities of birth-death processes proposed in Crawford and Suchard (2012) enables statistical estimation for general birth-death processes using likelihood-based inference (Crawford et al, 2014). Unfortunately, birth-death processes inherently only track one population, and extending this technique beyond the univariate case is nontrivial. Many applied models require the consideration of two or more interacting populations simultaneously to model behavior such as competition, predation, or infection. Examples of such bivariate models include epidemic models (McKendrick, 1926; Kermack and McKendrick, 1927; Griffiths, 1972), predator-prey models (Hitchcock, 1986; Owen et al, 2015), genetic models (Rosenberg et al, 2003; Xu et al, 2015), and within-host macro-parasite models (Drovandi and Pettitt, 2011).
The most general extensions of birth-death processes to bivariate processes are competition processes (Reuter, 1961). These processes allow not only “birth” and “death” events in each population, but also “transition” events where an individual moves from one population to the other. Unlike birth-death processes, few attempts have been made to compute the transition probabilities of competition processes or their special cases. Hence, researchers usually rely on classical continuous-time Markov chain methods such as matrix exponentiation and diffusion approximation. Unfortunately, these methods fail to leverage the specific structure of competition processes, and have several intrinsic limitations. Matrix exponentiation methods compute the transition probability matrix P(t) by solving the matrix form of Kolmogorov’s forward equation P′(t) = P(t)Q with initial condition P(0) = I, where Q is the instantaneous rate matrix of the process. While this equation admits a unique solution P(t) = exp(Qt) (Ephraim and Mark, 2012), numerical evaluation of the matrix exponential is often troublesome (Moler and Loan, 2003). Its computational cost via eigenvalue decomposition, for instance, is cubic in the size of the state-space and thus becomes computationally prohibitive even with moderately sized state-spaces (Drovandi and Pettitt, 2011; Crawford and Suchard, 2012). For example, Keeling and Ross (2008) demonstrate that computing transition probabilities via matrix exponentiation for the simplest epidemic models is practical only when modeling spread of an infectious disease through a very small population (e.g., 100 people). Moreover, matrix exponentiation can introduce serious rounding errors for certain rate matrices even for biologically reasonable values (Schranz et al, 2008; Crawford and Suchard, 2012; Crawford et al, 2014). Diffusion approximations, on the other hand, require the state-space to be large in order to justify approximating a discrete process by a continuous-valued diffusion process (Karev et al, 2005; Golightly and Wilkinson, 2005), and can often remain inaccurate for simulation even in settings with large state-spaces (Golightly and Wilkinson, 2005). Branching processes form another closely related class of processes, and have been used in a likelihood-based framework to study bivariate populations (Xu et al, 2015). Branching processes are at once more general than competition processes, permitting events that increment populations by more than one, and also more restrictive in that linearity is implied by an assumption that particles act independently. The latter assumption is limiting in epidemiological applications, for instance, which commonly feature non-linear interactions between populations.
The lack of a reliable method for computing transition probabilities in bivariate processes forces researchers to apply alternative likelihood-free approaches such as approximate Bayesian computation (ABC) (Blum and Tran, 2010; Drovandi and Pettitt, 2011; Owen et al, 2015). The ABC approach uses simulated and observed summary statistics to bypass likelihood evaluation. Nonetheless, this is not a panacea approach that can completely replace traditional likelihood-based methods. The ABC method itself has several sources for loss of information such as non-zero tolerance, and non-sufficient summary statistics (Sunnåker et al, 2013). The tolerance is an ad hoc threshold to decide whether ABC accepts a new proposal. If the tolerance is zero and the summary statistics are sufficient, ABC is guaranteed to return the correct posterior distribution. In practice, however, tolerance is always positive which often leads to bias. In the context of counting processes, sufficient summary statistics usually do not exist because the data are observed partially. Thus, credible interval estimates under ABC are potentially inflated due to the loss of information (Csilléry et al, 2010). Also, when sufficient summary statistics are not available, the ABC method can not be trusted in selecting between models (Robert et al, 2011). Because of all these limitations, direct likelihood-based methods are often more favorable.
In this paper, we develop an efficient method to compute the transition probabilities of a subclass of competition processes with two interacting populations of particles, enabling likelihood-based inference. We call this subclass birth(death)/birth-death processes, whose first population is increasing (decreasing). It is worth mentioning that we do not impose linearity condition for the rates of these processes. A rigorous characterization of this class of processes and derivation of recursive formulae to compute their transition probabilities are provided in Section 2. Our main tools are the Laplace transform and continued fractions that have been successfully applied for univariate birth-death processes in Crawford and Suchard (2012). These formulae enable accurate and computationally efficient numerical computation of transition probabilities. We implement this method in the new R package MultiBD https://github.com/msuchard/MultiBD. In Section 3, we discuss multiple scientifically relevant applications of birth(death)/birth-death processes including stochastic susceptible-infectious-removed (SIR) models in epidemiology (McKendrick, 1926; Kermack and McKendrick, 1927; Raggett, 1982), monomolecular reaction systems (Jahnke and Huisinga, 2007), a birth-death-shift model for transposable elements (Rosenberg et al, 2003; Xu et al, 2015), and a within-host macro-parasite model (Riley et al, 2003; Drovandi and Pettitt, 2011). We examine the accuracy of our method in simulation studies, including comparisons to branching process, matrix exponentiation method, and Monte Carlo approximations. Finally, we apply our method to estimate infection rates and death rates during the plague of Eyam in 1666 within a likelihood-based Bayesian framework in Section 4.
Previous work on computing the transition probabilities
Analytic expressions of the transition probabilities have only been found for some special cases such as linear birth-death processes (see e.g. Novozhilov et al, 2006) and monomolecular reaction systems (Jahnke and Huisinga, 2007). Therefore, matrix exponentiation is still the most common method for computing the transition probabilities of general Markov processes. The state-of-the-art software package for exponentiating sparse matrices is Expokit (Sidje, 1998; Moler and Loan, 2003), which uses Krylov subspace projection method. van den Eshof and Hochbruck (2006) propose a modified version using a simple preconditioned transformation to improve the convergence behavior of this method. Although matrix exponentiation has the advantage of generality in that it can be applied to any Markov process, it is not the most efficient method in many scenarios. Recently, Crawford and Suchard (2012) propose an efficient method for evaluating the transition probabilities of general birth-death processes using Laplace transform and continued fraction. However, efficient methods that extend this result to general bivariate birth-death processes have yet to be found.
2 Birth(death)/birth-death processes
2.1 Birth/birth-death processes
A birth/birth-death process is a bivariate continuous-time Markov process X(t) = (X1(t), X2(t)), t ≥ 0, whose state-space is in ℕ × ℕ, the Cartesian product of the non-negative integers. We can describe a birth/birth-death process as governing dynamics of a system consisting two types of particles, where one out of four possible events can happen in infinitesimal time: (1) a new type 1 particle enters the system; (2) a new type 2 particle enters the system; (3) a type 2 particle leaves the system; or (4) a type 2 particle becomes a type 1 particle. In this system, X1(t) and X2(t) track the number of type 1 and type 2 particles at time t respectively. Mathematically, there are five possibilities for X(t) during a small time interval (t, t + dt):
(1) |
where a, b ∈ ℕ, is the birth rate of type 1 particles given a type 1 particles and b type 2 particles, is the equivalent birth rate of type 2 particles, is the death rate of type 2 particles, and γab is the transition rate from type 2 particles to type 1 particles. We fix .
Letting , the forward Kolmogorov’s equations for the birth/birth-death process are
(2) |
for all (a, b). In practice, we can usually only observe the process discretely. In this scenario, the likelihood function is the product of transition probabilities between consecutive observations. Therefore, computing is an important step for any direct likelihood-based analysis.
In general, a birth/birth-death process is a special case of a competition process (Reuter, 1961) with rate matrix Q = {qij} where i, j ∈ ℕ × ℕ and
j | Competition process | Birth/birth-death | ||
---|---|---|---|---|
| ||||
(a + 1, b) | q(a,b)(a+1,b) |
|
||
(a − 1, b) | q(a,b)(a−1,b) | 0 | ||
(a, b + 1) | q(a,b)(a,b+1) |
|
||
(a, b − 1) | q(a,b)(a,b−1) |
|
||
(a + 1, b − 1) | q(a,b)(a+1,b−1) | γab | ||
(a − 1, b + 1) | q(a,b)(a−1,b+1) | 0 | ||
(a, b) |
|
|
||
other | 0 | 0 |
for i = (a, b). Competition processes are the most general bivariate Markov processes that only allow transitions between neighboring states. Many practical models in biology are special cases of these processes such as epidemic models (McKendrick, 1926; Kermack and McKendrick, 1927; Griffiths, 1972) and predator-prey models (Hitchcock, 1986; Owen et al, 2015).
2.1.1 Sufficient condition for regularity
Definition 1
A birth/birth-death process is regular if there is a unique set of transition probabilities satisfying the system of equations (2).
Here, we establish the sufficient condition for regularity of a birth/birth-death process. For k ∈ ℕ, we denote:
(3) |
Theorem 1
The sufficient condition for regularity of a general birth/birth-death process is .
Proof
We will apply the following Reuter’s condition (Reuter, 1957):
Lemma 1
Let Q = {qij} be a conservative matrix, such that −qii = Σj≠i qij < ∞. A continuous-time Markov chain associated with Q is regular if and only if for some ζ > 0, the equation Qy = ζy subject to 0 ≤ yi ≤ 1 has only trivial solution y = 0.
For a general birth/birth-death process, states i and j are in ℕ × ℕ. Let {yab}a,b∈ℕ be a solution of Qy = ζy such that yab ∈ [0, 1] for any a and b. Then, we have
(4) |
Defining yk = max(a,b)∈Dk{yab} and (ak, bk) = argmax(a,b)∈Dk{yab}, we deduce that
(5) |
Since , yk is an increasing sequence. Thus,
(6) |
Assuming that there exists k0 such that yk0 > 0, we obtain
(7) |
that is larger than 1 if k is big enough. Hence yk = 0 for every k. Then, the theorem is proved by applying Lemma 1.
Note that the condition in Theorem 1 generalizes the classical regularity condition of a pure birth process (Feller, 1968). From now on, we assume that our birth/birth-death processes are regular.
2.1.2 Recursive formula for transition probabilities
In this section, we establish a recursion to calculate the transition probabilities of a birth/birth-death process. Since we assume that our birth/birth-death process is regular, these transition probabilities are unique.
We first note that for all a < a0. Let fab(s), s ∈ ℂ, be the Laplace transform of , that is
(8) |
From (2), we have
(9) |
Note that fab(s) is the unique solution of (9) by the uniqueness of . We construct the recursive approximation formulae for fab(s) using continued fractions. Appendix A provides necessary background on continued fractions and their convergents. Denote
(10) |
and consider the following continued fraction
(11) |
We can construct the sequence (Definition A3, Appendix A) as follows:
(12) |
Comparing the sequences in (12) with (9), we deduce that . Since is a probability distribution, we have . Taking the Laplace transform of the previous equation, we get . Hence, for every s > 0. By Lemma A1 (Appendix A), converges for every s > 0, and
(13) |
where Yab is the denominator of the bth convergent of .
From (9), we note that
(14) |
By Lemma A2 (Appendix A), where
(15) |
Next, we obtain formulae for approximating fab(s) recursively assuming that we already have evaluated fa−1,b(s). Again, from (2), we have
(16) |
for b ∈ ℕ. We approximate fab(s) by solving a truncated version of (16) for 0 ≤ b ≤ B, where B is sufficiently large. The intuition of how to choose B follows from the observation that we want to be small. By Lemma A2 (Appendix A), we have the following approximation:
(17) |
Therefore, the transition probabilities of a birth/birth-death process can be computed recursively using the following Theorem:
Theorem 2
Let be defined as in (11), (13), and (15). We have
(18) |
where and
(19) |
Here, ℒ−1(.) denotes the inverse Laplace transform and B is the truncation level.
If the number of type 2 particles is bounded by B*, we choose B = B*. In this case, the approximation in Theorem 2 is exact. We prove that the output of our approximation scheme (19) converges to fab(s) as B goes to infinity in Appendix C. Further, the transition probability returned by Theorem 2 converges to the true transition probability. This truncation error can be bounded explicitly by extending the coupling argument in Crawford et al (2016) to multivariate processes. However, we leave it as a subject of future work because a complete treatment is beyond the scope of this paper.
2.1.3 Numerical approximation of the transitions probabilities
To approximate using Theorem 2, we need to compute two quantities: the continued fractions , and the inverse Laplace transform ℒ−1 [fab(s)] (t). We efficiently evaluate the continued fractions through the modified Lentz method (Lentz, 1976; Thompson and Barnett, 1986); see Appendix B for more details. This algorithm enables us to control for and limit truncation error. To approximate the inverse Laplace transform ℒ−1 [fab(s)] (t), we apply the method proposed in Abate and Whitt (1992) using a Riemann sum:
(20) |
Here ℛ[z] is the real part of z and H is a positive real number. Abate and Whitt (1992) show that the error that arises in (20) is bounded by 1/(eH − 1). Moreover, we can use the Levin transform (Levin, 1973) to improve the rate of convergence because the series in (20) is an alternating series when ℛ{fab[(H + 2kπi)/(2t)]} have the same sign. These numerical methods have been successfully applied by Crawford and Suchard (2012) to compute the transition probabilities of birth-death processes.
In practice, to handle situations where can possibly equal to 0 for some (a, b), we re-parametrize xab and yab as follows:
(21) |
With this new parametrization, we obtain
(22) |
Our complete algorithm to compute the transition probabilities of birth/birth-death processes is implemented in the function bbd_prob in a new R package called MultiBD. The function takes t, a0, b0, , γab, A, B as inputs and returns the transition probability matrix . Here, there is no requirement for A while B needs to be large enough such that is small. We can check to see if B is large enough by checking if is sufficiently small.
In practice, the computational complexity of evaluating each term (fab(s))a0≤a≤A,0≤b≤B is 𝒪((A − a0)B2) because the Lentz algorithm terminates quickly. Let K be the number of iterations required by the Levin acceleration method (Levin, 1973) to achieve a certain error bound for the Riemann sum in (20). Then, the total complexity of our algorithm is 𝒪((A − a0)B2K). However, evaluation of can be efficiently parallelized across different values of k, and we exploit this parallelism via multicore processing, delegating most of the computational work to compiled C++ code.
2.2 Death/birth-death processes
Similar to the birth/birth-death process, a death/birth-death process is also a special case of competition processes. The only difference is that the number of type 1 particles is decreasing instead of increasing. Mathematically, possible transitions of a death/birth-death process X(t) = (X1(t), X2(t)) during (t, t+dt) are:
(23) |
where is the death rate of type 1 particles given a type 1 particles and b type 2 particles, is the birth rate of type 2 particles, is the death rate of type 2 particles, and γab is the transition rate from type 1 particles to type 2 particles. Again, we fix .
Following a similar argument as in Section 2.1.1, we obtain a sufficient condition for regularity of a death/birth-death process. Denote
(24) |
where a0 is the number of type 1 particles at time t = 0. The following Theorem is a direct application of Theorem 1 in Iglehart (1964)
Theorem 3
A sufficient condition for regularity of a death/birth-death process is
(25) |
We note that if we do a transformation for a death/birth-death process X(t) = (X1(t), X2(t)) as follows:
(26) |
Then, Y(t) = (Y1(t), Y2(t)) can be considered as a birth/birth-death process. Therefore, the transition probabilities of a death/birth-death process can also be computed using the R function bbd_prob and the transformation (26). Again, we want to choose B such that is small. We implement this procedure in the function dbd_prob in our R package MultiBD. The function takes t, a0, b0, , γab, A, B as inputs and returns the transition probability matrix . As for birth/birth-death processes, there is no requirement for A.
3 Applications
Birth(death)/birth-death processes are appropriate for modeling two-type populations where the size of the first population is monotonically increasing (decreasing). Here we examine our methods in four applications: a within-host macro-parasite model, a birth-death-shift model for transposable elements, monomolecular reaction systems, and the stochastic SIR epidemiological model. We demonstrate that a birth (death)/birth-death process well captures the dynamics of these common biological problems, and inference using its transition probabilities often outperforms existing approximations. In particular, we emphasize that the birth (death)/birth-death process approach allows us to compute finite-time transition probabilities in the stochastic SIR model that were previously considered unknown or intractable without model simplification (Cauchemez and Ferguson, 2008).
3.1 Monomolecular reaction systems
We illustrate the performance of our computational method by considering the following monomolecular reactions:
(27) |
where rab, rba is the reaction rates, and ob is the outflow rate. Denote
By Theorem 1 in Jahnke and Huisinga (2007), the transition probabilities of the reaction system (27) at time t > 0 is
(28) |
where ℳ(x, N, p) is the multinomial distribution and ★ denotes the convolution operator. As analytic expressions for transition probabilities exist for this class of reactions, this example serves as a baseline for comparison to assess the accuracy of our method.
To study these processes in our framework, let A(t) denote the total number of particle A at time t and L(t) be the total number of particle B leaving the system up to t. Then, {L(t), A(t)} is a birth/birth-death process with the following possible transitions during (t, t + dt):
Here x+ = max(0, x). Therefore, can be computed using our method implemented in the R function bbd_prob.
We use bbd_prob to calculate of the reaction system (27) with rab = 2, rba = 0.5 and ob = 1. The L1 distance between our result and the analytic result (28) is less than 4.7 × 10−9, thus confirming the accuracy of our method compared to explicit analytic solutions.
3.2 Birth-death-shift model for transposable elements
Transposable elements or transposons are genomic sequences that can either duplicate, with a new copy moving to a new genomic location, move to a different genomic location, or be deleted from the genome. Rosenberg et al (2003) model the number of copies of a particular transposon using a linear birth-death-shift process; a birth is a duplication event, a death is a deletion event, and shift is a switching position event. Xu et al (2015) propose representing this birth-death-shift process by a linear multi-type branching process X(t) = (Xold(t), Xnew(t)) tracking the number of occupied sites where Xold(t) is the number of initially occupied sites and Xnew(t) is the number of newly occupied sites. Let λ, μ, and ν be the birth, death, and shift rates respectively. The transitions of X(t) during a small time interval occur with probabilities
(29) |
Equivalent to the branching process representation, notice that in this case X(t) is also a death/birth-death process. Hence, we can effectively compute its transition probabilities. In contrast, Xu et al (2015) consider the probability generating function
(30) |
where
(31) |
Because of the model-specific linearity in terms of a and b of the birth and death rates, one can evaluate Φjk(t, s1, s2) by solving an ordinary differential equation. Further transforming s1 = e2πiw1, s2 = e2πiw2, the generating function becomes a Fourier series
(32) |
Therefore, Xu et al (2015) retrieve the transition probabilities through approximating the integral as a Riemann sum
(33) |
and show that choosing H as the smallest power of 2 greater than max(a, b) produces accurate estimates of the true transition probabilities of the model. The authors implement this method in the R package bdsem. Using their method, evaluating requires numerically solving H2 linear ordinary differential equations (ODEs). We perform a simulation to compare the performance between bdsem and our function dbd_prob. Because Xu et al (2015) already provide a thorough empirical validation that bdsem produces accurate transition probabilities compared to Monte Carlo estimates from the true model, we consider a comparison to their method and omit a complete reproduction of their simulation study. Using both routines to compute the transition probabilities of a birth-death-shift process with rates λ = 0.0188, μ = 0.0147, ν = 0.00268 (estimated from the IS6110 data by Rosenberg et al (2003)) repeatedly over one hundred trials leads to a negligible difference in estimated probabilities. Specifically, we computed at three different observation period lengths t = 1, 5, 10, and found that the L1 distance between probabilities estimated by each method is less than 4 × 10−8 across all cases. Here, the L1 distance between two matrices U = (uij) and V = (vij) are defined as ||U − V|| = Σi,j |uij − vij|.
Having validated the accuracy of our approach, we turn to a runtime comparison. The ratios of CPU time required using bdsem compared to dbd_prob are summarized in Figure 1, and note that this result is obtained using a single-thread option for dbd_prob. We see that dbd_prob is about 15 to 30 times faster than the bdsem implementation, while producing very similar results.
While there is a large performance difference in wall clock time, we cannot immediately conclude that our method is faster then the method in Xu et al (2015) because computation time may depend heavily on implementation. Nonetheless, we can make some remarks about the performance of both methods that are platform-independent. Notably, the bdsem implementation grows slower as t increases while dbd_prob does not. This is expected because solving ODEs is slower when the domain increases. However, it is worth mentioning that we can use the solution paths to get the solutions of these ODEs at other time points in the domain. For example, when we solve the ODEs at t = 10, we also get the solutions at t = 1 and 5 for free. This point becomes important in applications where we need to compute the transition probabilities at several time points. Another downside of bdsem is that it computes instead of evaluating directly as is done by dbd_prob.
3.3 Within-host macro-parasite model
Riley et al (2003) posit a stochastic model to describe a within-host macro-parasite population where Brugia pahangi is the parasite and Felis catus is the host. Brugia pahangi is closely related to Brugia malayi which infects millions of people in South and Southeast Asia. The model tracks the number of B. pahangi larvae L(t), the number of mature parasites M(t), and hosts experience of infection I(t) at time t. The dynamics of {L(t), M(t), I(t)} follow a system of differential equations:
(34) |
where μL is the natural death rate and γ is the maturation rate of larvae; β is the death rate of larvae due to the immune response from the host; μM is the death rate of mature parasites; ν is the acquisition rate and μI is the loss rate of immunity.
Drovandi and Pettitt (2011) propose a simplification of this model by applying a pseudoequilibrium assumption for immunity, such that the immunity is constant over time. Under this pseudoequilibrium assumption, the dynamics of {L(t), M(t)} becomes
(35) |
where η = βν/μI. We illustrate the dynamic of (35) in Figure 2. The corresponding stochastic formulation of this model is:
(36) |
Notably, {L(t), M(t)} follow a death/birth-death process.
For this model, γ and μM has been estimated at 0.04 and 0.0015 previously (see Drovandi and Pettitt, 2011, for more details). To estimate the remaining parameters, Drovandi and Pettitt (2011) examine the number of mature parasites at host autopsy time (at most 400 days) of those injected with approximately 100 juveniles, assume a priori μL and η are uniform[0,1) and apply ABC to draw inference because the traditional matrix exponentiation method is computationally prohibitive here. The basic idea of ABC involves sampling from an approximate posterior distribution
(37) |
where θ is the vector of unknown parameters, ε > 0 is an ad hoc tolerance, and ρ(Y, Ys) is a discrepancy measure between summary statistics of the observed data Y and the simulated data Ys. Because the sufficient statistics are not available for this problem, the authors use a goodness-of-fit statistic. However, the ABC method suffers from loss of information because of non-zero tolerance and non-sufficient summary statistics (Sunnåker et al, 2013). Therefore, credible intervals obtained by the ABC approach are potentially inflated (Csilléry et al, 2010).
In contrast, our method makes direct likelihood computation and in turn evaluation of the posterior density feasible. Figure 3 displays a visualization of the posterior density surface of (log μL, log η) computed using our method, given the collection of numbers of mature parasites M(t) at autopsy under this model (see Drovandi and Pettitt, 2011, for more details about the data). Importantly in this example, we are able to efficiently integrate out the unobserved larvae counts L(t) at autopsy. The approximate estimate obtained by Drovandi and Pettitt (2011) using ABC is overlaid on this density surface for comparison, and does not align with the highest density region of our computed posterior. Note that the posterior is flat when η is close to 0, and has an unusual tail toward the region where the ABC estimate lies. This suggests that the previous ABC approach fails to explore the region with high posterior probability well, likely due to loss of information incurred by the method, resulting in a poor estimate from the data.
Finally, we consider this example toward a second runtime comparison between our method and Expokit, a state-of-the-art matrix exponentiation package with efficient implementation. In particular, we compute the transition probability matrix of {L(t),M(t)} with μL = 0.0682, μM = 0.0015, η = 0.0009, γ = 0.04 at t = 100, 200, 400 using our function dbd_prob and the function expv in expoRkit, an R-interface to the Fortran package Expokit. Both methods produce similar results: the L1 distance between the two estimated transition probability matrices is less than 3 × 10−9 across all cases. In terms of speed, we see that dbd_prob is roughly twice as fast as expv when t = 100, 200, but about 9-fold faster when t = 400 (Figure 4). It is worth mentioning that dbd_prob can be further accelerated via parallelization.
3.4 Stochastic SIR model in epidemiology
McKendrick (1926) models the spread of an infectious disease in a closed population by dividing the population into three categories: susceptible persons (S), infectious persons (I) and removed persons (R). Since the population is closed, the total population size N obeys the conservation equation N = S(t)+I(t)+R(t) for all time t. The deterministic dynamics of these three subpopulations follow a system of nonlinear ordinary differential equations (Kermack and McKendrick, 1927):
(38) |
where α > 0 is the removal rate and β > 0 is the infection rate of the disease. This system of equations cannot be solved analytically, but we can obtain its solution numerically. An important quantity for the SIR model is the basic reproduction number R0 = βN/α (Earn, 2008). This quantity determines whether a spread of an infectious disease becomes an epidemic. In particular, an epidemic can only occur when R0 > 1.
Unfortunately, the deterministic model is not suitable when the community is small (Britton, 2010). In these situations, the original stochastic SIR model (McKendrick, 1926) becomes more appropriate. Moreover, Andersson and Britton (2000) argue that stochastic epidemic models are preferable when their analysis is possible because (1) stochastics are the most natural way to describe a spread of diseases, (2) some phenomena do not satisfy the law of large numbers and can only be analyzed in the stochastic setting (for example, the extinction of endemic diseases only occurs when the epidemic process deviates from its expected value), and (3) quantifying the uncertainty in estimates requires stochastic models. Nonetheless, one can bypass Andersson and Britton’s third argument by imposing random sampling errors around the deterministic compartments. Therefore, it is important to distinguish between the deterministic SIR model with sampling errors and the stochastic SIR model.
Without loss of generality, the stochastic SIR model needs only track S(t) and I(t) because S(t) + I(t)+R(t) remains constant. All possible transitions of {S(t), I(t)} during a small time interval (t, t+dt) occur with probabilities
(39) |
We see that {S(t), I(t)} is a death/birth-death process with , γsi = βsi.
Due to the interaction between populations and nonlinear nature of the model, mechanistic analysis of the stochastic SIR model is difficult, and the lack of an expression for transition probabilities has been a bottleneck for statistical inference. Renshaw (2011) remarks that while one can write out the Kolmogorov forward equation for the system, the “associated mathematical manipulations required to generate solutions can only be described as heroic.” Instead, the majority of efforts involve either simulation based methods or simplifications and tractable approximations to the SIR model. For instance, the stochastic SIR model can be analyzed using ABC (McKinley et al, 2009), but we have already mentioned limitations of this approach. Particle filter methods can be used to analyze SIR models within maximum likelihood (Ionides et al, 2006, 2015) and Bayesian frameworks (Andrieu et al, 2010; Dukic et al, 2012), but these methods are computationally very demanding and often suffer from convergence problems. When examining large epidemics, to make the likelihood tractable it is reasonable to apply a continuous approximation to the large populations, modeled as a diffusion process with exact solutions (Cauchemez and Ferguson, 2008). However, such an approach is a poor proxy for the SIR model when observed counts are low. When data are collected at regular intervals and coincide with disease generation timescales, it is also possible to study discrete-time epidemic models— the time-series SIR (TSIR) model is one well-known example (Finkenstädt and Grenfell, 2000). However, these simplifications also have their shortcomings, relying on the relatively strong assumption that populations are constant over each interval between observation times.
In the death/birth-death framework, our method enables practical computation of these quantities without any simplifying model assumptions. In Section 4, we will apply our method to analyze the population of Eyam during the plague of 1666 (Raggett, 1982) to estimate the infection and the death rates of this disease, using the death/birth-death transition probabilities within a Metropolis-Hastings algorithm. Here, we first examine the accuracy of these transition probabilities themselves. We compare the continued fraction method to empirical transition probabilities obtained via simulation from the true model as ground-truth, and to a new two-type branching approximation to the SIR model introduced below. The branching process approximation is appropriate when transition probabilities need to be computed for short time intervals, and its simple expressions for transition probabilities enable much more efficient computation. However, we show that as transition time intervals increase, the branching approximation becomes less accurate, while the transition probabilities computed under the death/birth-death model remain very accurate.
While branching processes fundamentally rely on independence of each member of the population, we can nonetheless make a fair approximation by mimicking the interaction effect of infection over short time intervals. In the branching model, let X1(t) denote the susceptible population and X2(t) denote the infected population at time t, with details and derivation included in Appendix D. Over any time interval [t0, t1), we use the initial population X2(0) as a constant scalar for the instantaneous rates. This branching process model has instantaneous infection rate βX2(0)X1(t) and recovery rate αX2(t) for all t ∈ [t0, t1), closely resembling the true SIR model rates, with the exception of fixing X2(0) in place of X2(t) in the rate of infection. This constant initial population fixes a piecewise homogeneous per-particle birth rate to satisfy particle independence while mimicking interactions, but notice that both populations can change over the interval, offering much more flexibility than models such as TSIR that assume constant populations and rates between discrete observations.
This branching model admits closed-form solutions to the transition probabilities that can be evaluated quickly and accurately. The transition probabilities of the two-type branching approximation to the SIR model over any time interval of length t are given by
(40) |
where
(41) |
and
(42) |
The sum over products of expressions (41) and (42) in equation (40) may look unwieldy, but this sum is computed extremely quickly with a vectorized implementation, and with high degrees of numerical stability. In settings when such a model is appropriate and (X1(t),X2(t)) ≈ (S(t), I(t)), the branching approximation can offer a much more computationally efficient alternative to the continued fraction method.
3.5 Transition probabilities of the SIR model
Figure 5 provides a comparison between methods of computing transition probabilities. Included are transition probabilities corresponding to the nine pairs of system states {(m, n), (k, l)}j, j = 1, …, 9, such that is largest. Fixing these indices, we plot the set of probabilities { } while varying t between 0.1 and 1.0. We see that transition probabilities computed using the continued fraction method under the death/birth-death model very closely match those computed empirically via simulation from the model, taken to be the ground truth. Almost all such probabilities in Figure 5 fall within the 95% confidence interval, while the branching process transitions follow a similar shape over time, but fall outside of the confidence intervals for many observation intervals. An additional heatmap visualization comparing the support of transition probabilities is included in the Appendix, and shows that the branching approximation is accurate with similar support to the empirical transition probabilities for a shorter time interval of length t = 0.5, but becomes visibly further from the truth when we increase the observation length to t = 1.0.
4 The Plague in Eyam revisited
We revisit the outbreak of plague in Eyam, a village in the Derbyshire Dales district, England, over the period from June 18th to October 20th, 1666. This plague outbreak is widely accepted to originate from the Great Plague of London, that killed about 15% of London’s population at that time. To prevent further spread of the plague after infestation, the Eyam villagers did not escape the village, instead isolating themselves from the outside world. At the end of this horrific event, only 83 people had survived out of an initial population of 350. We summarize data recording the spread of the disease (Raggett, 1982) in Table 1. As mentioned in Raggett (1982), this data are obtained by counting the number of deaths from the dead list and estimating the infective population from the list of future deaths assuming a fixed length of illness prior to death. Then, the susceptible population can be computed easily because the the town is isolated.
Table 1.
|
||||||||
---|---|---|---|---|---|---|---|---|
Time (months) | ||||||||
0 | 0.5 | 1 | 1.5 | 2 | 2.5 | 3 | 4 | |
Susceptible population | 254 | 235 | 201 | 153 | 121 | 110 | 97 | 83 |
Infective population | 7 | 14 | 22 | 29 | 20 | 8 | 8 | 0 |
Raggett (1982) analyzes these data using the stochastic SIR model (39). In this model, α is the unknown death rate of infective people and β is the unknown infection rate of the plague. The author uses a simple approximation method for the forward differential equation and comes up with a point estimate (α̂, β̂) = (3.39, 0.0212). We take a Bayesian approach to re-analyze these data.
With n observations at time , the log of the likelihood function is:
(43) |
Because {S(t), I(t)} is a death/birth-death process, the individual transition probabilities can be computed efficiently using our continued fraction method. Hence, the log of the likelihood (43) can be computed easily. Since α and β are non-negative, we opt to use log α and log β as our model parameters and assume a priori that log α ~ 𝒩(μ = 0, σ = 100) and log β ~ 𝒩(μ = 0, σ = 100). We explore the posterior distribution of (log α, log β) using a random-walk Metropolis algorithm implemented in the R function MCMCmetrop1R from package MCMCpack (Martin et al, 2011). We start the chain from Raggett’s estimated value (log(3.39), log(0.0212)) and run it for 100000 iterations. We discard the first 20000 iterations and summarize the posterior distribution of (α, β) using the remaining iterations. We illustrate the density of this posterior distribution in Figure 6(a). The posterior mean of α is 3.22 and the 95% Bayesian credible interval for α lies in (2.69, 3.82). Those corresponding quantities for β are 0.0197 and (0.0164, 0.0234). Notice that our credible intervals include the point estimate (α̂, β̂) = (2.73, 0.0178) from Brauer (2008) using the deterministic SIR model and Raggett’s point estimate (α̂, β̂) = (3.39, 0.0212).
We also apply the two-type branching approximation to compute the log of the likelihood (43). Using the same random-walk Metropolis algorithm as before, we explore the posterior distribution of (α, β) and visualize it in Figure 6(b). The posterior mean of α is 3.237 and the 95% Bayesian credible interval for α is (2.7, 3.84), while those quantities for β are 0.02 and (0.0171, 0.023). Although the posterior means and the 95% Bayesian credible intervals are similar to ones from the continued fraction method, we see in Figure 6(b) that this method fails to fully capture the posterior correlation structure between α and β.
The posterior distribution of the basic reproduction number R0 from the continued fraction method and from the branching approximation method are similar (Figure 7). The posterior mean of R0 from the continued fraction method is 1.61 and from the branching approximation method is 1.62. The estimate for R0 from Brauer (2008) is 1.7, from Raggett (1982) is 1.63. These estimates are similar, and in particular the branching approximation estimate is very close to that under the continued fraction method, offering a very efficient way to provide reasonable estimates of quantities such as R0 despite being less accurate than the continued fraction approach.
From the results, we can see that estimates of R0 from different methods are roughly the same while estimates of α and β are different. Although the basic reproduction number R0 is an important quantity in the SIR model, it is not the only parameter driving the dynamic of the epidemic. Correia-Gomes et al (2014) demonstrated the important of accurately estimating the transmission parameters between compartments of the SIR model for Salmonella Typhimurium in pigs.
5 Discussion
Likelihood-based inference for bivariate continuous-time Markov processes is usually restricted to very small state spaces due to the computational bottleneck of transition probability calculation. In this paper, we provide tools for likelihood-based inference for birth(death)/birth-death processes by developing an efficient method to compute their transition probabilities. We provide a complete implementation of the algorithms to compute these transition probabilities in a new R package called MultiBD. Our functions employ sophisticated tools including continued fractions, the modified Lentz method, the method of Abate and Whitt for approximate inverse Laplace transforms, and the Levin acceleration method. Moreover, these methods are naturally amenable to parallelization, and we exploit multicore processing to speed up the algorithm. We remark that birth(death)/birth-death processes remain a limited subclass of general multivariate birth-death processes. For example, many population biology problems require a full bivariate birth-death process including predator-prey models (Hitchcock, 1986; Owen et al, 2015) and the SIR model with vital dynamics (Earn, 2008). Unfortunately, efficiently computing the transition probabilities of multivariate birth-death processes remains an open problem. Solving this problem will enable numerically stable statistical inference under birth-death processes and will be worth the “heroic” effort (Renshaw, 2011).
Acknowledgments
This work was partially supported by the National Institutes of Health (R01 HG006139, R01 AI107034, and U54 GM111274) and the National Science Foundation (IIS 1251151, DMS 1264153, DMS 1606177). We thank Christopher Drovandi, Edwin Michael, and David Denham for access to the Brugia pahangi count data.
A Continued fractions
In this section, we give some basic definitions and properties related to continued fractions.
Definition A1
A continued fraction ϕ0 is a scalar quantity expressed in
(A.1) |
where and are infinite sequences of complex numbers.
Definition A2
The nth convergent of ϕ0 is
(A.2) |
Definition A3
We define the corresponding sequence of a continued fraction (A.1) by the following recurrence formulae
(A.3) |
Murphy and O’Donohoe (1975) provided the following sufficient condition for the convergence of (A.1):
Lemma A1
Assume that there exists N such that infn>N |Yn| > 0 and limn→∞ ϕn = 0. Then, the continued fraction (A.1) is convergent. Moreover,
(A.4) |
Now, if we consider a more general recurrence formulae
(A.5) |
then under the assumption of Lemma A1, we have the following lemma:
Lemma A2
The solution for (A.5) is
(A.6) |
B Modified Lentz method
Modified Lentz method (Lentz, 1976; Thompson and Barnett, 1986) is an efficient algorithm to finitely approximate the infinite expression of the continued fraction ϕ0 in (A.1) to within a prescribed error tolerance. Let be the nth convergence of ϕ0, that is . The main idea of Lentz’s algorithm lies in using the ratios
(B.1) |
to stabilize the computation of . We can calculate An, Bn, and recursively as follows:
(B.2) |
If converges to ϕ0, then Craviotto et al (1993) show that
(B.3) |
where ℐ[Yn/Yn−1] is the imaginary part of Yn/Yn−1 and is assumed to be non-zero. Hence, the Lentz’s algorithm terminates when
(B.4) |
is small enough. However, An and Bn can equal zero themselves and cause problem. Hence, Thompson and Barnett (1986) propose a modification for Lentz’s algorithm by setting An and Bn to a very small number, such as 10−16, whenever they equal zero. In practice, the algorithm often terminates after small number of iterations. However, in some rare cases where the numerical computation is unstable, it might take too long before the algorithm terminates. So, we set a predefined maximum number of iterations H as a fallback for these cases.
C Convergence results of increasing the truncation level
Let be the output of the approximation scheme (19) in Theorem 2. In this section, we prove that converges to fab(s) as B goes to infinity. To do so, let us consider a truncated birth/birth-death process at truncation level B such that it executes the same process as X(t) on the state {a0, a0 + 1, a0 + 2,…} × {0, 1, 2, …, B} except that . Define be the transition probabilities of X(B)(t) and TB be the hitting time at which X2(t) first reach state B + 1. For any set S ⊂ ℕ2, we have
Therefore | Pr(X(t) ∈ S) − Pr(X(B)(t) ∈ S)| ≤ Pr(TB ≤ t). Note that is the Laplace transform of . Hence
By Dominated convergence theorem and the fact that limB→∞ Pr(TB ≤ t) = 0, we deduce that .
D Branching SIR approximation
Here we derive and solve the Kolmogorov backward equations of the two-type branching process necessary for evaluating the probability generating functions (PGFs) whose coefficients yield transition probabilities.
D.1 Deriving the PGF
Our two-type branching process is represented by a vector (X1(t),X2(t)) that denotes the numbers of particles of two types at time t. Let the quantities a1(k, l) denote the rates of producing k type 1 particles and l type 2 particles, starting with one type 1 particle, and a2(k, l) be analogously defined but beginning with one type 2 particle. Given a two-type branching process defined by instantaneous rates ai(k, l), denote the following pseudo-generating functions for i = 1, 2 as
(D.1) |
We may expand the probability generating functions in the following form:
(D.2) |
We have an analogous expression for ϕ01(t, s1, s2) beginning with one particle of type 2 instead of type 1. For short, we will write ϕ10 := ϕ1, ϕ01 := ϕ2. Thus, we have the following relation between the functions ϕ and u:
(D.3) |
To derive the backwards and forward equations, Chapman-Kolmogorov arguments yield the symmetric relations
(D.4) |
First, we derive the backward equations by expanding around t and applying (D.3):
(D.5) |
Since an analogous argument applies for ϕ2, we arrive at the system
(D.6) |
with initial conditions ϕ1(0, s1, s2) = s1, ϕ2(0, s1, s2) = s2.
Recall in our SIR approximation, we use the initial population X2(0) as a constant that scales the instantaneous rates over any time interval [t0, t1). The only nonzero rates specifying this proposed model, in the notation above, are
(D.7) |
For simplicity, call X2(0) := I0, the constant representing the infected population at the beginning of the time interval. Thus, the corresponding pseudo-generating functions have a simple form:
(D.8) |
Plugging into the backward equations, we obtain
(D.9) |
The ϕ2 differential equation corresponds to a pure death process and is immediately solvable; suppressing the arguments of ϕ2 for notational convenience, we obtain
(D.10) |
Plugging in ϕ2(0, s1, s2) = s2, we obtain C = ln(1 − s2), and we arrive at
(D.11) |
Substituting this solution into the first differential equation and applying the integrating factor method provides
(D.12) |
Plugging in the initial condition ϕ1(0, s1, s2) = s1 and rearranging yields
(D.13) |
D.2 Transition probability expressions
Transition probabilities are related to the PGF via repeated partial differentiation; note that
(D.14) |
This expression is generally unwieldy, but notice for all i > 0 in our model. Remarkably, this allows us to further simplify and ultimately arrive at closed-form expressions. Continuing, we see
(D.15) |
From here, it is straightforward to take partial derivatives of h(t, s1, s2) and our closed-form expression of to arrive at Conditions (41) and (42). A heatmap visualization of the difference between transition probabilities under the branching approximation and those computed using the continued fraction method for the SIR model is included below.
Contributor Information
Lam Si Tung Ho, Department of Biostatistics, University of California, Los Angeles.
Jason Xu, Department of Biomathematics, University of California, Los Angeles.
Forrest W. Crawford, Department of Biostatistics, Yale University
Vladimir N. Minin, Departments of Statistics and Biology, University of Washington
Marc A. Suchard, Departments of Biomathematics, Biostatistics and Human Genetics, University of California, Los Angeles
References
- Abate J, Whitt W. The Fourier-series method for inverting transforms of probability distributions. Queueing Systems. 1992;10(1–2):5–87. [Google Scholar]
- Andersson H, Britton T. Stochastic epidemic models and their statistical analysis. Vol. 4. Springer; New York: 2000. [Google Scholar]
- Andrieu C, Doucet A, Holenstein R. Particle Markov chain Monte Carlo methods. Journal of the Royal Statistical Society: Series B (Statistical Methodology) 2010;72(3):269–342. [Google Scholar]
- Blum MG, Tran VC. HIV with contact tracing: a case study in approximate Bayesian computation. Biostatistics. 2010;11(4):644–660. doi: 10.1093/biostatistics/kxq022. [DOI] [PubMed] [Google Scholar]
- Brauer F. Mathematical epidemiology. Springer; 2008. Compartmental models in epidemiology; pp. 19–79. [Google Scholar]
- Britton T. Stochastic epidemic models: a survey. Mathematical Biosciences. 2010;225(1):24–35. doi: 10.1016/j.mbs.2010.01.006. [DOI] [PubMed] [Google Scholar]
- Cauchemez S, Ferguson N. Likelihood-based estimation of continuous-time epidemic models from time-series data: application to measles transmission in London. Journal of the Royal Society Interface. 2008;5(25):885–897. doi: 10.1098/rsif.2007.1292. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Correia-Gomes C, Economou T, Bailey T, Brazdil P, Alban L, Niza-Ribeiro J. Transmission parameters estimated for salmonella typhimurium in swine using susceptible-infectious-resistant models and a bayesian approach. BMC veterinary research. 2014;10(1):101. doi: 10.1186/1746-6148-10-101. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Craviotto C, Jones WB, Thron W. A survey of truncation error analysis for Padé and continued fraction approximants. Acta Applicandae Mathematica. 1993;33(2–3):211–272. [Google Scholar]
- Crawford FW, Suchard MA. Transition probabilities for general birth–death processes with applications in ecology, genetics, and evolution. Journal of Mathematical Biology. 2012;65(3):553–580. doi: 10.1007/s00285-011-0471-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Crawford FW, Minin VN, Suchard MA. Estimation for general birth-death processes. Journal of the American Statistical Association. 2014;109(506):730–747. doi: 10.1080/01621459.2013.866565. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Crawford FW, Weiss RE, Suchard MA. Sex, lies, and self-reported counts: Bayesian mixture models for longitudinal heaped count data via birth-death processes. Annals of Applied Statistics. 2015;9:572–596. doi: 10.1214/15-AOAS809. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Crawford FW, Stutz TC, Lange K. Coupling bounds for approximating birth-death processes by truncation. Statistics & probability letters. 2016;109:30–38. doi: 10.1016/j.spl.2015.10.013. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Csilléry K, Blum MG, Gaggiotti OE, François O. Approximate Bayesian computation (ABC) in practice. Trends in Ecology & Evolution. 2010;25(7):410–418. doi: 10.1016/j.tree.2010.04.001. [DOI] [PubMed] [Google Scholar]
- Doss CR, Suchard MA, Holmes I, Kato-Maeda M, Minin VN. Fitting birth–death processes to panel data with applications to bacterial DNA fingerprinting. The Annals of Applied Statistics. 2013;7(4):2315–2335. doi: 10.1214/13-AOAS673. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Drovandi CC, Pettitt AN. Estimation of parameters for macroparasite population evolution using approximate Bayesian computation. Biometrics. 2011;67(1):225–233. doi: 10.1111/j.1541-0420.2010.01410.x. [DOI] [PubMed] [Google Scholar]
- Dukic V, Lopes HF, Polson NG. Tracking epidemics with Google flu trends data and a state-space SEIR model. Journal of the American Statistical Association. 2012;107(500):1410–1426. doi: 10.1080/01621459.2012.713876. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Earn DJ. Mathematical epidemiology. Springer; 2008. A light introduction to modelling recurrent epidemics; pp. 3–17. [Google Scholar]
- Ephraim Y, Mark BL. Bivariate Markov processes and their estimation. Foundations and Trends in Signal Processing. 2012;6(1):1–95. [Google Scholar]
- van den Eshof J, Hochbruck M. Preconditioning lanczos approximations to the matrix exponential. SIAM Journal on Scientific Computing. 2006;27(4):1438–1457. [Google Scholar]
- Feller W. An Introduction to Probability Theory and its Applications. Vol. 1. John Wiley & Sons; 1968. [Google Scholar]
- Finkenstädt B, Grenfell B. Time series modelling of childhood diseases: a dynamical systems approach. Journal of the Royal Statistical Society: Series C (Applied Statistics) 2000;49(2):187–205. [Google Scholar]
- Golightly A, Wilkinson DJ. Bayesian inference for stochastic kinetic models using a diffusion approximation. Biometrics. 2005;61(3):781–788. doi: 10.1111/j.1541-0420.2005.00345.x. [DOI] [PubMed] [Google Scholar]
- Griffiths D. A bivariate birth-death process which approximates to the spread of a disease involving a vector. Journal of Applied Probability. 1972;9(1):65–75. [Google Scholar]
- Hitchcock S. Extinction probabilities in predator-prey models. Journal of Applied Probability. 1986;23(1):1–13. [Google Scholar]
- Iglehart DL. Multivariate competition processes. The Annals of Mathematical Statistics. 1964;35(1):350–361. [Google Scholar]
- Ionides E, Bretó C, King A. Inference for nonlinear dynamical systems. Proceedings of the National Academy of Sciences, USA. 2006;103(49):18,438–18,443. doi: 10.1073/pnas.0603181103. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ionides EL, Nguyen D, Atchadé Y, Stoev S, King AA. Inference for dynamic and latent variable models via iterated, perturbed Bayes maps. Proceedings of the National Academy of Sciences, USA. 2015;112(3):719–724. doi: 10.1073/pnas.1410597112. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Jahnke T, Huisinga W. Solving the chemical master equation for monomolecular reaction systems analytically. Journal of Mathematical Biology. 2007;54(1):1–26. doi: 10.1007/s00285-006-0034-x. [DOI] [PubMed] [Google Scholar]
- Karev GP, Berezovskaya FS, Koonin EV. Modeling genome evolution with a diffusion approximation of a birth-and-death process. Bioinformatics. 2005;21(Suppl 3):iii12–iii19. doi: 10.1093/bioinformatics/bti1202. [DOI] [PubMed] [Google Scholar]
- Keeling M, Ross J. On methods for studying stochastic disease dynamics. Journal of The Royal Society Interface. 2008;5(19):171–181. doi: 10.1098/rsif.2007.1106. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kermack W, McKendrick A. A contribution to the mathematical theory of epidemics. Proceedings of the Royal Society of London Series A. 1927;115(772):700–721. [Google Scholar]
- Lentz WJ. Generating Bessel functions in Mie scattering calculations using continued fractions. Applied Optics. 1976;15(3):668–671. doi: 10.1364/AO.15.000668. [DOI] [PubMed] [Google Scholar]
- Levin D. Development of non-linear transformations for improving convergence of sequences. International Journal of Computer Mathematics. 1973;3(1–4):371–388. [Google Scholar]
- Martin AD, Quinn KM, Park JH. MCMCpack: Markov chain Monte Carlo in R. Journal of Statistical Software. 2011;42(9):22. URL http://www.jstatsoft.org/v42/i09/ [Google Scholar]
- McKendrick A. Applications of mathematics to medical problems. Proceedings of the Edinburgh Mathematics Society. 1926;44:98–130. [Google Scholar]
- McKinley T, Cook AR, Deardon R. Inference in epidemic models without likelihoods. The International Journal of Biostatistics. 2009;5(1):1557–4679. [Google Scholar]
- Moler C, Loan C. Nineteen dubious ways to compute the exponential of a matrix, twenty-five years later. SIAM Review. 2003;45:3–49. [Google Scholar]
- Murphy J, O’Donohoe M. Some properties of continued fractions with applications in Markov processes. IMA Journal of Applied Mathematics. 1975;16(1):57–71. [Google Scholar]
- Novozhilov AS, Karev GP, Koonin EV. Biological applications of the theory of birth-and-death processes. Briefings in Bioinformatics. 2006;7(1):70–85. doi: 10.1093/bib/bbk006. [DOI] [PubMed] [Google Scholar]
- Owen J, Wilkinson DJ, Gillespie CS. Scalable inference for Markov processes with intractable likelihoods. Statistics and Computing. 2015;25(1):145–156. [Google Scholar]
- Rabier CE, Ta T, Ané C. Detecting and locating whole genome duplications on a phylogeny: a probabilistic approach. Molecular Biology and Evolution. 2014;31(3):750–762. doi: 10.1093/molbev/mst263. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Raggett G. A stochastic model of the Eyam plague. Journal of Applied Statistics. 1982;9(2):212–225. [Google Scholar]
- Renshaw E. Stochastic Population Processes: Analysis, Approximations, Simulations. Oxford University Press; Oxford, UK: 2011. [Google Scholar]
- Reuter GEH. Denumerable Markov processes and the associated contraction semigroups on l. Acta Mathematica. 1957;97(1):1–46. [Google Scholar]
- Reuter GEH. Competition processes. Proc 4th Berkeley Symp Math Statist Prob. 1961;2:421–430. [Google Scholar]
- Riley S, Donnelly CA, Ferguson NM. Robust parameter estimation techniques for stochastic within-host macroparasite models. Journal of Theoretical Biology. 2003;225(4):419–430. doi: 10.1016/s0022-5193(03)00266-2. [DOI] [PubMed] [Google Scholar]
- Robert CP, Cornuet JM, Marin JM, Pillai NS. Lack of confidence in approximate Bayesian computation model choice. Proceedings of the National Academy of Sciences. 2011;108(37):15,112–15,117. doi: 10.1073/pnas.1102900108. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rosenberg NA, Tsolaki AG, Tanaka MM. Estimating change rates of genetic markers using serial samples: applications to the transposon IS6110 in Mycobacterium tuberculosis. Theoretical Population Biology. 2003;63(4):347–363. doi: 10.1016/s0040-5809(03)00010-8. [DOI] [PubMed] [Google Scholar]
- Schranz HW, Yap VB, Easteal S, Knight R, Huttley GA. Pathological rate matrices: from primates to pathogens. BMC Bioinformatics. 2008;9(1):550. doi: 10.1186/1471-2105-9-550. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sidje RB. Expokit: a software package for computing matrix exponentials. ACM Transactions on Mathematical Software (TOMS) 1998;24(1):130–156. [Google Scholar]
- Sunnåker M, Busetto AG, Numminen E, Corander J, Foll M, Dessimoz C. Approximate Bayesian computation. PLoS Computational Biology. 2013;9(1):e1002,803. doi: 10.1371/journal.pcbi.1002803. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Thompson I, Barnett A. Coulomb and Bessel functions of complex arguments and order. Journal of Computational Physics. 1986;64(2):490–509. [Google Scholar]
- Xu J, Guttorp P, Kato-Maeda M, Minin VN. Likelihood-based inference for discretely observed birth–death-shift processes, with applications to evolution of mobile genetic elements. Biometrics. 2015;71(4):1009–1021. doi: 10.1111/biom.12352. [DOI] [PMC free article] [PubMed] [Google Scholar]