Skip to main content
bioRxiv
  • Home
  • About
  • Submit
  • ALERTS / RSS
Advanced Search
New Results

Accelerated Predictive Healthcare Analytics with Pumas, a High Performance Pharmaceutical Modeling and Simulation Platform

View ORCID ProfileChris Rackauckas, Yingbo Ma, Andreas Noack, Vaibhav Dixit, Patrick Kofod Mogensen, Simon Byrne, Shubham Maddhashiya, José Bayoán Santiago Calderón, Joakim Nyberg, Jogarao V.S. Gobburu, Vijay Ivaturi
doi: https://doi.org/10.1101/2020.11.28.402297
Chris Rackauckas
1
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
  • ORCID record for Chris Rackauckas
  • For correspondence: crackauc@mit.edu crackauc@mit.edu
Yingbo Ma
2Julia Computing
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Andreas Noack
2Julia Computing
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Vaibhav Dixit
2Julia Computing
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Patrick Kofod Mogensen
2Julia Computing
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Simon Byrne
3Caltech
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Shubham Maddhashiya
2Julia Computing
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
José Bayoán Santiago Calderón
4Biocomplexity Institute & Initiative, University of Virginia, Pumas-AI, Inc.
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Joakim Nyberg
5University of Uppsala
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Jogarao V.S. Gobburu
6School of Pharmacy, University of Maryland, Baltimore, Pumas-AI, Inc.
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Vijay Ivaturi
6School of Pharmacy, University of Maryland, Baltimore, Pumas-AI, Inc.
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
  • Abstract
  • Full Text
  • Info/History
  • Metrics
  • Preview PDF
Loading

Abstract

Pharmacometric modeling establishes causal quantitative relationship between administered dose, tissue exposures, desired and undesired effects and patient’s risk factors. These models are employed to de-risk drug development and guide precision medicine decisions. Recent technological advances rendered collecting real-time and detailed data easy. However, the pharmacometric tools have not been designed to handle heterogeneous, big data and complex models. The estimation methods are outdated to solve modern healthcare challenges. We set out to design a platform that facilitates domain specific modeling and its integration with modern analytics to foster innovation and readiness to data deluge in healthcare.

New specialized estimation methodologies have been developed that allow dramatic performance advances in areas that have not seen major improvements in decades. New ODE solver algorithms, such as coefficient-optimized higher order integrators and new automatic stiffness detecting algorithms which are robust to frequent discontinuities, give rise to up to 4x performance improvements across a wide range of stiff and non-stiff systems seen in pharmacometric applications. These methods combine with JIT compiler techniques and further specialize the solution process on the individual systems, allowing statically-sized optimizations and discrete sensitivity analysis via forward-mode automatic differentiation, to further enhance the accuracy and performance of the solving and parameter estimation process. We demonstrate that when all of these techniques are combined with a validated clinical trial dosing mechanism and non-compartmental analysis (NCA) suite, real applications like NLME parameter estimation see run times halved while retaining the same accuracy. Meanwhile in areas with less prior optimization of software, like optimal experimental design, we see orders of magnitude performance enhancements. Together we show a fast and modern domain specific modeling framework which lays a platform for innovation via upcoming integrations with modern analytics.

Clinical pharmacologists, pharmacometricians, systems biologists and statisticians have been leveraging the latest advances in scientific computing to solve complex healthcare problems. The scientific analyses continue to evolve to be more complex as more data became available historically. However, the latest advances in computational science are not readily available to healthcare scientists.

Scientific computing and machine learning have continued to make strides in recent decade, improving core methodologies from multigrid preconditioners and neural network architectures all the way down to the basics of matrix multiplication. Surprisingly, one field which has remained consistent in both the methodologies and software used in practice is small systems of ordinary differential equations. The core software, such as the Hairer’s widely used Runge-Kutta methods (DOPRI5, DOP853) [13] and the backwards differentiation formulae (BDF) methods derived from LSODE [16] (LSODA [15], VODE [8], and CVODE [17]), were fully developed by the 90’s and have been the stable core of scientific computing ever since. However, in this manuscript we will demonstrate that this general area of computational science can see dramatic computational performance improvements by developing a new set of solver algorithms specialized for simulation of small-scale stiff and non-stiff dynamical systems.

The delay in the availability of the latest advances to healthcare scientists limits their ability to gain deep insights into why some patients do not respond to treatment, why some develop serious toxicity, risk factors for deciding on the right treatment for the right patient (precision medicine). The access to heterogenous data from laboratory measurements, radiographic scans, clinical scripts, genomic and genetic data has not fully translated into actionable science due to the lack of more efficient tools, to a large extent [12]. A related challenge has also has been the lack of a unified platform to perform these advanced scientific analyses. For example, a systems biologist cannot perform nonlinear mixed effects modeling for the same project within one software. Unknowingly, this caused serious communication issues between scientists at different stages of the same project. On other hand, one scientist cannot be expected to master all software tools. An integrated platform that allows scientists to build tools in a seamless manner is urgently needed.

Fields which require high fidelity and stable estimation of parameters of such dynamical systems, such as pharmacometrics and systems biology, are frequently constrained by the calculation times required when solving large numbers of such systems [2, 7]. In this manuscript we will demonstrate how these new differential equation solvers are integrated with automatic differentiation and parameter fitting routines in a manner that decreases the time of real-world applications by an order of magnitude.

Likewise, without a bridge that connects these new solver and compiler tools to domain-specific tooling, the ability for pharmacometricians to make use of these tools is limited and requires a modeler to go to tools usually written in low level languages like C++ or Fortran. This limits the flexibility of the allowed models and decreases the speed at which the latest advancements in high performance computing become available to the practitioner. Pumas (PharmaceUtical Modeling And Simulation) is impacting this flow by directly packaging the latest mathematical and hardware advances inside of a pharmacometric modeling context inside of the Julia high level high performance language [6]. The driving paradigm of Pumas is to have a completely flexible core while successively simplifying interfaces through generally useful defaults. This allows for a graded approach to learning the modeling framework where beginners can simply use the defaults and expect it to match standard behavior, while keeping non-standard pharmacometric models (such as stochastic differential equations) directly accessible, optimized, and able to utilize all of the hardware compatibility tooling in a first-class manner. This is made possible because Pumas is written for the Julia programming language while being written entirely written with the Julia programming language; allowing user-written extensions to flow directly from standard usage. While Julia is a high level programming language which allows Pumas to have ease of use for non-programmers, the Julia language is a just-in-time (JIT) compiled language as fast as low level languages like C or Fortran. Thus both the library and any user-written components are free from interpreter overhead imposed in languages like Python or R. Therefore, our approach with Pumas is to not shy away from using the language and its extensive package ecosystem, and instead integrate our approaches with these tools.

In this paper we will describe the generalized nonlinear mixed effects models (NLME) [7] framework which Pumas utilizes for personalized precision dosing [31]. We will then showcase how the deep integration with the DifferentialEquations.jl [33] software package can allow for many domain-optimized approaches to be accessible within the context of pharmacometric models such as those seen in pharmacokinetics and pharmacodynamics (PK/PD) [3, 43]. We will demonstrate how this connection facilitates Integrated Pharmacometrics and Systems Pharmacology (iPSP) [41] by allowing the optimized solution of large sparse PBPK and QSP models within the NLME context, and showcase how alternative differential equation forms like Differential-Algebraic Equations (DAEs) can be used to stabilize a model or Stochastic Differential Equations (SDEs) can be used to generalize a model to include process noise. Features of Pumas, like integrated high-performance noncompartmental analysis (NCA), automatically parallelized visual predictive checks (VPCs), and fast tooling for optimal design of clinical experiments is all integrated into the Pumas system to allow full applications to be simple and fast. After seeing the modeling benefits of such a framework, we detail the performance benefits, showcasing acceleration over previous software in the standard ODE NLME cases while demonstrating automated parallelism. Together Pumas is a tool built for the next-generation of pharmacometric analysis that will allow for modeling and developing personalized precision medicine in areas that were previously inaccessible due to excessive computational cost.

1 Introduction to Nonlinear Mixed Effects Modeling with Pumas

1.1 Nonlinear Mixed Effects Models

Many pharmacometric studies fall into a class of models known as nonlinear mixed effects models [7]. Figure 1 gives a diagramatic overview of this two-stage hierarchical model. In the context of pharmacometrics, the lower level model describes the drug dynamics within a subject via a differential equation while the higher the values θ which are independent of the subject. One can think of the fixed effects as population typical values. With every subject i there is a set of covariate values Zi which we can know about a subject in level model describes how the dynamical model is different between and within subject. The fixed effects are advance, such as their weight, height, or sex. We then allow a parameter ηi which is known as the random effect to be the difference between the typical value and the subject. The structural model g is the function that collates these values into the dynamical parameters for a subject pi, i.e.: Embedded Image

Figure 1:
  • Download figure
  • Open in new tab
Figure 1: Diagrammatic description of nonlinear mixed effect models.

A plate diagram of the model: rectangle nodes denote parameters, circles denote random quantities which are either latent (unfilled) or observed (filled), diamonds are deterministic given the inputs, and nodes without a border are constant.

The dynamical parameters are values such as reaction rates, drug clearance, and plasma volume which describe how the drug and patient reaction evolves over time through an ordinary differential equation (ODE): Embedded Image where f is the dynamical model and u is the state variables that are being evolved, such as the drug concentrations over time. The jth observables of patient i, yij, such as the maximum concentration or area under the curve (AUC), are derived values from the dynamical simulation through a function h: Embedded Image

Lastly, measurements are taken on the derived values by assuming measurement noise of some distribution (commonly normal) around the prediction point.

The following showcases a classic model of Theophylline dynamics via a 1-compartment model implemented in Pumas, where patients have covariates: Embedded Image a structural collocation: Embedded Image internal dynamics: Embedded Image Embedded Image and normally distributed measurement noise. The reason for the NLME model is that, if we have learned the population typical values, θ, then when a new patient comes to the clinic we can guess how they are different from the typical value by knowing their covariates Zi (with the random effect ηi = 0). We can simulate between-subject variability not captured by our model by sampling ηi from some representative distributions of the ηi from our dataset (usually denoted ηi ∼ N(0,Ω)). Therefore this gives a methodology for understanding and predicting drug response from easily measurable information.

Figure
  • Download figure
  • Open in new tab
Figure
  • Download figure
  • Open in new tab

1.2 Clinical Dosage Regimen Modeling

In addition to nonlinear mixed effects model designations, Pumas allows for the specification of clinical dosage regimens. These dosage regimens are modeled as discontinuities to the differential equation and can be specified using a standard clinical dataset or by using the programmatic DosageRegimen method directly from Julia code. Figure 2 showcases the result of a Pumas simulation of this model with steady state dosing against the pharmaceutical software NONMEM [4], showcasing that Pumas recovers the same values. The test suite for the dosing mechanism is described in Appendix 5. Appendix Figures 9 and 10 demonstrate similar results across a 20 different dosage regimens using numerical ODE solving and analytical approach for accelerated handling of linear dynamics. One interesting feature of Pumas demonstrated here is the ability to specify the continuity of the observation behavior. Because of the discontinuities at the dosing times, the drug concentration at the time of a dose is not unique and one must choose the right continuous or the left continuous value. Previous pharmaceutical modeling software, such as NONMEM, utilize right-continuous values for most discontinuities but left-continuous values in the case of steady state dosing. To simplify this effect for the user, Pumas defaults to using the right-continuous values, but allows the user to change to left continuity through the continuity keyword argument. By using right continuity, the observation is always the one captured post-dose. Since the simulations usually occur after the dose, this makes the observation series continuous with less outlier points, a feature we believe will reduce the number of bugs in fitting due to misspecified models.

Figure 2:
  • Download figure
  • Open in new tab
Figure 2: Clinical dosing simulation comparison against NONMEM.

Shown is the continuous simulation trajectory outputted from Pumas using the default (right) and left continuity choices, compared against NONMEM. This figure both showcases a relative difference < 1 × 10−10 except at the starting point, where the NONMEM simulation requires a pre-dose estimate of zero whereas the Pumas simulations allows a continuous output via a post-dose observation and allows for switching to the NONMEM behavior.

1.3 Maximum Likelihood and Bayesian Model Fitting

To understand how a drug interacts within the body, we can either simulate populations of individuals and dosage regimens or utilize existing patient data to estimate our parameters. Transitioning from a simulation approach to a model estimation approach is simply the change of the verb applied to the model object. The follow code demonstrates how moving between simulation and fitting in Pumas is a natural transition:

Figure
  • Download figure
  • Open in new tab

This example first generates a data set using simobs and then proceeds to fit the parameters of the model to data using fit. For fitting one currently has a choice between using:

  1. FO: a first order approximation to the likelihood integral

  2. FOCE: a first order conditional estimation of the likelihood integral without interaction

  3. FOCEI: a first order conditional estimation of the likelihood integral with interaction

  4. LaplaceI: a second order Laplace approximation of the likelihood integral with interaction

  5. BayesMCMC: A Bayesian Markov Chain Monte Carlo estimation of model posteriors using the Hamiltonian Monte Carlo no-U-turn sampler (NUTS)1

We use the Optim.jl package [27] for the numerical optimization and default to using a safeguarded BFGS algorithm with a backtracking line search for the fixed effects and Newton’s method with a trust region strategy for the empirical bayes estimates. The result of the fitting process is a FittedPumasModelwhich we call res. This object can be inspected to determine many quantities such as confidence intervals (as demonstrated later). Importantly, coef(res) returns the coefficients for the fixed effects in a NamedTuple that directly matches the style of fixeffs, and thus we demonstrate calling simobs on the returned coefficients as a way to check the results of the fitting process. When applied to the model of Section 1.1, this process returns almost exactly the coefficients used to generate the data, and thus this integration between the simulation and fitting models is routinely used within Pumas to generate unit tests of various methodologies.

2 Generalized Quantitative Pharmacology Models with Pumas

The following sections detail featured which are new to pharmaceutical modeling software or enhanced via parallelization or direct integration. In summary:

  1. We show how the integrated Non-compartmental Analysis (NCA) module can be mixed with NLME simulation and estimation.

  2. We show how alternative dynamical formulations, such as stochastic differential equation can be directly utilized in the NLME models.

  3. We showcase how the Pumas generalized error distribution form allows for mixing discrete and continuous data and likelihoods

  4. We detail the model diagnostics and validation tools

  5. We demonstrate the functionality for optimal design of experiments.

2.1 Integrated Non-compartmental Analysis (NCA)

NCA is a set of common analysis methods performed in all stages of the drug development program, preclinical to clinical, that has strict rules and guidelines for properly calculating diagnostic variables from experimental measurements [11]. In order to better predict the vital characteristics, Pumas includes a fully-featured NCA suite which is directly accessible from the nonlinear mixed effects modeling suite. Appendix Figures 11 and 12 demonstrate that Pumas matches industry standard software such as PKNCA [9] and Phoenix on a set of 13104 scenarios and 78,624 subjects as described in Section 5. The following code showcases the definition of a NLME model where the observables are derived quantities calculated through the NCA suite, demonstrating the ease at which a validated NCA suite can be coupled with the simulation and estimation routines.

Figure
  • Download figure
  • Open in new tab

2.2 Alternative Differential Equations via A Function-Based Interface: Stochastic, Delay, and Differential-Algebraic Equations for Pharmacology

While ODEs are a common form of dynamical model, in many circumstances additional features are required in order for the realism of the model to adequately predict the behavior of the process. For example, many biological processes are inherently stochastic, and thus an extension to ordinary differential equations, known as stochastic differential equations, takes into account the continuous randomness of biochemical processes [34, 36, 22, 46]. Many biological effects are delayed, in which case a delay differential equation which allows for an effect to be determined by a past value of the system may be an appropriate model [19, 23]. Together, Pumas allows for the definition of dynamical systems of the following non-standard forms:

  1. Split and Partitioned ODEs (Symplectic integrators, IMEX Methods)

  2. Stochastic ordinary differential equations (SODEs or SDEs)

  3. Differential algebraic equations (DAEs)

  4. Delay differential equations (DDEs)

  5. Mixed discrete and continuous equations (Hybrid Equations, Jump Diffusions)

where each can be simulated with high-performance adaptive integrators with specific method choices stabilized for stiff equations. The following code demonstrates the definition solving of a stochastic differential equation model with steady state dosing via a high strong order adaptive SDE solver specified using an alternative interface known as the Pumas function-based interface. This interface is entirely defined with standard Julia functions, meaning that any tools accessible from Julia can be utilized in the pharmacological models through this context.

Figure
  • Download figure
  • Open in new tab
Figure
  • Download figure
  • Open in new tab

2.3 Generalized Error Distribution Abstractions

Traditional nonlinear mixed effects models formulate the error distribution handling in a different manner, focusing on the perturbation via the error against the estimate. Mathematically, this amounts to having an measurement noise, i.e. defining the observables as: Embedded Image

Instead of using the perturbation format, Pumas allows for users to specify the likelihood directly via any arbitrary Distributions.jl [5] distribution, with the mean of the distribution corresponding to the prediction. This has some immediate advantages. For one, many distributions are not directly amenable to the perturbation form. For example, one may wish to model a discrete observable, such as a pain score, probabilistically based on clinical outputs. A discrete likelihood function, like a Poisson distribution, can thus be given to described the predicted outputs like in the following example:

Figure
  • Download figure
  • Open in new tab
Figure
  • Download figure
  • Open in new tab

This type of model could not be described with continuous perturbations and thus would have to be approximated in other scenarios. In addition, since any distribution is possible in this format, users can extend the modeling schema to incorporate custom distributions. Discrete Markov Chain models, or Time to Event models for example can be implemented as a choice of a custom distribution, thus making it easy to extend the modeling space directly from standard language use.

2.4 Integrated and Parallelized Model Diagnostics and Validation

After running the estimation procedure, it is important to have a wide suite of methods to post-process the results and validate the predictions. Model diagnostics are used to check if the model fits the data well. Pumas provides a comprehensive set of diagnostics tooling A number of residual diagnostics are available as well as shrinkage estimators. Additionally, for model validation, Visual Predictive Checks (VPCs) [18] can be used for a variety of models in a performant and robust manner.

The diagnostics tooling comprises of:

  1. Residuals: Populations residuals take the inter-individual variability into account as opposed to Individual residuals which are correlated due to the lack of accounting for inter-individual variability. The following Population residuals are available in Pumas2:

    • Normalized Prediction Distribution Errors (NPDE) [26]

    • Weighted Residuals (WRES)

    • Conditional Weighted Residuals (CWRES)

    • Conditional Weighted Residuals with Interaction (CWRESI)

    Similarly the following Individual residuals are also available

    • Individual Weighted Residuals (IWRES)

    • Individual Conditional Weighted Residuals (ICWRES)

    • Individual Conditional Weighted Residuals with Interaction (ICWRESI)

    • Expected Simulation based Individual Weighted Residuals (EIWRES)

  2. Population Predictions: Population prediction are defined as the difference between the observations and the model expectation for subject i, i.e. yi-E[yi] where the E[yi] are the population predictions. The population predictions, EPRED, PRED, CPRED and CPREDI are defined as the E[yi] from equations of NPDE, WRES, CWRES and CWRESI respectively.

  3. Individual Predictions: The individual residuals are defined as the difference between the observation and the model prediction for subject i, i.e. yi - Embedded Image where the Embedded Image are the individual predictions. The individual predictions IPRED, CIPRED and CIPREDI are defined as the Embedded Image from equations of IWRES, ICWRES and ICWRESI. The individual expected prediction (EIPRED) is is defined as the individual mean conditioned on ηk, i.e. E[yi], from equation of EIWRES.

  4. Akaike Information Criterion (AIC) and Bayesian Information Criterion (BIC)

  5. η Shrinkage and ϵ Shrinkage [35]

The above discussed diagnostics can be evaluated through the inspect function and further exported as a DataFrame. Additionally, the infer function is available for computing the covariance matrix of the confidence intervals and the standard errors for the parameter estimates. As an example below we call infer and inspecton the FittedPumasModel object res obtained as the result of fit call in earlier section.

Figure
  • Download figure
  • Open in new tab

Additionally several out of the box visualizations are available for practitioners to evaluate the model fit are are mainly provided by the PumasPlots.jl package. Convergence plot for fitting obtained with the convergencefunction for the HCV model is shown in the following Figure 3.

Figure
  • Download figure
  • Open in new tab
Figure 3:
  • Download figure
  • Open in new tab
Figure 3: Convergence Plot for the HCV model

In Pumas we provide the ability to run Visual Predictive Checks with vpc function. For continuous mod-els VPCs are computed using the Quantile Regression based approach discussed in [20]. The syntax for computing and plotting the VPCs is shown below followed by the Figure 4 of a stratified VPC plot in Pumas.

Figure
  • Download figure
  • Open in new tab
Figure 4:
  • Download figure
  • Open in new tab
Figure 4: Visual Predictive Check

2.5 Optimal Design of Experiments

Optimal design of clinical trials has increasingly played a central role in increasing the effectiveness of such studies while minimizing costs [25]. To facilitate the advancement of optimal design methodologies into standard clinical trial workflows, Pumas includes functionality for high performance calculations of the Fisher Information Matrix (FIM) which is central to optimal design methodologies. The function informationmatrix takes in a FittedPumasModel, the output of the fit estimation function, and computes either the expected or observed FIM dependent on a keyword argument expected using a normality approximation [40]. The following demonstrates the workflow for performing parameter estimation with FO and calculating the expected FIM in the Warfarin Pk model [29]:

Figure
  • Download figure
  • Open in new tab
Figure
  • Download figure
  • Open in new tab

Note that the derivative calculations used within the FIM calculation are the discrete sensitivity analysis derivatives derived via forward-mode automatic differentiation as described in Section 3.2.

3 High Performance and Stability-Enhanced Model Fitting

3.1 Fine-Tuning Differential Equation Solver Behavior to Model Features

The core computation of the model fitting process utilizes the simobs function for generating solutions to the differential equation during the likelihood approximation, meaning that every step of the optimization is solving thousands of the same small differential equation representing different possible parameter configurations amongst all subjects in a clinical trial. Thus, while in isolation these small ODEs may simulate very fast, real-world NLME model fitting with large numbers of subjects consistently arrives at workflows which take hours to days or weeks with the majority of the time due to the cost of solving small ODEs. Thus practical workflows of industry pharmacologists would be heavily impacted if the speed of these systems could be dramatically decreased.

Pumas recognizes the crux of the computational issue and thus has many new features for optimizing the internal solve of the fitting process. The options for controlling the solvers are same between the simulation and estimation workflows. The full gamut of options from DifferentialEquations.jl are exposed to allow users to control the solvers as much as possible. This allows for specializing the solver behavior on the known characteristics of the functions and its solution. For example, the concentrations modeled in the ODEs need to stay positive in order for the model to be stable, but numerical solvers of ODEs do not generally enforce this behavior which can cause divergences in the optimization process. In Pumas, one can make use of advanced strategies [38] like rejecting steps out of the domain by using isoutofdomain or using the PositiveDomain callback.

However, a more immediate effect of this connection is the ability to choose between a large set of highly optimized integration methods. Table 1 shows timing results of Pumas on pharmacokinetic (PK) and pharmacokinetic/pharmacodynamic (PK/PD) models using both the native DifferentialEquations.jl methods and some classic C++ and Fortran libraries and demonstrates a performance advantage averaging around 3x between the best Julia-based method against the best wrapped C++ or Fortran solver method. This table also demonstrate a few different dimensions by which this performance advantage is achieved. First of all, the DifferentialEquations.jl library uses different Runge-Kutta methods which are derived to have asymptotically better error qualities for the same amount of work [42, 44], with a much larger effect for the high order (7th order) integrator. Secondly, DifferentialEquations.jl uses a tuned PI-adaptive timestepping method [39] which is able to stabilize the solver and increase the timesteps, thus decreasing the total amount of work to integrate the equation. Lastly, Pumas is able to utilize the JIT compiler to compile a form of the differential equation solver that utilizes stack-allocated arrays and is specific to the size and ODE function. While this optimization only applies to small ODE systems (the optimization is no longer beneficial at around 10 or more ODEs), many pharmacometric models fall into this range of problems and these benchmarks demonstrate that it can have a noticeable effect on the solver time.

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 1: Effect of specialized ODE solvers on forward simulation of small pharmacometric ODE models.

Shown is the effect of the ODE solver choice on the speed of the forward pass of common pharmacometric models. OC for the one-compartment model of Section 1.1, MR for the multiple response model described in Section 5, and HCV for the hapatitis C model described in Section 5. Times are all shown in seconds. By default the tolerances for the solvers was 1 × 10−3 for the relative tolerance and 1 × 10−6 for the absolute tolerance, while LT stands for low tolerence with 1 × 10−8 for the relative tolerance and 1 × 10−12 for the absolute tolerance (representative of tolerances used when simulating vs when simulating). Solutions were checked against a tolerance 1 × 10−14 reference solution to ensure the actual errors were within the same order of magnitude. The automatic stiffness detection AutoTsit5-Rosenbrock23 method is a combination between Tsit5 [42] and a Rosenbrock method Rosenbrock23 [37], while Tsit5 and Vern7 [44] are explicit Runge-Kutta methods from the DifferentialEquations.jl library [33]. CVODE is from the Sundials library [17], while DOP853 and DOPRI are from the Hairer Fortran methods suite [13]. The Array methods are generically compiled for heap-allocated mutable arrays, where the SArray versions are specially optimized for the specific size of the ODE using Julia’s JIT compiler.

One additional advantage of this tweak-ability is the ease to span multiple domains. Physiologically-based pharmacokinetic (PBPK) models are typically larger stiff ODE-based models which incorporates systems-type mechanistic modeling ideas to enhance the model’s predictive power [24]. Table 2 demonstrates the performance advantage of the native Julia methods that are unique to Pumas on a 15 stiff ODE PBPK model with steady state dosing, demonstrating a 2x-3x performance advantage over the classic CVODE method used in many other pharmacometric modeling suites.

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 2: Effect of specialized ODE solvers on forward simulation the Voriconazole physiologically-based pharmacokinetic (PBPK) model [48].

Shown is the effect of the ODE solver choice on the speed of the forward pass of the PBPK model with steady state dosing. Given the high degree of variance in the stiff ODE solver accuracies at the same tolerances, the tolerances were aligned using a reference solution computed at 1 × 10−14 tolerances, and high tolerance was chosen to be the tolerance pair by power of 10 which achieve a true error closest to 1 × 10−5 and for low tolerance the pair closes to 1 × 10−9. The automatic stiffness detection method AutoVern7-Rodas5 is a combination between Vern7 and Rodas5, while Rodas5 [45], KenCarp4 [21], and RadauIIA5 [14] are implicit methods from the DifferentialEquations.jl library [33]. CVODE is from the Sundials library [17]

3.2 Fast and Accurate Likelihood Hessian Calculations via Automatic Differentiation

When performing maximum likelihood estimation or Bayesian estimation with a gradient-based sampler like Hamiltonian Monte Carlo, the limiting step is often the calculation of the gradient of the likelihood. Finite difference calculations are not efficient since every calculation of a perturbation involves a numerical solve of the ODE system and either or two perturbations are required for each model parameter for forward and central differencing respectively. Furthermore, the finite difference approximation of a derivative is an unstable process [10] which in some cases can result in very inaccurate gradients when combined numerical solutions to ODEs.

The performance of the derivative calculations for the marginal likelihoods can be improved by utilizing a formulation with the sensitivity equations due to [1]. While very efficient, the method relies on second order derivatives in a way that makes the process unstable and accurate derivatives are required for process to work well. Instead of utilizing the traditional form of the sensitivity equations, Pumas generates an implementation of discrete forward sensitivity analysis by utilizing dual number arithmetic through the differential equation solver (cite ForwardDiff). Our group has previously shown that this discrete sensitivity analysis via automatic differentiation outperforms traditional sensitivity analysis since it allows the compiler more freedom to optimize the generated code for passes like single instruction, multiple data (SIMD) auto-vectorization [32].

Table 3.2 demonstrates the effect on run time and and accuracy of using the sensitivity method from [1] with finite difference and automatic differentiation based derivatives respectively as well as a simple but expensive finite difference based gradient computation. The error is computed relative to a solution computed with 256 bit precision floating point numbers. All ODE solutions are computed to a relative tolerance of 10−8. The results show that the simple finite difference based gradient doesn’t have too large an error but is slow while the faster sensitivity based method has a large relative error. The error is so large that gradient based optimization is no longer practical. In contrast, the sensitivity based gradient computation based on automatic differentiation loses almost no precision and is even faster that the finite difference based gradient because it requires fewer evaluations of the objective function.

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 3: Timings and relative errors for the gradient computations of the marginal likelihood in a non-linear fixed effects model with time varying coefficients in the ODE.

Shown are the timings of the three likelihood gradient calculation methods along with their relative error. AD stands for automatic differentiation while FD stands for finite differentiation, demonstrating both the effciency and accuracy gains obtained through by utilizing the automatic differentiation derived discrete sensitivity analysis.

3.3 Accelerated Maximum Likelihood Fitting

Maximum likelihood directly corresponds to repeated calculation of likelihood gradients. Given the performance advantages that are obtained due to the ODE solver and discrete sensitivity analysis advantages over previous software, one would predict that the model estimation routines would see a similar benefit as derived from these components. Appendix 5 describes the full set of benchmark models for maximum likelihood estimation. In Figure 5 we demonstrate this is the case by calculating the elapsed run time to estimate 6 models in both Pumas and NONMEM. We note that the Pumas fitting mechanism has a higher fixed cost which effects the results on the smallest models, but on the two larger models we see more than a 2x performance advantage for Pumas, similar to the difference between the non-fully optimized ODE solver and the alternative array-based algorithms and implementations. Figure 6 demonstrates that this performance advantage over NONMEM extends to larger nonlinear models, showcasing the general applicability of the performance enhancements seen in Pumas. In all of the occasions the resulted in similar likelihoods.

Figure 5:
  • Download figure
  • Open in new tab
Figure 5: Maximum likelihood estimation results.

Shown is the run time of a fit of the various Pk/Pd models

Figure 6:
  • Download figure
  • Open in new tab
Figure 6: Runtime comparisons of non-linear mechanistic TMDD models.

Shown is the run time of a fit of the Michaelis-Menten (MM) model, Constant Rtot model and Rapid binding (QE) and quasi steady-state (QSS) models

3.4 Automated Parallelism and Full-Application Benchmarks

Pumas is able to automatically parallelize the solution of the NLME model solution across subjects. 2 forms of parallelism are currently available:

  1. Multithreaded parallelism for shared memory machines

  2. Multiprocessing for distributed memory architectures

Multithreaded is enabled by default and no extra steps are required for this parallelism to occur. Meanwhile the multiprocessing allows a user to utilize cores across any cluster with passwordless SSH, which includes architectures like traditional high-performance computing (HPC) clusters and cloud architectures like Azure. Figure 7 demonstrates the good scaling of multithreading on a PK/PD maximum likelihood estimation. The scaling does not meet the theoretical optimal properties of linear scaling because there are parts of the fitting process that cannot be parallelized.

Figure 7:
  • Download figure
  • Open in new tab
Figure 7: Scaling of multithreaded fitting of a HCV model.

Shown is the run time of a fit of a simultaneous PK/PD model HCV model described in 5 with multithreading with 1, 2, 3, 4, 6, 8 and 12 threads.

3.5 High Performance Non-Compartmental Analysis (NCA)

In the previous sections we demonstrated that the integrated NCA suite reproduced the results of industry-standard tools, demonstrating the correctness of the implementation over 13104 scenarios. In addition to determining the correctness, we calculated the run times. The full analysis tool 3 hours and 16 minutes in PKNCA while in Pumas the run time was 56 seconds, demonstrating a 210x acceleration. This speed is particularly useful when 1,000s of clinical trials are simulated during the planning of a large patient trial.

3.6 Accelerated Optimal Design of Experiments

In order to assess the effectiveness of accelerated differential equation solving on optimal design workflows, we tested the calculation time of the FIM on the Warfarin PK model (Section 2.5) and the HCV PK/PD model Section 5 against the PopED Population Optimal Experimental Design framework [30]. Figure 8 showcases that Pumas calculates the FIM approximately 20x faster than PopED on the Warfarin model and approximately 220x faster on the HCV model. Much of the acceleration can be attributed to the AutoVern7(Rodas5()) ODE solver used in the Pumas version of the FIM calculation as opposed to the ode45 method internally used by PopED. This demonstrates how central improvements to the solving of small ODEs can give large advantages to real applications built on top of such methodologies.

Figure 8:
  • Download figure
  • Open in new tab
Figure 8: Accelerated Optimal Design of Experiments.

Shown is the relative time to compute the Fisher Information Matrix (FIM) between PopED [30] and Pumas on the Warfarin and HCV models. The FIM was calculated 1000 times in order to reduce noise in the timings.

Figure 9:
  • Download figure
  • Open in new tab
Figure 9: Clinical dosing simulation verification against NONMEM for analytical solutions.

Shown are the clinical dosing simulation verification of the models described in Section 5 using analytical solutions of the differential equation mixed with the event handling system.

Figure 10:
  • Download figure
  • Open in new tab
Figure 10: Clinical dosing simulation verification against NONMEM for analytical solutions.

Shown are the clinical dosing simulation verification of the models described in Section 5 using numerical approximations of the solutions of the differential equation mixed with the event handling system.

Figure 11:
  • Download figure
  • Open in new tab
Figure 11: Pumas and Phoenix NCA Results Comparison.

Eighteen percent of subjects were randomly selected from the 13104 scenarios to form a subset of 2367 subjects. This smaller subset was used to perform the NCA calculations across the three software while ensuring to maintain the same default options. All analysis were conducted on the same laptop.

Figure 12:
  • Download figure
  • Open in new tab
Figure 12: Pumas and PKNCA Results Comparison.

Eighteen percent of subjects were randomly selected from the 13104 scenarios to form a subset of 2367 subjects. This smaller subset was used to perform the NCA calculations across the three software while ensuring to maintain the same default options. All analysis were conducted on the same laptop.

4 Conclusion

Pumas pulls together a diverse array of pharmacometrics problems into a single platform and utilizes the JIT optimization to directly specialize the internal solvers. We have showcased how the Pumas platform achieves across the board performance improvements from preclinical to clinical analyses over existing pharmacometrics tools. This more broadly illustrates how integrating optimizing compilers into dynamic tool chains can improve performance over traditional approaches which do not specialize on the problem’s scale. Even something as standardized as an ODE solver can be improved. Pumas is still early in its development and will continue to increase its performance as it demonstrates new features to the pharmacometrics community.

5 Acknowledgements

The Pumas project was started in 2017 with the support of the University of Maryland Baltimore School of Pharmacy (UMB). Professor Jill Morgan, the chair of Pharmacy Practice and Science (PPS) and Dean Natalie Eddington were instrumental in their support. The staff, faculty, students and researchers at the Center for Translational Medicine in UMB drove a lot of the initial testing and we are extremely thankful for their patience while adopting a new language and tool. Brian Corrigan from Pfizer who encouraged us throughout the journey and nudged the team to achieve new heights. All the early adopters and believers. Viral Shah and Deepak Vinchii from Julia Computing for being our trusted technology collaborators. Last but the most important thank you goes out to the members of the Julia Language community who develop world class scientific computing packages and create an environment that is conducive to newcomers.

Appendix

Model Definitions

Multiple Response Model

Embedded Image Embedded Image Embedded Image Embedded Image

where: Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image

HCV Model

The ”HCV Model” is a multiple response PKPD model from [29] that models the effect of a pegylated interferon dose given as a 24h infusion once a week for 4 weeks. Twelve simulated samples are obtained for the PK and PD at times t = [0.0, 0.25, 0.5, 1.0, 2.0, 3.0, 4.0, 7.0, 10.0, 14.0, 21.0, 28.0]. The internal dynamics are: Embedded Image Embedded Image Embedded Image Embedded Image Embedded Image where C(t) = A(t)/Vd. The PK variable C is modelled with an additive normal distribution and the PK variable W is modelled as being log-normal. We use the parameters reported in the original paper.

Dosing Regimen Verification

The event handling of Pumas and the accuracy of simulation under different kinds of events was evaluated systematically. The examples for this testing were adapted from mrgsolve test suite3. The dosing and sampling scenarios were setup in R’s mrgsolve package which were then used to simulate concentration time profile for a single subject in NONMEM and Pumas. The listing of all the tested scenarios is presented below:

  1. Infusion (10 mg/hr) into the central compartment with 4 doses given every 12 hours

  2. Infusion (10 mg/hr) into the central compartment with lag time (5 hr) with 4 doses given every 12 hours

  3. Infusion (10 mg/hr) into the central compartment with lag time (5 hr) and bioavailability (0.4) with 4 doses given every 12 hours

  4. Infusion (10 mg/hr) into the central compartment at steady state (ss)

  5. Infusion (10 mg/hr) into the central compartment at steady state (ss) with 81% bioavailability, where frequency of events (ii) is less than the infusion duration (DUR)

  6. Infusion (10 mg/hr) into the central compartment at steady state (ss) with 100% bioavailability, where frequency of events (ii) is less than the infusion duration (DUR)

  7. Infusion (10 mg/hr) into the central compartment at steady state (ss) with 100% bioavailability, where frequency of events (ii) is a multiple of infusion duration (DUR)

  8. Infusion (10 mg/hr) into the central compartment at steady state (ss) with 41% bioavailability, where frequency of events (ii) is exactly equal to the infusion duration (DUR)

  9. Infusion (10 mg/hr) into the central compartment at steady state (ss) with 100% bioavailability, where frequency of events (ii) is exactly equal to the infusion duration (DUR)

  10. Oral dose at steady state with lower bioavailability of 41%

  11. Oral dose at steady state with lower bioavailability of 41% and 5 hour lag time

  12. Zero order infusion followed by first order absorption into gut

  13. Zero order infusion into central compartment specified by duration parameter

  14. First order bolus into central compartment at ss followed by an ss=2 (superposition ss) dose at 12 hours

  15. First order bolus into central compartment at ss followed by an ss=2 (superposition ss) dose at 12 hours followed by reset ss=1 dose at 24 hours

  16. Two parallel first order absorption models

  17. Mixed zero and first order absorption

Maximum Likelihood Tests

The Pumas-NLME parameter estimation algorithms, specifically FOCEI() were compared with NONMEM in a richly-sampled data setting with multiple models.

After a single administration 19 samples were collected over 72 hours via simulations for 4 different dose levels of 30 subjects each. A total of 6 test cases were generated that were a combination of:

  • one- or two-compartmental disposition [26]

  • oral (first-order absorption), intravenous (IV) bolus, or IV infusion administration.

The Ω’s, representing the between subject variability were set to 30% CV, implemented as diagonal covariance matrix. A proportional residual error with 20% CV was chosen to capture the error distribution. For the structural model, all one-compartment models had a population Vc of 70 L, and all two-compartment models had an additional peripheral volume (Vp) of 40 L. For all oral absorption models, Ka was set to 1.0 h-1. All models with linear elimination had a CL of 4.0 L/h. All two-compartment models had inter-compartmental clearance (Q) set to 4.0 L/h.

TMDD Model Tests

While the maximum likelihood tests above compared the standard compartmental models, we also evaluted the performance of highly non-linear mechanistic models in the class of Target Mediated Drug Disposition (TMDD). Three models from this class were selected

  1. Michaelis-Menten (MM) model

  2. Constant Rtot

  3. Rapid binding (QE) and quasi steady-state (QSS) models

Data were simulated from a Full TMDD model in 224 subjects over a range of doses with a total of 3948 observations. The simulated data were then estimated using the reduced models listed above using NONMEM and Pumas

NCA Implementation Verification

Simulations were performed in R with scenarios consisting of 1-, 2-, and 3-compartment models with typical parameters and ±4-fold from those typical parameters on the ratio of absorption rate (Ka) rate (Kel), ratio of peripheral volume of distribution 1 and 2 (V p1 and V p2) to central volume of distribution (V c), intercompartmental clearance between V c and V p1 or V p2 (Qcp1 and Qcp2), and ratio of clearance (CL) to V c all models, as the parameters apply; with and without target-mediated drug disposition (TMDD); and oral and intravascular bolus dosing. All models were simulated with 4%, 10%, and 20% proportional residual error. Each model was simulated with 6 subjects. This yielded a total of 13104 scenarios and 78624 subjects simulated.

Each subject was then grouped with all other subjects in its simulation scenario, and 5, 10, and 20% of concentration measurements were set to below the limit of quantification (LOQ). NCA was to be performed on each of those LOQ scenarios in PKNCA [9], Pumas, and Phoenix 4 (a total of 707616 NCA intervals with calculations). Comparisons were made between the results of those NCA calculations performed on a single machine.

Five parameters, were chosen as the metrics for comparison as they included both observed and derived parameters:

  1. AU Clast

  2. Cmax

  3. Tmax

  4. Half – life

  5. AU Cin f(pred)

Eighteen percent of subjects were randomly selected from the 13104 scenarios to form a subset of 2367 subjects. This smaller subset was used to perform the NCA calculations across the three software while ensuring to maintain the same default options. All analysis were conducted on the same laptop and discussed at ACoP 2019 [47].

Results from all three software for the key NCA parameters match. Most results matched within ±0.1% between all software. The difference between PKNCA /Pumas and Phoenix in half-life appears to be the result of PKNCA/Pumas selecting the best fit first and then filtering for decreasing slope while Phoenix first considers only consecutive sets of points that generate a descending slope and then selects the final set of points with the best regression adjusted R squared. None of the different results would be reported in a typical reporting workflow as all r2 values were <0.7.

Footnotes

  • ↵1 Prior distributions are required for this fitting method and are specified in the param block by using a distribution instead of a domain.

  • ↵2 Defined in [28] unless mentioned otherwise

  • ↵3 https://github.com/mrgsolve/nmtests/blob/master/nmtest7.md

  • ↵4 https://www.certara.com/software/phoenix-nlme/

References

  1. [1].↵
    Joachim Almquist, Jacob Leander, and Mats Jirstrand. Using sensitivity equations for computing gradients of the foce and focei approximations to the population likelihood. Journal of pharmacokinetics and pharmacodynamics, 42(3):191–209, 2015.
    OpenUrl
  2. [2].↵
    Maksat Ashyraliyev, Yves Fomekong-Nanfack, Jaap A Kaandorp, and Joke G Blom. Systems biology: parameter estimation for biochemical models. The FEBS journal, 276(4):886–902, 2009.
    OpenUrlCrossRefPubMed
  3. [3].↵
    Robert J Bauer, Serge Guzy, and Chee Ng. A survey of population analysis methods and software for complex pharmacokinetic and pharmacodynamic models with examples. The AAPS journal, 9(1):E60–E83, 2007.
    OpenUrl
  4. [4].↵
    Stuart L Beal, Lewis B Sheiner, Alison Boeckmann, and Robert J Bauer. Nonmem users guides. NON-MEM Project Group, University of California, San Francisco, 1992.
  5. [5].↵
    Mathieu Besançon, David Anthoff, Alex Arslan, Simon Byrne, Dahua Lin, Theodore Papamarkou, and John Pearson. Distributions. jl: Definition and modeling of probability distributions in the juliastats ecosystem. arXiv preprint arXiv:1907.08611, 2019.
  6. [6].↵
    Jeff Bezanson, Alan Edelman, Stefan Karpinski, and Viral B Shah. Julia: A fresh approach to numerical computing. SIAM review, 59(1):65–98, 2017.
    OpenUrlCrossRef
  7. [7].↵
    Peter L Bonate et al. Pharmacokinetic-pharmacodynamic modeling and simulation, volume 20. Springer, 2011.
  8. [8].↵
    Peter N Brown, George D Byrne, and Alan C Hindmarsh. Vode: A variable-coefficient ode solver. SIAM journal on scientific and statistical computing, 10(5):1038–1051, 1989.
    OpenUrl
  9. [9].↵
    Clare Buckeridge, Sridhar Duvvuri, and William S Denney. Simple, automatic noncompartmental analysis: the pknca r package. J Pharmacokinet Pharmacodyn, 42(1):11–107, 2015.
    OpenUrlCrossRef
  10. [10].↵
    S. D. Conte and Carl De Boor. Elementary Numerical Analysis: An Algorithmic Approach. McGraw-Hill, 1980.
  11. [11].↵
    Johan Gabrielsson and Daniel Weiner. Non-compartmental analysis. In Computational toxicology, pages 377–389. Springer, 2012.
  12. [12].↵
    Jogarao V.S. Gobburu. Future of pharmacometrics: Predictive healthcare analytics. British Journal of Clinical Pharmacology, n/a(n/a).
  13. [13].↵
    E. Hairer, S. P. Norsett, and Gerhard Wanner. Solving ordinary differential equations I: nonstiff problems. Number 8 in Springer series in computational mathematics. Springer, Heidelberg; London, 2nd rev. ed edition, 2009. OCLC: ocn620251790.
  14. [14].↵
    Ernst Hairer and Gerhard Wanner. Stiff differential equations solved by radau methods. Journal of Computational and Applied Mathematics, 111(1-2):93–111, 1999.
    OpenUrl
  15. [15].↵
    AC Hindmarsh and LR Petzold. Lsoda, ordinary differential equation solver for stiff or non-stiff system. 2005.
  16. [16].↵
    Alan C Hindmarsh. Lsode and lsodi, two new initial value ordinary differential equation solvers. ACM Signum Newsletter, 15(4):10–11, 1980.
    OpenUrl
  17. [17].↵
    Alan C Hindmarsh, Peter N Brown, Keith E Grant, Steven L Lee, Radu Serban, Dan E Shumaker, and Carol S Woodward. Sundials: Suite of nonlinear and differential/algebraic equation solvers. ACM Transactions on Mathematical Software (TOMS), 31(3):363–396, 2005.
    OpenUrl
  18. [18].↵
    NH Holford. An introduction to visual predictive checks, 2012.
  19. [19].↵
    Antti Honkela, Jaakko Peltonen, Hande Topa, Iryna Charapitsa, Filomena Matarese, Korbinian Grote, Hendrik G Stunnenberg, George Reid, Neil D Lawrence, and Magnus Rattray. Genome-wide modeling of transcription kinetics reveals patterns of rna production delays. Proceedings of the National Academy of Sciences, 112(42):13115–13120, 2015.
    OpenUrlAbstract/FREE Full Text
  20. [20].↵
    Kris M. Jamsen, Kashyap Patel, Keith Nieforth, and Carl M. J. Kirkpatrick. A regression approach to visual predictive checks for population pharmacometric models. CPT: Pharmacometrics & Systems Pharmacology, 7(10):678–686, 2018.
    OpenUrl
  21. [21].↵
    Christopher A Kennedy and Mark H Carpenter. Additive runge–kutta schemes for convection–diffusion–reaction equations. Applied numerical mathematics, 44(1-2):139–181, 2003.
    OpenUrlCrossRefWeb of Science
  22. [22].↵
    Minkyoung Kim, Dean Paini, and Raja Jurdak. Modeling stochastic processes in disease spread across a heterogeneous social system. Proceedings of the National Academy of Sciences, 116(2):401–406, 2019.
    OpenUrlAbstract/FREE Full Text
  23. [23].↵
    Niklas Korsbo and Henrik Jönsson. It’s about time: Analysing simplifying assumptions for modelling multi-step pathways in systems biology. PLoS computational biology, 16(6):e1007982, 2020.
    OpenUrl
  24. [24].↵
    Mengyao Li, Ping Zhao, Yuzhuo Pan, and Christian Wagner. Predictive performance of physiologically based pharmacokinetic models for the effect of food on oral drug absorption: current status. CPT: pharmacometrics & systems pharmacology, 7(2):82–89, 2018.
    OpenUrl
  25. [25].↵
    France Mentré, Marylore Chenel, Emmanuelle Comets, Joachim Grevel, Andrew Hooker, MO Karlsson, Marc Lavielle, and Iva Gueorguieva. Current use and developments needed for optimal design in pharmacometrics: a study performed among ddmore’s european federation of pharmaceutical industries and associations members. CPT: pharmacometrics & systems pharmacology, 2(6):1–2, 2013.
    OpenUrl
  26. [26].↵
    France Mentré and Sylvie Escolano. Prediction discrepancies for the evaluation of nonlinear mixed-effects models. Journal of pharmacokinetics and pharmacodynamics, 33(3):345–367, 2006.
    OpenUrlCrossRefPubMedWeb of Science
  27. [27].↵
    Patrick Kofod Mogensen and Asbjørn Nilsen Riseth. Optim: A mathematical optimization package for julia. Journal of Open Source Software, 3(24), 2018.
  28. [28].↵
    THT Nguyen, M-S Mouksassi, Nicholas Holford, N Al-Huniti, I Freedman, Andrew C Hooker, J John, Mats O Karlsson, DR Mould, JJ Pérez Ruixo, et al. Model evaluation of continuous data pharmacometric models: metrics and graphics. CPT: pharmacometrics & systems pharmacology, 6(2):87–109, 2017.
    OpenUrl
  29. [29].↵
    Joakim Nyberg, Caroline Bazzoli, Kay Ogungbenro, Alexander Aliev, Sergei Leonov, Stephen Duffull, Andrew C Hooker, and France Mentré. Methods and software tools for design evaluation in population pharmacokinetics–pharmacodynamics studies. British journal of clinical pharmacology, 79(1):6–17, 2015.
    OpenUrlCrossRefPubMed
  30. [30].↵
    Joakim Nyberg, Sebastian Ueckert, Eric A Strömberg, Stefanie Hennig, Mats O Karlsson, and Andrew C Hooker. Poped: an extended, parallelized, nonlinear mixed effects models optimal design tool. Computer methods and programs in biomedicine, 108(2):789–805, 2012.
    OpenUrlCrossRefPubMed
  31. [31].↵
    Thomas M Polasek, Sepehr Shakib, and Amin Rostami-Hodjegan. Precision dosing in clinical medicine: present and future, 2018.
  32. [32].↵
    Christopher Rackauckas, Yingbo Ma, Vaibhav Dixit, Xingjian Guo, Mike Innes, Jarrett Revels, Joakim Nyberg, and Vijay Ivaturi. A comparison of automatic differentiation and continuous sensitivity analysis for derivatives of differential equation solutions. arXiv preprint arXiv:1812.01892, 2018.
  33. [33].↵
    Christopher Rackauckas and Qing Nie. Differentialequations. jl–a performant and feature-rich ecosystem for solving differential equations in julia. Journal of Open Research Software, 5(1), 2017.
  34. [34].↵
    Christopher Rackauckas, Thomas Schilling, and Qing Nie. Mean-independent noise control of cell fates via intermediate states. iScience, 3:11–20, 2018.
    OpenUrl
  35. [35].↵
    Radojka M Savic and Mats O Karlsson. Importance of shrinkage in empirical bayes estimates for diagnostics: problems and solutions. The AAPS journal, 11(3):558–569, 2009.
    OpenUrl
  36. [36].↵
    Alan Schumitzky. Stochastic control of pharmacokinetic systems. In Topics in Clinical Pharmacology and Therapeutics, pages 13–25. Springer, 1986.
  37. [37].↵
    Lawrence F Shampine and Mark W Reichelt. The matlab ode suite. SIAM journal on scientific computing, 18(1):1–22, 1997.
    OpenUrl
  38. [38].↵
    Lawrence F Shampine, Skip Thompson, JA Kierzenka, and GD Byrne. Non-negative solutions of odes. Applied mathematics and computation, 170(1):556–569, 2005.
    OpenUrl
  39. [39].↵
    Gustaf Söderlind. Automatic control and adaptive time-stepping. Numerical Algorithms, 31(1-4):281–310, 2002.
    OpenUrl
  40. [40].↵
    Eric A Strömberg, Joakim Nyberg, and Andrew C Hooker. The effect of fisher information matrix approximation methods in population optimal design calculations. Journal of pharmacokinetics and pharmacodynamics, 43(6):609–619, 2016.
    OpenUrl
  41. [41].↵
    Mirjam N Trame, Matthew Riggs, Konstantinos Biliouris, Dhananjay Marathe, Jerome Mettetal, Teun M Post, Matthew L Rizk, Sandra AG Visser, and Cynthia J Musante. Perspective on the state of pharmacometrics and systems pharmacology integration. CPT: pharmacometrics & systems pharmacology, 7(10):617–620, 2018.
    OpenUrl
  42. [42].↵
    Ch Tsitouras. Runge–kutta pairs of order 5 (4) satisfying only the first column simplifying assumption. Computers & Mathematics with Applications, 62(2):770–775, 2011.
    OpenUrl
  43. [43].↵
    Tove Tuntland, Brian Ethell, Takatoshi Kosaka, Francesca Blasco, Richard Xu Zang, Monish Jain, Ty Gould, and Keith Hoffmaster. Implementation of pharmacokinetic and pharmacodynamic strategies in early research phases of drug discovery and development at novartis institute of biomedical research. Frontiers in pharmacology, 5:174, 2014.
    OpenUrl
  44. [44].↵
    James H Verner. Numerically optimal runge–kutta pairs with interpolants. Numerical Algorithms, 53(2-3):383–396, 2010.
    OpenUrl
  45. [45].↵
    Gerhard Wanner and Ernst Hairer. Solving ordinary differential equations II. Springer Berlin Heidelberg, 1996.
  46. [46].↵
    Darren J Wilkinson. Stochastic modelling for quantitative description of heterogeneous biological systems. Nature Reviews Genetics, 10(2):122–133, 2009.
    OpenUrlCrossRefPubMedWeb of Science
  47. [47].↵
    Ma Y, Guglieri-Lopez B, Gobburu J, Denney W, and Ivaturi V. Comparison of non-compartmental analysis results between pknca, pumas.nca and phoenix winnonlin. ACoP, 2019.
  48. [48].↵
    Nicole R Zane and Dhiren R Thakker. A physiologically based pharmacokinetic model for voriconazole disposition predicts intestinal first-pass metabolism in children. Clinical pharmacokinetics, 53(12):1171–1182, 2014.
    OpenUrlCrossRefPubMed
Back to top
PreviousNext
Posted November 30, 2020.
Download PDF
Email

Thank you for your interest in spreading the word about bioRxiv.

NOTE: Your email address is requested solely to identify you as the sender of this article.

Enter multiple addresses on separate lines or separate them with commas.
Accelerated Predictive Healthcare Analytics with Pumas, a High Performance Pharmaceutical Modeling and Simulation Platform
(Your Name) has forwarded a page to you from bioRxiv
(Your Name) thought you would like to see this page from the bioRxiv website.
CAPTCHA
This question is for testing whether or not you are a human visitor and to prevent automated spam submissions.
Share
Accelerated Predictive Healthcare Analytics with Pumas, a High Performance Pharmaceutical Modeling and Simulation Platform
Chris Rackauckas, Yingbo Ma, Andreas Noack, Vaibhav Dixit, Patrick Kofod Mogensen, Simon Byrne, Shubham Maddhashiya, José Bayoán Santiago Calderón, Joakim Nyberg, Jogarao V.S. Gobburu, Vijay Ivaturi
bioRxiv 2020.11.28.402297; doi: https://doi.org/10.1101/2020.11.28.402297
Reddit logo Twitter logo Facebook logo LinkedIn logo Mendeley logo
Citation Tools
Accelerated Predictive Healthcare Analytics with Pumas, a High Performance Pharmaceutical Modeling and Simulation Platform
Chris Rackauckas, Yingbo Ma, Andreas Noack, Vaibhav Dixit, Patrick Kofod Mogensen, Simon Byrne, Shubham Maddhashiya, José Bayoán Santiago Calderón, Joakim Nyberg, Jogarao V.S. Gobburu, Vijay Ivaturi
bioRxiv 2020.11.28.402297; doi: https://doi.org/10.1101/2020.11.28.402297

Citation Manager Formats

  • BibTeX
  • Bookends
  • EasyBib
  • EndNote (tagged)
  • EndNote 8 (xml)
  • Medlars
  • Mendeley
  • Papers
  • RefWorks Tagged
  • Ref Manager
  • RIS
  • Zotero
  • Tweet Widget
  • Facebook Like
  • Google Plus One

Subject Area

  • Pharmacology and Toxicology
Subject Areas
All Articles
  • Animal Behavior and Cognition (4381)
  • Biochemistry (9583)
  • Bioengineering (7089)
  • Bioinformatics (24852)
  • Biophysics (12598)
  • Cancer Biology (9952)
  • Cell Biology (14348)
  • Clinical Trials (138)
  • Developmental Biology (7945)
  • Ecology (12105)
  • Epidemiology (2067)
  • Evolutionary Biology (15985)
  • Genetics (10921)
  • Genomics (14736)
  • Immunology (9869)
  • Microbiology (23655)
  • Molecular Biology (9480)
  • Neuroscience (50843)
  • Paleontology (369)
  • Pathology (1539)
  • Pharmacology and Toxicology (2681)
  • Physiology (4013)
  • Plant Biology (8655)
  • Scientific Communication and Education (1508)
  • Synthetic Biology (2392)
  • Systems Biology (6430)
  • Zoology (1346)