Skip to main content
Springer logoLink to Springer
. 2017 Oct 13;79(12):2905–2928. doi: 10.1007/s11538-017-0356-4

A Multi-stage Representation of Cell Proliferation as a Markov Process

Christian A Yates 1,, Matthew J Ford 3,4, Richard L Mort 2
PMCID: PMC5709504  PMID: 29030804

Abstract

The stochastic simulation algorithm commonly known as Gillespie’s algorithm (originally derived for modelling well-mixed systems of chemical reactions) is now used ubiquitously in the modelling of biological processes in which stochastic effects play an important role. In well-mixed scenarios at the sub-cellular level it is often reasonable to assume that times between successive reaction/interaction events are exponentially distributed and can be appropriately modelled as a Markov process and hence simulated by the Gillespie algorithm. However, Gillespie’s algorithm is routinely applied to model biological systems for which it was never intended. In particular, processes in which cell proliferation is important (e.g. embryonic development, cancer formation) should not be simulated naively using the Gillespie algorithm since the history-dependent nature of the cell cycle breaks the Markov process. The variance in experimentally measured cell cycle times is far less than in an exponential cell cycle time distribution with the same mean.

Here we suggest a method of modelling the cell cycle that restores the memoryless property to the system and is therefore consistent with simulation via the Gillespie algorithm. By breaking the cell cycle into a number of independent exponentially distributed stages, we can restore the Markov property at the same time as more accurately approximating the appropriate cell cycle time distributions. The consequences of our revised mathematical model are explored analytically as far as possible. We demonstrate the importance of employing the correct cell cycle time distribution by recapitulating the results from two models incorporating cellular proliferation (one spatial and one non-spatial) and demonstrating that changing the cell cycle time distribution makes quantitative and qualitative differences to the outcome of the models. Our adaptation will allow modellers and experimentalists alike to appropriately represent cellular proliferation—vital to the accurate modelling of many biological processes—whilst still being able to take advantage of the power and efficiency of the popular Gillespie algorithm.

Keywords: Cell cycle, Markovian representation, Stochastic simulation, Gillespie algorithm, Exponentially modified Erlang

Introduction

In a well-mixed solution of chemicals undergoing reactions, non-reactive collisions occur far more often than reactive collisions allowing us to neglect the fast dynamics of motion. We can thus assume that the time between reactive collision events is exponentially distributed with rates which are a combinatorial function of the numbers of available reactants (Gillespie 1976, 1977). This premise is the basis of the Gillespie (1976) stochastic simulation algorithm.1 The Gillespie algorithm has become a ubiquitous algorithm for the simulation of stochastic systems in the biological sciences, in particular in computational systems biology (Szekely and Burrage 2014).

However, the Gillespie algorithm is often used inappropriately to represent processes for which the inter-event time is not exponentially distributed. One prevalent example of this is in the simulation of the cell cycle (Baar et al. 2016; Castellanos-Moreno et al. 2014; Ryser et al. 2016; Figueredo et al. 2014; Turner et al. 2009; Mort et al. 2016; Zaider and Minerbo 2000) (see Fig. 1). The assumption of memorylessness, and consequently exponentially distributed cell cycle times, means that with high probability a daughter cell may divide immediately after the division event which created it. This is not biologically plausible since each cell is required to pass through the G1,S,G2 and M phases of the cell cycle before division, and these phases (in particular S-phase) are rate-limiting.

Fig. 1.

Fig. 1

(Color figure online) The poor agreement between the best-fit exponential distribution (red curve) and experimentally determined cell cycle times in NIH 3T3 mouse embryonic fibroblasts grown in vitro (grey histograms). The rate parameter of the exponential distribution was fitted by minimising the sum of squared residuals between the curve and the bars of the histogram

As an illustrative example, Turner et al. (2009) present a well-mixed stochastic model of small populations of cancer stem cells, which they use to suggest treatment strategies. Both analytical and simulated results pertaining to the survival of the tumour are based on the assumption that inter-division times are exponentially distributed. We demonstrate later in this paper that using the correct cell cycle time distributions (CCTDs) could alter their results leading to different suggested treatment strategies.

Similarly, in a spatially extended context, Baker and Simpson (2010) investigate the role of spatial correlations on individual-based models of cell migration, proliferation and death, designed to represent experimental assays of cell behaviour in culture. The individual-based models they employ are on-lattice, volume-exclusion processes in two and three dimensions in which cell migration, proliferation and death events are all considered to be exponentially distributed. Cell proliferation occurs when a cell is chosen to divide, placing a daughter cell at one of its neighbouring lattice sites. Baker and Simpson (2010) demonstrate the effects of spatial correlations in these models. In particular, they find that changing the motility of the cells can alter their net rate of growth in comparison with the logistic growth predicted by a simple mean field assumption which neglects the effects of correlations. This effect is due to the fact that cell motility serves to break up correlations allowing more proliferation events to occur in comparison with the lower motility case. By explicitly considering the correlations between the occupancies of pairs of lattice sites, Baker and Simpson (2010) derive a more accurate population-level model which better represents the growth in the number of cells over time for a diverse range of parameter values. We will investigate the effects of incorporating more realistic CCTDs on the outcomes of the model simulations.

Non-Markovian simulation methods exist for events which do not have exponentially distributed inter-event times (Boguná et al. 2014). However, these algorithms are often difficult to understand and complex to encode since we are required to keep track of every cell individually. This presents a potential barrier to their use and consequently a barrier to the appropriate modelling of CCTDs.

Given the ubiquity of the Gillespie algorithm, it would be significantly more beneficial if we could decompose the cell cycle into a series of exponentially distributed events which could be naturally encoded in the framework of the Gillespie algorithm. One potential solution to this problem is the use of the hypoexponential family of distributions. It has been suggested that these distributions can be used to accurately represent phases of the cell cycle (and, by closedness of the sums of these distributions, the cell cycle itself) (Stewart 2009). Hypoexponential distributions are made up of a series of k independent exponential distributions, each with its own rate, λi, in series. If k is large, then these models may face issues of parameter identifiability.

Recently, Weber et al. (2014) have suggested that a delayed hypoexponential distribution (consisting of three delayed exponential distributions in series) could be used to appropriately represent the cell cycle. These delayed exponential distributions represent the G1,S and a combined G2/M phases of the cell cycle. Their model is an extension of the seminal stochastic cell cycle model of Smith and Martin (1973) who use a single delayed exponential distribution to capture the variance in the cell cycle. Delayed hypoexponential distributions representing periods of the cell cycle have been justified by appealing to the work of Bel et al. (2009). Bel et al. (2009) showed that the completion time for a large class of complex theoretical biochemical systems, including DNA synthesis and repair, protein translation and molecular transport, can be well approximated by either deterministic or exponential distributions.

In this paper, we consider two special cases of the general hypoexponential distribution: the Erlang and exponentially modified Erlang distribution which, in turn, are special cases of the Gamma and exponentially modified Gamma distributions. For reference, their PDFs PE and PEME, respectively, are given below:

graphic file with name 11538_2017_356_Equ1_HTML.gif 1

With suitable parameter choices, both distributions have been shown to provide good fits to large numbers of experimentally derived CCTDs (Golubev 2016) (see Fig. 2 for one such example). As special cases of the hypoexponential distributions, these distributions also have the significant advantage that they can be simulated using the ubiquitous Gillespie stochastic simulation algorithm. This will allow for the appropriate representation of CCTDs in stochastic models of cell populations, in contrast to the inappropriate exponentially distributed times which are commonly used (Baar et al. 2016; Castellanos-Moreno et al. 2014; Ryser et al. 2016; Figueredo et al. 2014; Turner et al. 2009; Mort et al. 2016; Zaider and Minerbo 2000). Additionally, the two and three parameters (respectively) of the Erlang and exponentially modified Erlang distributions (respectively) simplify parameter identification in comparison with more highly parametrised distributions. These two choices (Erlang and exponentially modified Erlang distributions) are not the only non-monotone distributions which could be used to appropriately represent the cell cycle. However, they are the general, non-monotone, hypoexponential distributions with the fewest number of parameters (two for Erlang and three for exponentially modified Erlang). These features will aid parameter identifiability (few parameters) and crucially mean the distributions can be simulated using the Gillespie algorithm (hypoexponentiality), making these the most suitable distributions to consider.

Fig. 2.

Fig. 2

(Color figure online) The agreement between experimentally determined cell cycle times in NIH 3T3 mouse embryonic fibroblasts grown in vitro (grey histograms) and a the Erlang distribution (green curve), b the exponentially modified Erlang distribution (blue curve)

Figure 2 demonstrates the improved agreement between the Erlang and exponentially modified Erlang distributions with the experimental data in comparison with the exponential distribution (c.f. Fig. 1). In each case, the parameters of the distributions are fitted by minimising the sum of squared residuals, Σ, between the curve and the bars of the histogram.2 Clearly, for the exponential distribution (see Fig. 1), the shape of the curve is incorrect. Consequently, the exponential distribution gives a poor representation of the true CCTD with a sum of squared residuals Σ=1.86×10-6. Evidently the Erlang distribution with parameters λ=0.0083 and k=12 gives a much better agreement to the experimental data (see Fig. 2a), with a minimised sum of squared residuals, Σ=1.23×10-7. Finally, the exponentially modified Erlang distribution with parameters λ1=0.0251,λ2=0.0019 and k=26 gives an even better agreement to the data3 with a minimised sum of squared residuals, Σ=6.01×10-8. The exponentially modified Erlang distribution achieves a minimised sum of squared residuals which is around half that of the Erlang distribution. Nevertheless, both Erlang and exponentially modified Erlang are good candidates for fitting cell cycle time data and can both be simulated within the existing Gillespie framework, so will be considered here.

In Sect. 2, we begin by outlining a general hypoexponential model of the cell cycle and noting that many previous models of the cell cycle are special cases. By simplifying the model further, we demonstrate that the Erlang and exponentially modified Erlang distributions are also special cases. In Sect. 3, we consider the special case of the Erlang distributed CCTD in more detail. Undertaking some simple analysis, we derive the expected behaviour of the mean cell number in the case of Erlang CCTDs and demonstrate analytically that significant differences can arise in comparison with models in which exponentially distributed CCTDs are used. In Sect. 4, we demonstrate the utility of our new CCTD representation in stochastic simulations of two biological models in which cellular proliferation is of critical importance. In each case, we show, through simulation, that there are important quantitative and qualitative differences between models which represent cell cycle times appropriately and those which do not. We conclude in Sect. 5 with a short discussion on the implications of our findings.

Multi-stage Model of the Cell Cycle

We divide the cell cycle (with mean length C) into k stages.4 The time to progress through each of these stages is exponentially distributed with mean μi. We can represent the progression through these stages of the cell cycle as the following chain of ‘reactions’

X1λ1X2λ2λk-1Xkλk2X1, 2

where λi=1/μi.

The CCT under this model is hypoexponentially distributed. Although there is no simple closed form for the probability density function of the hypoexponential distribution, we can find simple expressions for its mean and variance. The mean is given by the sum of the means of the exponentially distributed stage times i=1kμi=C, and the variance is the sum of the variances of these stage times, i=1kμi2. By increasing the number of exponentially distributed stages, whilst decreasing their mean duration (in order to maintain the correct mean CCT), we can arbitrarily decrease the variance of the CCT. Many multi-stage models of the cell cycle are special cases of this general model (Golubev 2016; Hawkins et al. 2007; Hillen et al. 2010; Hoel and Crump 1974; Kendall 1948; Leander et al. 2014; León et al. 2004; Nakaoka and Inaba 2014; Powell 1955; Smith and Martin 1973; Weber et al. 2014; Zilman et al. 2010).

We can analyse the cell cycle reaction chain (2) further by considering the associated probability master equation (PME). Let P(x1,x2,,xk,t) be shorthand for the probability that there are x1 cells in stage one, x2 in stage two and so on. The PME is

graphic file with name 11538_2017_356_Equ3_HTML.gif 3

By multiplying the PME by xj and summing over the state space, we can find the evolution of the mean number of cells, Mj=xxjP, in each stage, where x is shorthand for x1=1xk=1 and P is shorthand for P(x1,x2,,xk,t). Upon simplification we find the following evolution equations for the mean number of cells in each stage

graphic file with name 11538_2017_356_Equ4_HTML.gif 4

Identical Rates of Progression

The hypoexponential model’s generality is also a significant drawback since it hampers parameter identifiability (Weber et al. 2014). As such, we seek to reduce the number of free parameters in the model whilst maintaining its ability to accurately represent CCTDs. Several authors have suggested using the Gamma distribution to model CCTDs (Hawkins et al. 2007; Kendall 1948; Nakaoka and Inaba 2014; Zilman et al. 2010). If we assume that all transition rates, λi, are identically equal to λ1 (for i=1,,k) in our general hypoexponential model, then the time to progress through the whole cell cycle is distributed according to the sum of k identically exponentially distributed random variables. It is straightforward to show (using moment generating functions or convolutions) that the CCTD is Erlang distributed with scale parameter μ=C/k and shape parameter k. In analogy with the general hypoexponential case, if we decrease μ and simultaneously increase k so that μk=C remains constant, the Erlang distribution approaches the Dirac delta function centred on C, demonstrating that we can still arbitrarily reduce the variance to match the distribution we are trying to model.

Analysis of the CCDT with Equal Rates of Progression

We now analyse this CCTD model with identical rates of progression, noting that Kendall (1948) studied this case extensively and we draw on some of his analyses below. Although for this special case it is possible to derive a closed form first-order partial differential equation for the evolution of the generating function corresponding the master equation (3), solving the associated characteristic equations is analytically intractable for all but the simplest case (k=1) (Kendall 1948). Instead we will focus on the mean behaviour of the cell population with which we can make some analytical progress.

In the equal rates case, we can sum the individual equations in system (4) to give

graphic file with name 11538_2017_356_Equ5_HTML.gif 5

where M=ikMi.

Consider the naive one stage (i.e. k=1) cell cycle mode with mean cell cycle time C:

X1/C2X. 6

The evolution of the mean number of cells is given by the special case of Eq. (5):

graphic file with name 11538_2017_356_Equ7_HTML.gif 7

In the multi-stage model, under the assumption that all cells are evenly distributed between the stages (i.e. Mi=M/k), we can replace Mk with M / k in Eq. (5) to give a closed equation for the evolution of the total number of cells which matches equation (7):

graphic file with name 11538_2017_356_Equ8_HTML.gif 8

However, the assumption on the even distributions of cells between stages is incorrect. This leads to differences not just, as might be expected, between the variation exhibited by the multi-stage and single-stage models, but also between their mean behaviour. In Fig. 3a, a clear difference between the k=1 and k=4 models is evident. The mean total cell number grows significantly more slowly in the k=4 case than the k=1 case. This is true for all models in which k>1. Intuitively, exponentially distributed CCTs imply that the most probable time for a cell to divide is the current time. Once a cell has divided, it is immediately able to divide again with high probability allowing cells proliferating under the exponentially distributed CCT assumption to reinforce their numbers. This is in direct contrast to cells with Erlang distributed CCTs (with the same mean but k>1) which, with high probability, will wait for a period of time before dividing. In short, the larger variance of the exponentially distributed CCT population allows it to grow more rapidly.

Fig. 3.

Fig. 3

(Color figure online) The evolution of the of a the total numbers of cells and b the mean numbers of cells in each of k=4 stages. In a, we plot the numerical (red line) and analytical (dashed black line) solutions for the total mean number of cells in the case k=4 and according to the naive (k=1) cell cycle model [analytical solution of Eq. (7)—blue line]. In b analytically determined solutions [see Eqs. (12)–(15)] are plotted as dashed black lines and their numerical counterparts on top as solid coloured lines. The average CCT is C=10 arbitrary time units. The average period of each stage is equal (μi=C/k=2.5,λi=1/μi=0.4 for i=1,,k)

Under the assumption of identical transition rates, equation system (4) can be reduced to a closed equation for the mean number of cells in the kth stage

graphic file with name 11538_2017_356_Equ9_HTML.gif 9

and a set of k-1 ODEs which relate the number of cells in the other stages to Mk

graphic file with name 11538_2017_356_Equ10_HTML.gif 10

Under the given initial conditions, a single cell in the first stage and no cells in any other stages, we can solve these equations to find

Mj=2(1-j)/kkr=0k-1z(1-j)rexp((21/kzr-1)kt/C), 11

where z is the first nth root of unity (Kendall 1948). Although this expression looks complicated, in some cases it is possible to express Mj in a simple closed form. For example, when k=4

M1=exp(-4t/C)2cosh29/4tC+cos29/4tC, 12
M2=exp(-4t/C)25/4sinh29/4tC+sin29/4tC, 13
M3=exp(-4t/C)23/2cosh29/4tC-cos29/4tC, 14
M4=exp(-4t/C)27/4sinh29/4tC-sin29/4tC. 15

A comparison between these analytical solutions and their numerically solved counterparts demonstrates their veracity in Fig. 3b.

By summing Eq. (11) over all values of j=1,,k, we can also find an expression for the total number of cells in a population:

M(t)=12kr=0k-121/k21/kzr-1exp(21/kzr-1)kt/C. 16

Although these formulae [Eqs. (12)–(16)] may be useful in specific cases where the closed form of the solution is readily accessible, their real utility is in shedding light on the asymptotic properties of the mean numbers of cells.

In the limit that t gets large for finite k the dominant term in the summation in Eq. (11) corresponds to the case r=0. Indeed for k28 the real parts of the other elements in the summation are negative, and hence, these terms decay (Kendall 1948). Thus, we have

limtMj1k2(1-j)/kexptαk/C, 17

where

αk=k21/k-1. 18

Summing Eq. (17) over all k stages leads to the asymptotic behaviour of the cell population as a whole:

limtM(t)=21/k2αkexptαk/C. 19

Equation (19) can be re-written as

limtM(t)=21/k2αkeαkt/C. 20

For all k>1, not only is the base of the exponent t / C less then e (since αk<1, for k>1), but the coefficient is less than unity (Kendall 1948). This implies that, asymptotically, the expected total number of cells in a multi-stage model will always be less than the number expected in a single-stage cell cycle model [which can be determined upon substituting k=1 in to (19)].

Note that in the limit as k,αkln2. Thus, as might have been expected for the deterministic model resulting from the limit k, the asymptotic population grows with base 2, doubling at regular intervals as the cells divide synchronously:

limklimtM=limk21/k2αk·2kt/C. 21

Surprisingly though, the coefficient of 2k/Ct does not tend to unity in Eq. (21) as might have been expected. Thus, the total population grows like

limklimtM0.721·2kt/C. 22

Reversing the order of limits and taking the limit as k tends to infinity of Eq. (16) for finite t gives the limit

limkM(t)=2t/C, 23

for non-integer value of t / C, where x gives the integer part of x (Kendall 1948). For integer values of t / C, the limit is

limkM(t)=342t/C, 24

corresponding to the algebraic mean of the limits of Eq. (23) as integers values are approached from the left and right hand sides. This “deterministic” doubling process is unsurprising since the waiting time distribution tends to a delta function in the k limit, implying that cell division is synchronous.

Cells are Not Distributed Proportional to Stage Length

Returning to Eq. (4) under the assumption of identical rates of progression through the stages, we can derive corresponding equations for the mean proportion of cells in each stage, M^j=Mj/M for j=1,,k:

dM^jdt=λ12M^k-M^1-M^1Mn^,forj=1,λ1M^j-1-M^j-M^jM^k,forj1. 25

At steady state, we have the following recurrence relations for the mean proportion of cells in each stage

M^jst=2M^kst1+M^kst,forj=1,M^j-1st1+M^kst,forj1. 26

In particular, this implies that M^jst<M^j-1st for j=2k, so that, at steady state, as we progress through the stages, we will have successively fewer cells in each stage on average (independent of the initial distribution of cells amongst different stages). By solving these recurrence formulae, we can find exact expressions for the steady-state proportions:

M^jst=(2k)k-j(2k-1). 27

In particular, note that

M^1stM^kst2ask. 28

That is to say there are twice as many cells in the first stage as the last stage at steady state when the number of stages is large.

These differences are potentially important for determining average CCTs experimentally. One popular method for determining cell cycle times is to label S-phase cells using two sequentially administered distinct DNA specific labels (Wimber and Quastler 1963; Bokhari and Raza 1992). The administration of the labels is separated by a known time period. By counting cells labelled with one or both labels, and with reference to the known time period of separation, it is possible to calculate the mean duration of the S-phase. Once the proportion of cells in S-phase and the mean duration of S-phase have been determined, it is also possible to calculate the mean cell cycle time for the population (Nowakowski et al. 1989).

The method outlined above implicitly makes the assumption that the number of cells in a particular phase of the cell cycle is proportional to the length of that phase. For the multi-stage model, we have demonstrated that in the large time limit this is unequivocally not the case. Equation (11) can also be used to show that this phenomenon holds dynamically, although the mathematics is cumbersome. Instead we solve Eq. (4) numerically. Numerical solution also allows us to investigate the more general hypoexponential CCTD model (2) for which no analytical solutions are available. Figure 4a, b displays the evolution of the mean numbers and proportions (respectively) of cells in each stage for equal stage progression rates, λ1, and Fig. 4c, d displays the equivalent for unequal progression rates. The number/proportion of cells in each stage is not proportional to the mean duration of the stage, μi, either at steady state (compare actual steady-state proportions with the stars representing the normalised mean stage durations, μi/μi, in Fig. 4b, d) or dynamically.

Fig. 4.

Fig. 4

(Color figure online) The evolution of the of the mean numbers (a, c) and proportions (b, d) of cells in each of k=5 stages. In all cases, the average CCT is C=10 arbitrary time units. a, b Represent the scenario in which rates are chosen so that the average period of each stage is equal (μi=C/k=2,λi=1/μi=0.5 for i=1,,k), c and d the scenario in which the mean stage durations, μi, are chosen by partitioning the total CCT uniformly at random into k=5 parts. Rates are given by λi=1/μi for i=1,,k. Stars at t=30 on (b) and (d) indicate the expected proportion of cells at steady state if numbers of cells in each stage were proportional to cell stage duration. For the equal progression rates model, all stars overlap in (b)

The Exponentially Modified Erlang Distribution

Although the identical-stage model, which gives rise to the Erlang distribution for CCTDs, is convenient from a mathematical perspective, it has been shown to have been outperformed by a number of other distributions (Golubev 2010, 2016). In particular, by considering 77 independent CCT data sets, Golubev (2016) has recently shown that one of the most appropriate distributions for representing CCTDs is the exponentially modified Gamma (EMG) distribution. For our purposes, we will require that the shape parameter of the Gamma distribution is be integer-valued so that the CCTD is actually an exponentially modified Erlang (EME). This will mean that we can continue to simulate CCTs using a series of exponentially distributed random variables (albeit one of them will have a different rate). Consequently, this will allow us to continue to appropriately simulate processes in which cell division is important using the popular Gillespie algorithm. In order to generate EME distributed CCTs, we modify our multi-stage cell cycle model as follows:

X1λ1X2λ1λ1Xkλ1Xk+1λ22X1. 29

Note that, in system (29), the rate of progression is identical through each of the initial k stages of cell cycle and that we have added an additional exponentially distributed stage at the end whose rate, λ2, is distinct from the rate, λ1, of the previous k stages.

We can ascertain the probability density function for the EME distribution, PEME(t), by convolving the Erlang (PER(t)) and exponential (PE(t)) distributions as follows,

graphic file with name 11538_2017_356_Equ30_HTML.gif 30

where λ2 is the rate of the exponential distribution with which we are convolving and, as before, λ1 is the rate of progression through each of the k identical exponentially distributed stages which comprise the Erlang distribution. We can simplify expression (30) to the following formulation

PEME(t)=λ2e-tλ2λ1λ1-λ2k1-Γ(k,Lt)(k-1)!, 31

where L=λ1-λ2 and Γ(k,Lt)=Ltzk-1e-zdz is the complementary incomplete gamma function.

We note that it is almost as simple to simulate this more general distribution in the Gillespie algorithm using a series of exponentially distributed stages as it is to simulate the distribution with constant rates of progression between stages. Indeed the simulation of any hypoexponential CCTD is straightforward in the Gillespie algorithm. However, the addition of extra parameters hampers their identifiability when fitting to experimental data and as such we only suggest using the Erlang or exponentially modified Erlang distributions in models of the CCTD.

In the following section, we illustrate the importance of incorporating non-exponentially distributed CCTDs into stochastic simulations of cellular proliferation. For ease of understanding, we concentrate purely on Erlang CCTDs, and note that the parameters are not based on fitted CCTDs but merely chosen for illustrative purposes.

Illustrative Examples

In this section, we recapitulate results from two different models which each assume exponentially distributed CCTs. The first is a well-mixed model of cancer stem cell proliferation and differentiation in a brain tumour. The second is a spatially extended model of cell migration and proliferation mimicking a growth-to-confluence experimental assay. In each case, we alter the CCTD in order to see what effect this has on the qualitative and quantitative results presented in the papers. For clarity, we will restrict ourselves to Erlang distributed CCTs, but note that results are qualitatively similar for exponentially modified Erlang distributed CCTs.

Cancer Stem Cell Maintenance

Turner et al. (2009) investigate the role of sub-populations of cells within a brain tumour possessing stem cell-like properties and responsible for maintaining the tumour. In situations (e.g. post-treatment) in which there are small numbers of stem cells, they consider a stochastic model of cell proliferation and differentiation. Stem cells, S, can undergo symmetric division in which the daughter cells possess the same characteristics as the parent cells [see Eq. (32)] and the stem cell population increases. They can also undergo asymmetric self-renewal in which one stem cell and one progenitor cell, P, are produced [see Eq. (33)] or symmetric proliferation in which two progenitor cells result from a stem cell division [see Eq. (34)]. Cell cycle times are exponentially distributed with rate ρs and fate choices (about which division type to undergo) are made at the point of division. With probability r1, symmetric division occurs, and with probability r3, symmetric proliferation occurs. Consequently, with probability r2=1-r1-r3 asymmetric self-renewal occurs. These divisions with their effective rates are captured in the reaction system (32)–(34):

Sρsr1S+S, 32
Sρsr2S+P, 33
Sρsr3P+P. 34

Under the assumption of exponential CCTDs, Turner et al. (2009) write down and solve a simple probability master equation for the stem cell population. In particular, they consider the case in which r1>r3 which implies a positive net growth rate of the stem cell population. Under this assumption the mean number of cells in the stem cell population and variance can be shown to increase exponentially. Since the model is linear, by appealing to the central limit theorem, Turner et al. (2009) argue that, for large enough cell populations, the exact mean field equations given by

graphic file with name 11538_2017_356_Equ35_HTML.gif 35

will approximate the stochastic dynamics well.

In order to ensure a more realistic representation of the CCTD, we introduce a multi-stage cell division process, as suggested above, so that the CCTDs are now Erlang distributed with the same mean, ρs, but with shape parameter k (and thus scale parameter μ1=1/(ρsk)). As, before, at each division event, a choice about the type of division to occur is made with the same probabilities (r1,r2,r3) as previously specified. Although we still get exponential increases in the mean and variance, the rate of increase is significantly decreased (see Fig. 5a, b). Crucially this means that the deterministic mean field model derived from the original process will significantly overestimate the number of cancer stem cells in the tumour which could have significant therapeutic implications.

Fig. 5.

Fig. 5

(Color figure online) The evolution of the of the mean numbers (a), variance (b), and probability of the tumour having more than 1000 stem cells (c), for cancer stem cells under model (32)–(34) with varying numbers of exponentially distributed stages of the cell cycle, k=1,2,5,10. The average CCT is ρs=1 and division probabilities are r1=0.2 and r3=0.15. Results are calculated from M=10,000 repeat simulations

Under this model with r1>r3, if a tumour is not completely eradicated by treatment, it is possible that it can return. It may therefore be informative to know the probability that a tumour will reach a certain size by a particular time in order to plan appropriate follow-up therapeutic intervention. For example, we may be interested to know the evolution of the probability that the tumour has reached 1000 stem cells in size (which we will denote p1000(t)) so that we might calculate the most appropriate time to initiate the follow-up intervention. In Fig. 5c, we plot the evolution of p1000(t) over time. It is clear, by t=100, that the probability of the tumour having grown to 1000 stem cells, p1000 varies significantly depending on the value of k used in the model despite the cells having the same mean CCT.5 The effects of varying CCTD can clearly be seen to influence the model outcome even in this relatively straightforward linear model of cellular proliferation. In more complex models, in which other species depend in a nonlinear manner on the number of cells, the effects will no doubt be further exacerbated. The potential for therapeutic interventions to be based on stochastic mathematical models of cellular proliferation further emphasises the importance of modelling the CCTD correctly.

Growth-to-Confluence Assays

Next we investigate the effect of incorporating a more realistic model of cell proliferation on the behaviour of a spatially extended individual-level model of cell migration and proliferation (Baker and Simpson 2010). As such, we alter the mechanism of cellular proliferation from the original, exponentially distributed division times to our more realistic multi-stage Erlang distributed division times and observe the effect this has on the growth of the cell population. In order to achieve this, we break the proliferation process into k stages, the passage through each of which has an exponentially distributed waiting time (as described above). As before, we chose the parameter of each stages’ waiting time to ensure we have the same mean proliferation attempt time as in the original model.

In more detail, we consider a volume-exclusion process on a regular, square lattice in two dimensions with periodic boundary conditions. Each lattice site, of length h, can hold at most one cell. Each repeat realisation begins by initialising, particles uniformly at random across the Lx×Ly sites of the lattice. Agents can move between adjacent (in the von Neumann sense) lattice sites with rate Pm. Movement is unbiased, meaning that once a cell has been chosen to move it does so into one of its four neighbouring lattice sites with equal probability. If the site into which a cell attempts to move is already occupied, then that movement event is aborted: the cell attempting movement remains at its current site.

Agents undergo a proliferation stage change with rate Ppk (giving average rate Pp for unhindered progression through the k stages required for division); this results in the cell’s current proliferation stage being incremented by one if the cell is currently in one of the first k-1 stages. If the cell is in the final stage (stage k) of proliferation and is selected to change stage, then the cell attempts to place a daughter in one of its four neighbouring lattice sites with equal probability. If the chosen site is empty, the cell places a daughter in the empty site and the proliferation stages of both the parent and the daughter are reset to unity. However, if the cell attempts to place a daughter in a site which is already occupied, then that proliferation event is aborted. In the multi-stage model of the cell cycle, we then have two choices:

  1. the progression stage of the cell attempting proliferation is reset to unity;

  2. the cell remains in the kth stage.

In the original model in which k=1, these two choices are identical. Under implementation (1), cells would have the same average rate of division attempts as in the original model. However, it could be argued that implementation (2) is more realistic as real cells do not reverse through the cell cycle if division is not favourable, but remain held at checkpoints (Alberts et al. 2002). We will investigate both possibilities. In order to clearly distinguish the effects of the different CCTDs, we will not consider cell death in our simulations. For different values of Pp, the population will naturally grow at different rates. As in Baker and Simpson (2010), we will rescale time, t¯=Ppt, in order to make population evolutions comparable.

Figure 6 shows example snapshots of the domain occupancy at rescaled time t¯=10 for three different values of k=1,10,100. Panels (a)–(c) Represent implementation (1) for k=1,10,100, respectively. Panels (d)–(f) represent implementation (2) for k=1,10,100, respectively. Spatial correlations in the occupancies of lattice sites (clusters) are clearly visible in all cases.

Fig. 6.

Fig. 6

The influence of the number of proliferation stages, k, and the proliferation abortion mechanism on the spatial coverage of cells populating the domain at t=10. Cells in different stages are represented by different shades of grey. Darker shading corresponds to later stages, and white indicates empty sites. Parameters are Pm=1,Pp=1 with Lx=Ly=100. Initial seeding density is 1% (i.e. 100 cells). ac Represent implementation (1) for k=1,10,100, respectively. Increasing the number of stages in the cell cycle causes a decrease in terminal cell density in this scenario. df Represent implementation (2) for k=1,10,100, respectively. Increasing k causes an increase in the terminal cell density in this scenario

In the multi-stage model, implementation (1) generally leads to less dense colonies than implementation (2) since cells do not attempt division as frequently. Under implementation (2) (see Fig. 6e, f), a clear proliferating rim of (grey) cells can be seen with the bulk of cells being kept at stage k (black). Under implementation (1), every cell can be found in any stage of the cell cycle so it is hard to distinguish the proliferating rim (see Fig. 6b, c). The difference between the two implementations, however, is not due to aborted proliferation events in the bulk (away from the rim) but to the ability of cells at the proliferating rim to rapidly undergo a further division attempt after an aborted attempt under implementation (2). This suggests that the difference between the two implementations will only be apparent at high densities for which correlations have built up and significant numbers of division attempts are being aborted.

For low-density systems, in which very few particles are adjacent, the mean cell division attempt times are almost the same for all values of k independent of the implementation ((1) or (2)). However, the variance in the CCTDs for low-density systems affects the rate of growth with larger values of k (less variance in the CCTD) generally leading to slower growth. This effect can be understood by considering Eqs. (16) and (19) for a non-excluding population of cells, for which the finite time and asymptotic time behaviours, respectively, of cell populations with different values of k can be contrasted.

In Fig. 7, we contrast the evolution of the spatially averaged density for three values of k=1,10,100 and three proliferation rates, Pp=0.05,0.5,1, under implementation (1) [(a)–(c)] and implementation (2) [(d)–(f)].

Fig. 7.

Fig. 7

(Color figure online) The influence of the number of proliferation stages, k, and proliferation rate Pp on the evolution of average cell density. Parameters, initial conditions and domain descriptions are as in Fig. 6. ac Represent implementation (1) for Pp=0.05,0.5,1, respectively. Increasing the number of stages in the cell cycle causes the growth of cell density to be retarded throughout the simulation. df Represent implementation (2) for Pp=0.05,0.5,1, respectively. Increasing k causes an initial retardation in growth followed by an acceleration as the effect of density correlations becomes prevalent. Note that figures in which Pp1 are plotted on rescaled time axes for comparison (as described in the main text)

Under implementation (1) (see Fig. 7a–c), even as cell–cell correlations build up, multi-stage cells still proliferate more slowly than single-stage cells, since the mean division attempt time remains the same for all values of k. The increased variance of cells with fewer stages results in faster population growth.

However, under the more realistic implementation (2) (see Fig. 7d–f), cells with multi-stage cell cycles are able to re-attempt division after abortive division events more quickly than they otherwise could under the single-stage cell cycle model. Thus, effective average CCTs for cells with a multi-stage cell cycle at the proliferating rim of a cluster decrease in comparison with cells with a single-stage cell cycle. The faster the pairwise correlations build up, the more pronounced this effect becomes. With a very low proliferation rate (in comparison with fixed motility—see Fig. 7d), cell movement is effective at breaking up correlations meaning that large clusters do not form and that we only see the effect of decreasing mean CCT for larger values of k at late (scaled) times, when the density is higher. Contrastingly, when proliferation is high in comparison with motility (see Fig. 7f), clusters can form quickly preventing the bulk of cells from proliferating earlier and allowing the cells with multi-stage cell cycles to divide faster on average at the proliferating rim of these clusters than their single-stage counterparts.

It is also worth noting that the greater synchrony in cell division times for larger values of k [exemplified by Eqs. (23)–(24) for the limit of infinite k] is in evidence in the jagged nature of the yellow curves (corresponding to k=100) in all six subfigures.

Discussion

Currently, many stochastic models which incorporate cell proliferation employ the ubiquitous Gillespie stochastic simulation algorithm (Gillespie 1976, 1977). Unfortunately, in its basic form the Gillespie algorithm represents all events as exponentially distributed. Cell cycle times are not exponentially distributed and cannot therefore be represented by a single reaction event in the Gillespie algorithm. Modelling cell cycle times as a single exponentially distributed event can lead to significant alterations in model behaviour in comparison with more appropriate CCTDs. Consequently, we postulated a simple, general hypoexponentially distributed CCT which can be broken down into exponentially distributed stages allowing for straightforward simulation with the popular Gillespie algorithm. To account for ease of parameter identification, we suggested two special cases of this more general model which have been shown to do an excellent job of recapitulating CCTDs (Golubev 2016).

We postulate that the general hypoexponential distribution (Zhou and Zhuang 2007) or even the more specific Erlang (Gibson and Bruck 2000; Svoboda et al. 1994) or exponentially modified Erlang (Lucius et al. 2003) inter-event distribution time models could be used to allow the simplified simulation of complex biochemical and biophysical processes [e.g. enzymatic reactions (Nelson and Cox 2005), allosteric transitions in ion channels (Qin and Li 2004), the movement of molecular motors (Schnitzer and Block 1995), DNA unwinding (Lucius et al. 2003)] using the Gillespie algorithm. More generally, non-Markovian processes for which only the inter-event distribution, rather than the mechanism which generates this distribution, is important might be simulated efficiently using our proposed mechanism (Gibson and Bruck 2000; Floyd et al. 2010; Lucius et al. 2003; Zhou and Zhuang 2007).

We employed our improved model of cell cycle proliferation times on two recent models of real biological processes (Turner et al. 2009; Baker and Simpson 2010). In each case, we found that the incorporation of multiple stages to the cell cycle led to significant differences in the population size in comparison with the original exponentially distributed CCT model. We suggest that these difference will hold more generally throughout stochastic models in which CCTs are currently modelled as exponential. In particular, we intend to investigate the effects of our modified CCTD on the speed of invasion of a population of migrating and proliferating cells.

The application here of hypoexponentially distributed CCTs built up from a number of intermediary exponential stages assumes that the CCT is not correlated between direct descendants or within a given generation. Whilst there are scenarios in which there is no evidence for a correlation in CCT between related cells (Schultze et al. 1979), there are other situations in which this assumption is clearly invalid (Duffy et al. 2012; Hawkins et al. 2009). It is possible that some of these correlation effects can be attributed to the environment in which the cells are proliferating. However, in NIH 3T3 cells a clear correlation has been observed between daughter cells of a given mitotic event compared to more distant relatives; implying a heritable predisposition (Mort et al. 2014). Therefore, one obvious extension to this work would be to incorporate the effects of correlations in cell and phase times to better reflect the biological heterogeneity of a given system.

Acknowledgements

Open access funding provided by University of Bath. This collaboration was supported by an LMS research in pairs grant (Grant #41461). Dr. Richard Mort is supported by funding from the NC3Rs and Medical Research Scotland (Grant #NC/K001612/1 and #NC/M001091/1). Dr. Christian Yates would like to thank the CMB/CNCB preprint club for constructive and helpful comments on a preprint of this paper.

Appendix A: Materials and Methods

In order to determine cell cycle times in cell culture, NIH 3T3 Flp-In cells (Mort et al. 2014) were seeded at various densities in phenol-red-free Dulbecco’s modified eagle medium (DMEM) containing 10% fetal calf serum, 1% penicillin/streptomycin and 100μg/ml hygromycin B on glass bottomed 24-well culture plates (Greiner bio-one, UK). The next day, time-lapse imaging was performed on subconfluent wells with a 20× objective using a Nikon A1R inverted confocal microscope in a heated chamber supplied with 5% CO2 in air. The time elapsed between mitotic events was measured using the Fiji (Schindelin et al. 2012) distribution of ImageJ—an open source image analysis package based on NIH Image (Schneider et al. 2012).

Appendix B: Psuedocode for the Multi-stage Model of the Cell Cycle

One of the original (and most popular) implementations of the mathematically exact SSA is known as the direct method (Gillespie 1977). Here we present pseudocode for the direct method implementation of the simple multi-stage model of the cell cycle (corresponding to Erlang distributed CCTs) in a well-mixed context.

Let X(t) be a vector of length k which contains the number of cells in each stage at time t. A time interval τ, until the next stage advancement event, is generated. Along with it, an index j is chosen which determines from which stage a cell will advance from time t+τ. The changes in the numbers of cells caused by the stage advancement are implemented, the propensity functions (progression rate, λ, multiplied by the number of cells in each stage) are altered accordingly, and the time is updated, ready for the next (τ,j) pair to be selected. A method for the implementation of this algorithm is given below:

  1. Initialize the time t=t0 and the number of cells in each stage, X(t0)=x0.

  2. Evaluate the propensity functions, aj(X(t))=λXj(t), (for j=1,,k) associated with the advancement of cells from their respective stages, and their sum a0(X(t))=j=1kaj(X(t)).

  3. Generate two random numbers rand1 and rand2 uniformly distributed in (0, 1).

  4. Use rand1 to generate a time increment, τ, an exponentially distributed random variable with mean 1/a0(X(t)). i.e.
    τ=1a0ln1rand1.
  5. Use rand2 to generate index of the next stage advancement event, j, with probability aj(X(t))/a0(X(t)), in proportion with its propensity function, i.e. find j such that6
    j=1j-1aj(X(t))<a0(X(t))·rand2<j=1jaj(X(t)).
  6. Update the time, t=t+τ, and the state vector to reflect the advancement of one cell from the chosen stage,
    Xj=Xj-1ifj=1,,kandXj+1=Xj+1+1ifjk,orX1=X1+2ifj=k.
  7. If t<tfinal, the desired stopping time, then go to step (1). Otherwise stop.

Footnotes

1

Although Gillespie was amongst the first to popularise the stochastic simulation algorithm and derived it from physical considerations, its conception dates back to the work of Doob (1945) and Feller (1940). It was derived in a different form by Kurtz (1972).

2

Note that even simpler methods of fitting are possible. In particular, given the first two (three) moments for the Erlang (exponentially modified Erlang) distribution, parameters can be identified by matching moments. This implies the knowledge of the whole distribution of cell cycle times is not necessary. For the Erlang distribution, one would need only the mean and variance of cell cycle times. For the exponentially modified Erlang distribution, the skewness would also be required.

3

The three-parameter exponentially modified Erlang distribution may be poorly constrained for some data sets. That is to say there are several values of the parameters which give almost equally good fits to the data. Keeping the aim of carrying out stochastic simulation using the determined distribution in mind, we suggest a preference for acceptable parameter values with the smallest possible value of k. The larger the value of k, the more “reaction channels” the Gillespie algorithm must account for which, if rate-limiting, will significantly reduce the algorithm’s performance.

4

Note these stages do not necessarily correspond to the traditional (G1,S,G2 and M) phases of the cell cycle. Indeed, there is good evidence that at least one of the phases is not exponentially distributed (Hahn et al. 2009). Rather they are arbitrary division of the cell cycle which will allow us to recreate the correct CCTD.

5

Note that by varying k with a fixed cell cycle time we are implicitly varying λ, the rate of progression through each stage.

6

Note in step 1, that in the case j=1 we assume j=10=0.

The original version of this article was revised due to a retrospective Open Access order.

Change history

8/8/2019

Equations (9) and (10) were transcribed incorrectly.

Change history

8/8/2019

Equations (9) and (10) were transcribed incorrectly.

References

  1. Alberts B, Bray D, Lewis J, Raff M, Roberts K, Watson JD. Molecular biology of the cell. 4. New York: Garland Science; 2002. [Google Scholar]
  2. Baar M, Coquille L, Mayer H, Hölzel M, Rogava M, Tüting T, Bovier A (2016) A stochastic model for immunotherapy of cancer. Sci Rep 6:24169 [DOI] [PMC free article] [PubMed]
  3. Baker RE, Simpson MJ. Correcting mean-field approximations for birth-death-movement processes. Phys Rev E. 2010;82(4):041905. doi: 10.1103/PhysRevE.82.041905. [DOI] [PubMed] [Google Scholar]
  4. Bel G, Munsky B, Nemenman I. The simplicity of completion time distributions for common complex biochemical processes. Phys Biol. 2009;7(1):016003. doi: 10.1088/1478-3975/7/1/016003. [DOI] [PubMed] [Google Scholar]
  5. Boguná Marian, Lafuerza Luis F, Toral Raúl, Serrano M Ángeles. Simulating non-Markovian stochastic processes. Phys Rev E. 2014;90(4):042108. doi: 10.1103/PhysRevE.90.042108. [DOI] [PubMed] [Google Scholar]
  6. Bokhari SAJ, Raza A. Novel derivation of total cell cycle time in malignant cells using two dna-specific labels. Cytom Part A. 1992;13(2):144–148. doi: 10.1002/cyto.990130206. [DOI] [PubMed] [Google Scholar]
  7. Castellanos-Moreno A, Castellanos-Jaramillo A, Corella-Madueño A, Gutiérrez-López S, Rosas-Burgos R (2014) Stochastic model for computer simulation of the number of cancer cells and lymphocytes in homogeneous sections of cancer tumors. arXiv preprint arXiv:1410.3768
  8. Doob JL. Markoff chains-denumerable case. Trans Am Math Soc. 1945;58(3):455–473. doi: 10.2307/1990339. [DOI] [Google Scholar]
  9. Duffy KR, Wellard CJ, Markham JF, Zhou JHS, Holmberg R, Hawkins ED, Hasbold J, Dowling MR, Hodgkin PD. Activation-induced b cell fates are selected by intracellular stochastic competition. Science. 2012;335(6066):338–341. doi: 10.1126/science.1213230. [DOI] [PubMed] [Google Scholar]
  10. Feller W. On the integro-differential equations of purely discontinuous Markoff processes. Trans Am Math Soc. 1940;48(3):488–515. doi: 10.1090/S0002-9947-1940-0002697-3. [DOI] [Google Scholar]
  11. Figueredo GP, Siebers P-O, Owen MR, Reps J, Aickelin U. Comparing stochastic differential equations and agent-based modelling and simulation for early-stage cancer. PLoS ONE. 2014;9(4):e95150. doi: 10.1371/journal.pone.0095150. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Floyd DL, Harrison SC, Van Oijen AM. Analysis of kinetic intermediates in single-particle dwell-time distributions. Biophys J. 2010;99(2):360–366. doi: 10.1016/j.bpj.2010.04.049. [DOI] [PMC free article] [PubMed] [Google Scholar]
  13. Gibson MA, Bruck J. Efficient exact stochastic simulation of chemical systems with many species and many channels. J Phys Chem A. 2000;104(9):1876–1889. doi: 10.1021/jp993732q. [DOI] [Google Scholar]
  14. Gillespie DT. A general method for numerically simulating the stochastic time evolution of coupled chemical reactions. J Comput Phys. 1976;22(4):403–434. doi: 10.1016/0021-9991(76)90041-3. [DOI] [Google Scholar]
  15. Gillespie DT. Exact stochastic simulation of coupled chemical reactions. J Phys Chem. 1977;81(25):2340–2361. doi: 10.1021/j100540a008. [DOI] [Google Scholar]
  16. Golubev A. Exponentially modified Gaussian (EMG) relevance to distributions related to cell proliferation and differentiation. J Theor Biol. 2010;262(2):257–266. doi: 10.1016/j.jtbi.2009.10.005. [DOI] [PubMed] [Google Scholar]
  17. Golubev A. Applications and implications of the exponentially modified gamma distribution as a model for time variabilities related to cell proliferation and gene expression. J Theor Biol. 2016;393:203–217. doi: 10.1016/j.jtbi.2015.12.027. [DOI] [PubMed] [Google Scholar]
  18. Hahn AT, Jones JT, Meyer T. Quantitative analysis of cell cycle phase durations and pc12 differentiation using fluorescent biosensors. Cell Cycle. 2009;8(7):1044–1052. doi: 10.4161/cc.8.7.8042. [DOI] [PMC free article] [PubMed] [Google Scholar]
  19. Hawkins ML, Turner ED, Dowling MR, Van Gend C, Hodgkin PD. A model of immune regulation as a consequence of randomized lymphocyte division and death times. Proc Natl Acad Sci USA. 2007;104(12):5032–5037. doi: 10.1073/pnas.0700026104. [DOI] [PMC free article] [PubMed] [Google Scholar]
  20. Hawkins ED, Markham JF, McGuinness LP, Hodgkin PD. A single-cell pedigree analysis of alternative stochastic lymphocyte fates. Proc Natl Acad Sci USA. 2009;106(32):13457–13462. doi: 10.1073/pnas.0905629106. [DOI] [PMC free article] [PubMed] [Google Scholar]
  21. Hillen T, De Vries G, Gong J, Finlay C. From cell population models to tumor control probability: including cell cycle effects. Acta Oncol. 2010;49(8):1315–1323. doi: 10.3109/02841861003631487. [DOI] [PubMed] [Google Scholar]
  22. Hoel DG, Crump KS. Estimating the generation-time distribution of an age-dependent branching process. Biometrics. 1974;30(1):125–135. doi: 10.2307/2529623. [DOI] [PubMed] [Google Scholar]
  23. Kendall DG. On the role of variable generation time in the development of a stochastic birth process. Biometrika. 1948;35(3/4):316–330. doi: 10.2307/2332354. [DOI] [Google Scholar]
  24. Kurtz TG. The relationship between stochastic and deterministic models for chemical reactions. J Chem Phys. 1972;57(7):2976–2978. doi: 10.1063/1.1678692. [DOI] [Google Scholar]
  25. Leander R, Allen EJ, Garbett SP, Tyson DR, Quaranta V. Derivation and experimental comparison of cell-division probability densities. J Theor Biol. 2014;359:129–135. doi: 10.1016/j.jtbi.2014.06.004. [DOI] [PMC free article] [PubMed] [Google Scholar]
  26. León K, Faro J, Carneiro J. A general mathematical framework to model generation structure in a population of asynchronously dividing cells. J Theor Biol. 2004;229(4):455–476. doi: 10.1016/j.jtbi.2004.04.011. [DOI] [PubMed] [Google Scholar]
  27. Lucius AL, Maluf NK, Fischer CJ, Lohman TM. General methods for analysis of sequential “n-step” kinetic mechanisms: application to single turnover kinetics of helicase-catalyzed dna unwinding. Biophys J. 2003;85(4):2224–2239. doi: 10.1016/S0006-3495(03)74648-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
  28. Mort RL, Ford MJ, Sakaue-Sawano A, Lindstrom NO, Casadio A, Douglas AT, Keighren MA, Hohenstein P, Miyawaki A, Jackson IJ. Fucci2a: a bicistronic cell cycle reporter that allows cre mediated tissue specific expression in mice. Cell Cycle. 2014;13(17):2681–2696. doi: 10.4161/15384101.2015.945381. [DOI] [PMC free article] [PubMed] [Google Scholar]
  29. Mort RL, Ross RJH, Hainey KJ, Harrison OJ, Keighren MA, Landini G, Baker RE, Painter KJ, Jackson IJ, Yates CA. Reconciling diverse mammalian pigmentation patterns with a fundamental mathematical model. Nat Commun. 2016;7:10288. doi: 10.1038/ncomms10288. [DOI] [PMC free article] [PubMed] [Google Scholar]
  30. Nakaoka S, Inaba H. Demographic modeling of transient amplifying cell population growth. Math Biosci Eng. 2014;11(2):363–384. doi: 10.3934/mbe.2014.11.363. [DOI] [PubMed] [Google Scholar]
  31. Nelson D, Cox M. Lehninger principles of biochemistry. New York: Wiley Online Library; 2005. [Google Scholar]
  32. Nowakowski RS, Lewin SB, Miller MW. Bromodeoxyuridine immunohistochemical determination of the lengths of the cell cycle and the DNA-synthetic phase for an anatomically defined population. J Neurocytol. 1989;18(3):311–318. doi: 10.1007/BF01190834. [DOI] [PubMed] [Google Scholar]
  33. Powell EO. Some features of the generation times of individual bacteria. Biometrika. 1955;42(1/2):16–44. doi: 10.2307/2333420. [DOI] [Google Scholar]
  34. Qin F, Li L. Model-based fitting of single-channel dwell-time distributions. Biophys J. 2004;87(3):1657–1671. doi: 10.1529/biophysj.103.037531. [DOI] [PMC free article] [PubMed] [Google Scholar]
  35. Ryser M, Lee W, Ready N, Leder K, Foo J. Quantifying the dynamics of field cancerization in HPV-negative head and neck cancer: a multiscale modeling approach. Cancer Res. 2016;76(24):7078–7088. doi: 10.1158/0008-5472.CAN-16-1054. [DOI] [PMC free article] [PubMed] [Google Scholar]
  36. Schindelin J, Arganda-Carreras I, Frise E, Kaynig V, Longair M, Pietzsch T, Preibisch S, Rueden C, Saalfeld S, Schmid B, Tinevez J-Y, White DJ, Hartenstein V, Eliceiri K, Tomancak P, Cardona A. Fiji: an open-source platform for biological-image analysis. Nat Methods. 2012;9(7):676–682. doi: 10.1038/nmeth.2019. [DOI] [PMC free article] [PubMed] [Google Scholar]
  37. Schneider CA, Rasband WS, Eliceiri KW. Nih image to ImageJ: 25 years of image analysis. Nat Methods. 2012;9(7):671. doi: 10.1038/nmeth.2089. [DOI] [PMC free article] [PubMed] [Google Scholar]
  38. Schnitzer MJ, Block SM (1995) Statistical kinetics of processive enzymes. In: Cold spring harbor symposia on quantitative biology, vol 60. Cold Spring Harbor Laboratory Press, New York pp 793–802 [DOI] [PubMed]
  39. Schultze B, Kellerer AM, Maurer W. Transit times through the cycle phases of jejunal crypt cells of the mouse. Cell Tissue Kinet. 1979;12(4):347–359. doi: 10.1111/j.1365-2184.1979.tb00159.x. [DOI] [PubMed] [Google Scholar]
  40. Smith JA, Martin L. Do cells cycle? Proc Natl Acad Sci USA. 1973;70(4):1263–1267. doi: 10.1073/pnas.70.4.1263. [DOI] [PMC free article] [PubMed] [Google Scholar]
  41. Stewart WJ. Probability, Markov chains, queues, and simulation: the mathematical basis of performance modeling. Princeton: Princeton University Press; 2009. [Google Scholar]
  42. Svoboda K, Mitra PP, Block SM. Fluctuation analysis of motor protein movement and single enzyme kinetics. Proc Natl Acad Sci USA. 1994;91(25):11782–11786. doi: 10.1073/pnas.91.25.11782. [DOI] [PMC free article] [PubMed] [Google Scholar]
  43. Szekely T, Burrage K. Stochastic simulation in systems biology. Comput Struct Biotechnol J. 2014;12(20):14–25. doi: 10.1016/j.csbj.2014.10.003. [DOI] [PMC free article] [PubMed] [Google Scholar]
  44. Turner C, Stinchcombe AR, Kohandel M, Singh S, Sivaloganathan S. Characterization of brain cancer stem cells: a mathematical approach. Cell Prolif. 2009;42(4):529–540. doi: 10.1111/j.1365-2184.2009.00619.x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  45. Weber TS, Jaehnert I, Schichor C, Or-Guil M, Carneiro J. Quantifying the length and variance of the eukaryotic cell cycle phases by a stochastic model and dual nucleoside pulse labelling. PLoS Comput Biol. 2014;10(7):e1003616. doi: 10.1371/journal.pcbi.1003616. [DOI] [PMC free article] [PubMed] [Google Scholar]
  46. Wimber DE, Quastler H. A 14c- and 3h-thymidine double labeling technique in the study of cell proliferation in Tradescantia root tips. Exp Cell Res. 1963;30(1):8–22. doi: 10.1016/0014-4827(63)90209-X. [DOI] [Google Scholar]
  47. Zaider M, Minerbo GN. Tumour control probability: a formulation applicable to any temporal protocol of dose delivery. Phys Med Biol. 2000;45(2):279. doi: 10.1088/0031-9155/45/2/303. [DOI] [PubMed] [Google Scholar]
  48. Zhou Y, Zhuang X. Kinetic analysis of sequential multistep reactions. J Phys Chem B. 2007;111(48):13600–13610. doi: 10.1021/jp073708+. [DOI] [PMC free article] [PubMed] [Google Scholar]
  49. Zilman A, Ganusov VV, Perelson AS. Stochastic models of lymphocyte proliferation and death. PLoS ONE. 2010;5(9):e12775. doi: 10.1371/journal.pone.0012775. [DOI] [PMC free article] [PubMed] [Google Scholar]

Articles from Bulletin of Mathematical Biology are provided here courtesy of Springer

RESOURCES