Next Article in Journal
‘Tablet-in-Syringe’: A Novel Dosing Mechanism for Dysphagic Patients Containing Fast-Disintegrating Tablets Fabricated Using Semisolid Extrusion 3D Printing
Next Article in Special Issue
Model-Informed Precision Dosing of Linezolid in Patients with Drug-Resistant Tuberculosis
Previous Article in Journal
Genipin-Crosslinked, Proteosaccharide Scaffolds for Potential Neural Tissue Engineering Applications
Previous Article in Special Issue
Model-Based Equivalent Dose Optimization to Develop New Donepezil Patch Formulation
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Free and Open-Source Posologyr Software for Bayesian Dose Individualization: An Extensive Validation on Simulated Data

1
Department of Biochemistry and Pharmaco-Toxicology, Brest University Hospital, 29200 Brest, France
2
Univ Brest, EA 3878, GETBO, 29200 Brest, France
3
Infectious Diseases Department, Brest University Hospital, 29200 Brest, France
*
Author to whom correspondence should be addressed.
Pharmaceutics 2022, 14(2), 442; https://doi.org/10.3390/pharmaceutics14020442
Submission received: 15 January 2022 / Revised: 15 February 2022 / Accepted: 16 February 2022 / Published: 18 February 2022
(This article belongs to the Special Issue Model-Informed Precision Dosing)

Abstract

:
Model-informed precision dosing is being increasingly used to improve therapeutic drug monitoring. To meet this need, several tools have been developed, but open-source software remains uncommon. Posologyr is a free and open-source R package developed to enable Bayesian individual parameter estimation and dose individualization. Before using it for clinical practice, performance validation is mandatory. The estimation functions implemented in posologyr were benchmarked against reference software products on a wide variety of models and pharmacokinetic profiles: 35 population pharmacokinetic models, with 4.000 simulated subjects by model. Maximum A Posteriori (MAP) estimates were compared to NONMEM post hoc estimates, and full posterior distributions were compared to Monolix conditional distribution estimates. The performance of MAP estimation was excellent in 98.7% of the cases. Considering the full posterior distributions of individual parameters, the bias on dosage adjustment proposals was acceptable in 97% of cases with a median bias of 0.65%. These results confirmed the ability of posologyr to serve as a basis for the development of future Bayesian dose individualization tools.

Graphical Abstract

1. Introduction

Model-informed precision dosing (MIPD) is an emerging dosing paradigm in which mathematical models are used for dose optimization, using individual information such as a patient’s age, organ function, and the results of therapeutic drug monitoring. Driven by the increasing importance of information technology in health care [1], MIPD is being promoted as a strategy to improve the efficiency of therapeutic drug monitoring and improve standards of care [2].
Because of the complexity of generic modeling software such as NONMEM, MIPD generally requires custom-made software tools tailored to the needs of clinical providers [1]. User-friendly software such as MWPharm [3], TDMx [4], and many others [5] have been developed to meet various needs. Some of this software is freely available, some allows specialist users to integrate their own models, and some has been validated for their predictive performance, but few tools combine all of these features. Software that utilizes publicly documented, accessible and reusable algorithms is even rarer.
Moreover, most of these software products rely only on Maximum A posteriori Bayesian Estimation (MAP-BE), assuming that the mode of the posteriori distribution leads to the prediction with the highest probability. However, Bayesian inference goes beyond point estimates: full posterior (conditional) distributions retain information about the uncertainty associated with individual parameter estimates. Taking this uncertainty into account helps to improve the quality of the predictions, and full Bayesian approaches have been shown superior to MAP-based approaches in dosing individualization [6].
The posologyr software has been developed to address these issues. Featuring Bayesian inference of individual parameters based on parametric nonlinear mixed-effects modeling, posologyr is a free R package [7], licensed under AGPLv3 [8] to guarantee external auditability and accessibility to the widest possible audience of R users.
The aim is for posologyr to be a reliable and open foundation for the development of future MIPD tools. To this end, the extensive validation of the predictive performance of the various implemented functions was an essential requirement.

2. Materials and Methods

2.1. Nonlinear Mixed Effects Models

Nonlinear mixed-effects models are frequently used for the analysis of pharmacokinetic data. They take into account different levels of variability, including inter-individual variability, by incorporating random effects [9]. The observations can be described using the following general nonlinear mixed-effects model implemented in the NONMEM software:
y i j = f ( x i j , ψ i ) + g ( x i j , ψ i , ε i j )
for i from 1 to N, and for j from 1 to ni. Where,
  • y i j is the jth observation of subject i;
  • N is the number of subjects;
  • n i is the number of observations of subject i;
  • f is the function defining the structural model;
  • g is the function defining the residual error model;
  • x i j is the vector of regression variables;
  • for subject i, the vector ψ i is a vector of individual parameters:
    ψ i = H ( θ , c i , η i   )
    where,
    θ is a vector of fixed effects;
    c i is a vector of covariates;
    η i is a vector of normally distributed random effects, of length k, with variance-covariance matrix Ω :
η i   ~   N ( 0 , Ω )
  • The residual errors ε i j are normally distributed random variables centered on 0, with variance Σ :
ε i j   ~   N ( 0 , Σ )
In the Monolix software, the implementation of the residual error model differs, and the nonlinear mixed-effects model becomes:
y i j = f ( x i j , ψ i ) + g ( x i j , ψ i ,   ξ ) ε i j
where the residual error model is defined by the function g and some parameters ξ . The residual errors are then random variables with mean zero and variance one.

2.2. Estimation of Individual Parameters

2.2.1. General Strategy

In the context of MIPD, the aim is to determine the individual parameters ψ i of a subject i, for which dosage personalization is needed. The estimation of individual parameters requires (i) a model for ( y , ψ ) with the prior estimates of θ , x i j , the Ω   variance covariance matrix, and, depending on the definition of the residual error model, either the Σ matrix, or the vector of parameters ξ ; (ii) the input of the observed concentrations y , the measurement times t , the individual covariates, and the administration regimen; and (iii) algorithms capable of estimating and maximizing   p ( ψ i | y i ) . The fixed effects of the population pharmacokinetic model are used as prior information, and the values of the individual random effects η i are estimated a posteriori, taking advantage of the observed data.

2.2.2. Maximum A Posteriori

MAP estimation determines the vector of individual parameters with the highest probability, i.e., the mode of the posterior distribution. In NONMEM, it is performed during the POSTHOC step by minimizing the following objective function value (OFV), based on the log likelihood (LL) [10]:
OFV i = 2 LL ( η i ) = j [ log σ 2 i j + ( y i j f i j ) 2 σ 2 i j ] + η i T Ω 1 η i
where σ 2 i j is the variance of the residual error for individual i at time j.
While most Bayesian forecasting tools rely on the MAP estimation, this approach does not necessarily predict the most probable outcome [6]. To provide a comprehensive uncertainty quantification, it may be desirable to compute the full posterior distributions, and not just point estimates such as the MAP.

2.2.3. Markov Chain Monte Carlo

While the probabilities of p ( ψ i ) or   p ( η i ) cannot be directly calculated, Markov chain Monte Carlo (MCMC) methods allow this distribution to be sampled. The typical procedure is as follows: at each iteration of the algorithm, a new vector of individual parameters ψ i is drawn from a proposal distribution. The new value is accepted with a probability that depends on p ( ψ i ) and on   p ( y i | ψ i ) . After a transition period, the algorithm reaches a stationary state where the accepted samples come from the posterior probability distribution   p ( ψ i | y i ) .

2.2.4. Sequential Importance Resampling

Particle filter algorithms, including Sequential Importance Resampling (SIR), are another class of algorithms that asymptotically draw samples from the posterior probability distribution, allowing for estimation of   p ( ψ i | y i ) . The SIR algorithm, consists of 3 steps [11]:
  • Step 1 (sampling): a defined number M of parameters are sampled from a multivariate parametric proposal distribution;
  • Step 2 (importance weighting): weights are computed for each of the sampled vectors, using the likelihood of the data given the parameter vector, weighted by the likelihood of the parameter vector in the proposal distribution;
  • Step 3 (resampling): m parameter vectors are resampled from the M simulated vectors (M > m), with probabilities proportional to their weighting.
Each step of the algorithm can be parallelized: for the same number of samples, the time needed for estimation can be significantly reduced when compared to MCMC.

2.3. Implementation in Posologyr

The posologyr package (available at https://github.com/levenc/posologyr/, accessed on 15 January 2022) builds on the RxODE [12] simulation framework, using the Fortran package LSODA (Livermore Solver for Ordinary Differential Equations) for solving systems of differential equations. It does not depend on any non-free licensed software, such as NONMEM or Monolix, to run. Random effects of individual models (inter-individual, inter-occasion), and residual error models are implemented within posologyr; RxODE is employed as a deterministic simulation engine. For the MAP estimation, the OFV minimization is performed with the L-BFGS-B algorithm [13] included in the optim package, a limited-memory approximation of the Broyden–Fletcher–Goldfarb–Shanno algorithm (BFGS) allowing for box constraints. To avoid converging to a suboptimal local minimum of the OFV, initial values of the parameters are drawn from the multinormal distribution   η i   ~   N ( 0 , Ω ) . The MCMC algorithm of posologyr is an adaptation of the Metropolis–Hastings algorithm from the R package saemix [14], slightly modified to estimate the posterior distribution   p ( η i | y i ) and to use RxODE as a simulation engine. As in the Metropolis–Hastings algorithm featured in Monolix, three different distributions are used in turn with a (2,2,2) pattern for the proposal distribution: the population distribution, a unidimensional Gaussian random walk, or a multidimensional Gaussian random walk [15]. For the random walks, the variance of the Gaussian is automatically adapted to reach an optimal acceptance ratio. The number of iterations to be discarded following the burn-in period, the number of Markov chains, and the number of iterations per chain are user-defined. The SIR algorithm implemented in posologyr works by sampling from the multinormal distribution   N ( 0 , Ω ) using the rmvnorm function of the mvtnorm package. The weightings are computed from the LL, i.e., 0 , 5 × O F V , following the simultaneous simulation of the observations generated by the M individual parameter vectors from the sampling step. The initial number of samples M, and the number of draws m in the resampling step can be defined by the user.

2.4. Dosing Adjustment

In order to individualize treatments, posologyr features several dosage optimization functions based on individual parameter estimates. The posologyr::poso_dose_conc and posologyr::poso_dose_auc functions determine the optimal dose to reach, respectively, a target concentration at a given time, or a target area under the time-concentration curve (AUC) over a given duration. The optimization is based on the minimization of the square of the difference between the desired target (target concentration, target AUC) and the result of the successive simulations. The posologyr::poso_time_cmin function determines by simulation the time needed to reach a target concentration (typical application: the therapeutic drug monitoring of aminoglycoside treatment). Finally, the posology::poso_inter_cmin function estimates the optimal inter-dose interval to reliably achieve a target trough concentration between each administration. All these functions allow optimization from MAP estimates of individual parameters, but also from posterior distributions. In the latter case, the set of probable profiles is simulated using RxODE, and the proportion p of the distribution to be considered for optimization is set by the user. For example, for posologyr::poso_dose_auc with p = 0.5, posologyr will determine the optimal dose so that 50% of the probable profiles reach or exceed the target AUC.

2.5. Validation

2.5.1. Point Estimate: MAP

To allow for an extensive comparison of the performance of posologyr estimates and NONMEM POSTHOC estimates [16] (NONMEM version 7.4.4, Dublin, Ireland: ICON), the validation of the posologyr MAP algorithm was performed following the methodology proposed by Le Louedec et al. [17]. The 35 population pharmacokinetic models (Table 1) were transcribed for posologyr (an example is given in Appendix A): default monocompartmental with linear elimination, bicompartmental, with various absorption models (lag-time, zero order, first order, combination of zero and first order kinetics, bioavailability), with nonlinear Michaelis–Menten elimination associated or not with linear elimination, with time-varying covariates, different residual error models (additive, proportional, mixed, log-additive), with two types of observations (parent–metabolite model), and finally with increasing levels of inter-individual variability (with variances ranging from 0.2 to 2).
For models with time-varying covariates, the interpolation of variables between observations was performed using the “next observation carried backward” (nocb) approach, similar to NONMEM. The data set simulated by mrgsolve [18] included 4000 subjects per model, or 140,000 subjects in total. They were equally divided into 4 administration and sampling schemes: single administration and rich sampling, single administration and sparse sampling, multiple administration and rich sampling, and multiple administration and sparse sampling. Doses of 10, 30, 60, 80, or 120 mg were administered to each group. To address the nondeterministic nature of the selection of initial η i for OFV minimization, the pseudorandom generator seed was set to an identical value for all estimates using the set.seed function of R.

2.5.2. Conditional Distributions

The estimates of the posologyr MCMC and SIR algorithms were compared to the estimates of the MCMC algorithm from the conditional distributions task of Monolix (version 2021R1. Antony, France: Lixoft SAS, 2020). As the computational time per individual was significantly higher than for the validation of the MAP algorithm, the validation was performed on a subset of the test models and the simulated subjects. The conditional distributions were estimated based on 10,000 samples of each algorithm, for each parameter. The SIR algorithm was run with settings M = 106 samples, and with m = 104 resampling runs. The MCMC algorithm of posologyr was run with 2 Markov chains, each starting with 200 burn-in iterations, discarded before drawing 5000 samples from each chain. The models tested were as follows: the default single-compartment model with oral administration (model #1); the model with lag-time (#3); the model with dual zero and first order absorption (#6); the bicompartmental model with oral administration (#101); the model with nonlinear Michaelis–Menten elimination and oral administration (#201); the model with both linear and nonlinear Michaelis–Menten elimination with oral administration (#207); the model with time-dependent clearance and oral administration (#301); the model with mixed residual error (#405); the model with variance of the random effects set to 1 for all parameters (#504); and the model with variance of random effects equal to 2 (#513). For the model with time-varying covariates, the interpolation of variables between observations was performed using the “last observation carried forward” (locf) approach, similar to Monolix [19]. For model #405, the mixed residual error model was set to combined1 in Monolix. To test the different administration and sampling schemes, 20 subjects were estimated for each model (to test each administration/sampling cohort, and every dose level), i.e., 200,000 parameter samples estimated per algorithm. To ensure reproducibility of the experiments, the pseudorandom generator seed was set to an identical value for all estimates using the set.seed function of R for posologyr, and in the project settings for Monolix.

2.6. Performance Analysis

2.6.1. Point Estimate: MAP

To allow comparability of the results of the performance evaluation of the MAP algorithm of posologyr, the primary endpoints were identical to those proposed by Le Louedec et al. [17]. The maximum absolute difference was obtained between posologyr ( η i k ,   P G Y R ) and NONMEM ( η i k , N M ) for each individual according to the following expressions:
Δ η ^ i k = | η ^ i k , P G Y R η ^ i k , N M |
Δ η ^ i = max ( Δ η ^ i k )
where k is the length of the vector η ^ i . Based on this definition, several performance thresholds were defined. For Δ η ^ i < 0.001, the estimate was considered excellent because, assuming an individual exponential model, with a lognormal distribution of individual parameters around a population median value, the impact on the parameter estimate would be negligible: Δ ψ i < 0.1%. For Δ η ^ i > 0.095, the estimate was considered discordant ( Δ ψ i > 10%). The other estimates were considered acceptable. Finally, for each estimate, the final result of the calculation of the OFV from the MAP estimates of posologyr was compared to the OFV computed from the NONMEM POSTHOC estimates.

2.6.2. Conditional Distributions

Because of the stochastic nature of the estimation algorithms, and because of the multivariate nature of the individual parameter vectors, the isolated posterior distributions were not directly compared using numerical criteria. The validation endpoints were the bias between the results of three different dosage adjustment functions built into posologyr, taking the optimizations based on the posterior distributions produced using Monolix as the reference. For each subject, and each function, the bias was calculated as follows:
b i a s = | O u t p u t a l g o r i t h m O u t p u t M o n o l i x O u t p u t M o n o l i x |
where O u t p u t M o n o l i x is the result of the dose adjustment function based on the distribution of individual parameters estimated using Monolix, and O u t p u t a l g o r i t h m is the result of the same dose adjustment function based on the distribution of individual parameters estimated using either MCMC or SIR. One scenario per function was tested:
  • Determination of the optimal dose to reach a concentration of 30 mg/L, 3 h after administration, with posologyr::poso_dose_conc;
  • Determination of the optimal dose to achieve an AUC0-12h of 500 mg·h/L, with posologyr::poso_dose_auc;
  • Determination of the time to reach a trough concentration below 0.5 mg/L after a 100 mg dose, with posologyr::poso_time_cmin.
The p proportion was set at 0.89 in all cases. For all outcomes, the bias was considered acceptable when ≤10%.

3. Results

3.1. Point Estimate: MAP

The performance of the posologyr MAP algorithm was satisfactory. The estimates were excellent in 98.7% of the cases. The median Δ η ^ i was 7.70 × 10−6, and only 0.58% of all estimates were discordant (Figure 1). Representative pharmacokinetic profiles of excellent and discordant estimates, compared with NONMEM profiles, are given in Appendix B (Figure A1).
The greatest number of discordant estimates was observed for the models with lag-time (model #3), and those with zero order absorption in the central compartment (models #4 and #6). For these models, no discrepancies were found in the case of sparse sampling. In contrast, for the 6000 patients in models 3, 4, and 6 with rich sampling, 9.5% of the estimates were discordant. In the majority of these cases (402 of 570 subjects, or 70% of the estimates), the OFV associated with the posologyr estimate was lower than that calculated based on the NONMEM POSTHOC estimate, in support of a better performance of minimization when using posologyr, leading to the most likely value of η ^ i . Discordant MAP estimates were also more frequently observed in models with increasing inter-individual variability (models #504, #511, #512 and #513), up to a maximum of 3.3% for model 513, irrespective of the administration or observation scheme. Again, for model #513, the posologyr OFVs were lower than the NONMEM POSTHOC estimate in most cases (24 subjects out of 4000, or 99.4%). Extending the above observation regarding OFV to all 140,000 simulated subjects, the estimates produced using posologyr were outperformed by the NONMEM POSTHOC estimate in only 0.14% of cases.

3.2. Posterior Distribution

The performance of the SIR algorithm was satisfactory. Using the posologyr::poso_dose_conc and posologyr::poso_dose_auc functions, the bias on dosage adjustment proposals based on SIR estimates was acceptable in 97% of cases (Figure 2 and Figure 3). The median bias was 0.65% (minimum: 0.00%, maximum: 31.41%). Elimination time predictions using posologyr::poso_time_cmin were acceptable in 99.5% of cases (all but one subject) and the median bias was 0.14% (minimum: 0.00%, maximum: 23.16%).
All outcomes considered, the greatest number of discordances between SIR and Monolix was observed for models with significant inter-individual variability (#504 and #513): 8.3%. For these subjects, proposals based on estimates from the MCMC algorithm implemented in posologyr were discordant with propositions based on Monolix estimates in 10.8% of cases. For the entire dataset, the estimates produced using MCMC exhibited 4.17% discrepancies with Monolix, with a median bias of 0.77%.
For illustration purposes, the density curves of the posterior distributions computed using the different algorithms for subject #1, model #003 are presented in Figure 4.

4. Discussion

A free and open-source software has been developed to allow for the Bayesian individualization of treatments. The performance of posologyr for individual parameter estimation was benchmarked against NONMEM for MAP point estimates and against Monolix for the estimation of full posterior distributions of individual parameters.
The MAP optimization function of posologyr showed excellent performance compared to NONMEM for a wide variety of models and pharmacokinetic profiles. In particular, agreement with NONMEM’s POSTHOC estimates was excellent for the single-compartment and two-compartment models, the models with nonlinear Michaelis–Menten elimination, the model with time-dependent clearance, and the various residual error models, for values of inter-individual variability lower than 1.
A greater number of discrepancies was observed for the different absorption models, especially following administration with lag-time. This type of model produces discontinuous time-concentration profiles, which to some degree may be responsible for difficulties in determining the optimal values of individual parameters [20]. An increasing, but small, number of discrepancies was also observed for increasing values of inter-individual variability. In these different cases, under the assumption that the OFV calculated from the estimated individual parameters [10] is a satisfactory reflection of the minimization performance, posologyr outperformed NONMEM’s POSTHOC estimates for the majority of discordances.
The SIR algorithm implemented in posologyr demonstrated satisfactory performance on the evaluated scenarios. The estimates of the posterior distributions of individual parameters led to dose adjustment proposals comparable to those based on the Monolix estimates. The execution time of the different algorithms was not formally evaluated; however, the observations made during this study showed that the time required to obtain 10,000 samples was 15 times shorter with the SIR algorithm of posologyr than with the MCMC algorithm of posologyr. These results are reassuring with regard to the feasibility of developing a probabilistic MIPD tool in R, opening the door to personalized treatment options informed by knowledge of the uncertainty associated with individual parameter estimation [6]. Still, in this preliminary study, the simulated population tested was limited to 200 patients, with one scenario per function, and a single probability threshold; these exploratory results need to be confirmed before considering the application of this methodology to therapeutic drug monitoring. A thorough evaluation of the performance of SIR will be necessary in order to define the precise scope of its application according to model types, sampling schemes, and patient profiles. The evaluation of different sample sizes, and resampling numbers, would also allow for the optimization of runtime without foregoing estimation quality.
The posologyr software is, and will remain, free and open source under the AGPLv3 license [8]. Now available at https://github.com/levenc/posologyr (accessed on 15 January 2022), it is scheduled for release via the comprehensive R archive network (CRAN) soon. These decisions to make the software easy to distribute and to guarantee its external auditability serve the purpose for which posologyr was developed: to provide a foundation for future Bayesian dosage individualization tools.

Author Contributions

Conceptualization, C.L.; methodology, C.L., A.C. and C.M.; software, C.L.; validation, C.L., A.C. and C.M.; writing—original draft preparation, C.L, C.M.; writing—review and editing, C.L., A.C. and C.M.; All authors have read and agreed to the published version of the manuscript.

Funding

This research received no external funding.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Data supporting the reported results can be found at https://github.com/levenc/posologyr-pharmaceutics (accessed on 15 January 2022).

Acknowledgments

We are thankful to Sasha Schutz for providing computing power useful for this work, and to Pauline Ménard for her insights throughout the development of posologyr.

Conflicts of Interest

The authors declare no conflict of interest.

Appendix A

Model #207 transcribed for posologyr, to match NONMEM estimates:
mod_run207 <- list(
  ppk_model  = RxODE::RxODE({
   centr(0) = 0;
   depot(0) = 0;
   TVVmax= THETA_Vmax;
   TVVc = THETA_Vc;
   TVKa = THETA_Ka;
   TVKm = THETA_Km;
   TVCl = THETA_Cl;
   Vmax = TVVmax*exp(ETA_Vmax);
   Vc  = TVVc*exp(ETA_Vc);
   Ka  = TVKa*exp(ETA_Ka);
   Km  = TVKm*exp(ETA_Km);
   Cl  = TVCl*exp(ETA_Cl);
   Cc  = centr/Vc;
   Ke  = Cl/Vc;
   d/dt(depot) = - Ka*depot;
   d/dt(centr) =  Ka*depot - Vmax*(centr/Vc)/(Km+(centr/Vc)) - Ke*centr;
   d/dt(AUC)   =  Cc;
  }),
  error_model = function(f,sigma){
   dv <- cbind(f,1)
   g <- diag(dv%*%sigma%*%t(dv))
   return(sqrt(g))
  },
 theta = c(THETA_Vmax=10000, THETA_Vc=70.0, THETA_Ka=1.0, THETA_Km=2500, THETA_Cl=4.0),
  omega = lotri::lotri({ETA_Vmax + ETA_Vc + ETA_Ka + ETA_Km + ETA_Cl ~
    c(0.2  ,
     0   ,   0.2,
     0   ,    0,  0.2,
     0   ,    0,   0,  0.2,
     0   ,    0,   0,   0,   0.2)}),
  sigma    = lotri::lotri({prop + add ~ c(0.05,0.0,0.00)}))
Model #207 transcribed for posologyr, to match Monolix estimates:
mod_dist_run207 <- list(
  ppk_model  = RxODE::RxODE({
   centr(0) = 0;
   depot(0) = 0;
   TVVmax= THETA_Vmax;
   TVVc = THETA_Vc;
   TVKa = THETA_Ka;
   TVKm = THETA_Km;
   TVCl = THETA_Cl;
   Vmax = TVVmax*exp(ETA_Vmax);
   Vc  = TVVc*exp(ETA_Vc);
   Ka  = TVKa*exp(ETA_Ka);
   Km  = TVKm*exp(ETA_Km);
   Cl  = TVCl*exp(ETA_Cl);
   Cc  = centr/Vc;
   Ke  = Cl/Vc;
   d/dt(depot) = - Ka*depot;
   d/dt(centr) =  Ka*depot - Vmax*(centr/Vc)/(Km+(centr/Vc)) - Ke*centr;
   d/dt(AUC)  =  Cc;
  }),
  error_model = function(f,sigma){
   g <- sigma[2] + sigma[1]*f
   return(g)
  },
 theta = c(THETA_Vmax=10000, THETA_Vc=70.0, THETA_Ka=1.0, THETA_Km=2500, THETA_Cl=4.0),
  omega = lotri::lotri({ETA_Vmax + ETA_Vc + ETA_Ka + ETA_Km + ETA_Cl ~
     c(0.2  ,
      0   ,   0.2,
      0   ,    0,  0.2,
      0   ,    0,   0,  0.2,
      0   ,    0,   0,   0,  0.2)}),
  sigma    = c(b_prop=0.05,a_add=0.00)
)

Appendix B

Figure A1. Simulated pharmacokinetic profiles from MAP estimates of posologyr (blue solid line) and NONMEM (green dashed line). (A,C): discordant profiles ( Δ η ^ i > 0.050). (B,D): concordant profiles ( Δ η ^ i < 0.001). Black dots: observed concentrations.
Figure A1. Simulated pharmacokinetic profiles from MAP estimates of posologyr (blue solid line) and NONMEM (green dashed line). (A,C): discordant profiles ( Δ η ^ i > 0.050). (B,D): concordant profiles ( Δ η ^ i < 0.001). Black dots: observed concentrations.
Pharmaceutics 14 00442 g0a1

References

  1. Keizer, R.J.; ter Heine, R.; Frymoyer, A.; Lesko, L.J.; Mangat, R.; Goswami, S. Model-Informed Precision Dosing at the Bedside: Scientific Challenges and Opportunities. CPT Pharmacomet. Syst. Pharmacol. 2018, 7, 785–787. [Google Scholar] [CrossRef] [PubMed]
  2. Frymoyer, A.; Schwenk, H.T.; Zorn, Y.; Bio, L.; Moss, J.D.; Chasmawala, B.; Faulkenberry, J.; Goswami, S.; Keizer, R.J.; Ghaskari, S. Model-Informed Precision Dosing of Vancomycin in Hospitalized Children: Implementation and Adoption at an Academic Children’s Hospital. Front. Pharmacol. 2020, 11, 551. [Google Scholar] [CrossRef]
  3. Proost, J.H.; Meijer, D.K.F. MW/Pharm, an Integrated Software Package for Drug Dosage Regimen Calculation and Therapeutic Drug Monitoring. Comput. Biol. Med. 1992, 22, 155–163. [Google Scholar] [CrossRef]
  4. Wicha, S.G.; Kees, M.G.; Solms, A.; Minichmayr, I.K.; Kratzer, A.; Kloft, C. TDMx: A Novel Web-Based Open-Access Support Tool for Optimising Antimicrobial Dosing Regimens in Clinical Routine. Int. J. Antimicrob. Agents 2015, 45, 442–444. [Google Scholar] [CrossRef] [PubMed]
  5. Drennan, P.; Doogue, M.; van Hal, S.J.; Chin, P. Bayesian Therapeutic Drug Monitoring Software: Past, Present and Future. Int. J. Pharmacokinet. 2018, 3, 109–114. [Google Scholar] [CrossRef]
  6. Maier, C.; Hartung, N.; de Wiljes, J.; Kloft, C.; Huisinga, W. Bayesian Data Assimilation to Support Informed Decision Making in Individualized Chemotherapy. CPT Pharmacomet. Syst. Pharmacol. 2020, 9, 153–164. [Google Scholar] [CrossRef] [PubMed]
  7. R Core Team. R: A Language and Environment for Statistical Computing; R Foundation for Statistical Computing: Vienna, Austria, 2022. [Google Scholar]
  8. GNU Affero General Public License—GNU Project—Free Software Foundation. Available online: https://www.gnu.org/licenses/agpl-3.0.en.html (accessed on 15 January 2022).
  9. Bonate, P.L. Nonlinear Mixed Effects Models: Theory. In Pharmacokinetic-Pharmacodynamic Modeling and Simulation; Bonate, P.L., Ed.; Springer: Boston, MA, USA, 2011; pp. 233–301. ISBN 978-1-4419-9485-1. [Google Scholar]
  10. Kang, D.; Bae, K.-S.; Houk, B.E.; Savic, R.M.; Karlsson, M.O. Standard Error of Empirical Bayes Estimate in NONMEM® VI. Korean J. Physiol. Pharmacol. Off. J. Korean Physiol. Soc. Korean Soc. Pharmacol. 2012, 16, 97–106. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  11. Dosne, A.-G.; Bergstrand, M.; Karlsson, M.O. An Automated Sampling Importance Resampling Procedure for Estimating Parameter Uncertainty. J. Pharmacokinet. Pharmacodyn. 2017, 44, 509–520. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  12. Wang, W.; Hallow, K.; James, D. A Tutorial on RxODE: Simulating Differential Equation Pharmacometric Models in R. CPT Pharmacomet. Syst. Pharmacol. 2016, 5, 3–10. [Google Scholar] [CrossRef] [PubMed]
  13. Byrd, R.H.; Lu, P.; Nocedal, J.; Zhu, C. A Limited Memory Algorithm for Bound Constrained Optimization. SIAM J. Sci. Comput. 1995, 16, 1190–1208. [Google Scholar] [CrossRef]
  14. Comets, E.; Lavenu, A.; Lavielle, M. Parameter Estimation in Nonlinear Mixed Effect Models Using Saemix, an R Implementation of the SAEM Algorithm. J. Stat. Softw. 2017, 80, 1–41. [Google Scholar] [CrossRef] [Green Version]
  15. Conditional Distribution Calculation Using Monolix. Available online: https://monolix.lixoft.com/tasks/conditional-distribution/ (accessed on 15 January 2022).
  16. Nonmem 7.4 Users Guides. Available online: https://nonmem.iconplc.com/#/nonmem744/guides (accessed on 15 January 2022).
  17. Le Louedec, F.; Puisset, F.; Thomas, F.; Chatelut, É.; White-Koning, M. Easy and Reliable Maximum a Posteriori Bayesian Estimation of Pharmacokinetic Parameters with the Open-Source R Package Mapbayr. CPT Pharmacomet. Syst. Pharmacol. 2021, 10, 1208–1220. [Google Scholar] [CrossRef] [PubMed]
  18. Elmokadem, A.; Riggs, M.M.; Baron, K.T. Quantitative Systems Pharmacology and Physiologically-Based Pharmacokinetic Modeling With Mrgsolve: A Hands-On Tutorial. CPT Pharmacomet. Syst. Pharmacol. 2019, 8, 883–893. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  19. Using Regression Variables in Monolix. Available online: https://monolix.lixoft.com/data-and-models/regressor/ (accessed on 15 January 2022).
  20. Savic, R.M.; Jonker, D.M.; Kerbusch, T.; Karlsson, M.O. Implementation of a Transit Compartment Model for Describing Drug Absorption in Pharmacokinetic Studies. J. Pharmacokinet. Pharmacodyn. 2007, 34, 711–726. [Google Scholar] [CrossRef] [PubMed]
Figure 1. Performance of posologyr MAP estimation by test model. The negative percentages are the proportions of discordant estimates.
Figure 1. Performance of posologyr MAP estimation by test model. The negative percentages are the proportions of discordant estimates.
Pharmaceutics 14 00442 g001
Figure 2. Adequacy of dose adaptation by tested model for a target AUC based on SIR posterior estimates. The negative percentages are the proportions of discordant propositions.
Figure 2. Adequacy of dose adaptation by tested model for a target AUC based on SIR posterior estimates. The negative percentages are the proportions of discordant propositions.
Pharmaceutics 14 00442 g002
Figure 3. Adequacy of dose adaptation by tested model for a target concentration based on SIR posterior estimates. The negative percentages are the proportions of discordant propositions.
Figure 3. Adequacy of dose adaptation by tested model for a target concentration based on SIR posterior estimates. The negative percentages are the proportions of discordant propositions.
Pharmaceutics 14 00442 g003
Figure 4. Density plots of the posterior distributions of η i for subject #1 with model #003.mcmc, the MCMC algorithm implemented in posologyr; mlx, the MCMC algorithm of Monolix; sir, the SIR algorithm of posologyr; Cl, clearance; Ka, absorption rate; Vc, central volume of distribution; ALAG, lag-time.
Figure 4. Density plots of the posterior distributions of η i for subject #1 with model #003.mcmc, the MCMC algorithm implemented in posologyr; mlx, the MCMC algorithm of Monolix; sir, the SIR algorithm of posologyr; Cl, clearance; Ka, absorption rate; Vc, central volume of distribution; ALAG, lag-time.
Pharmaceutics 14 00442 g004
Table 1. Test models.
Table 1. Test models.
Model Characteristics Model Number
(Number of Estimated Parameters)
Oral AdministrationIV Administration
Monocompartmental (default) 1 (3)2 (2)
Absorption Lag time3 (4)/
Zero-order in Central compartment4 (3)/
Zero-order in Depot compartment5 (4)/
Dual 0- and 1st orders6 (4)/
Dual 1st orders7 (4)/
Bioavailability8 (4)/
Distribution Bicompartmental101 (4)102 (3)
Elimination Michaelis–Menten (KM, VMAX)201 (4)202 (3)
Cl + Michaelis–Menten (KM)203 (4)204 (3)
Cl + Michaelis–Menten (VMAX)205 (4)206 (3)
Cl + Michaelis–Menten (KM, VMAX)207 (5)208 (4)
Time-Varying Covariates Time-varying Cl301 (3)302 (2)
Residual Error Model Metabolite401 (5)402 (4)
Additive403 (3)404 (2)
Mixed405 (3)406 (2)
Log-additive407 (3)408 (2)
Inter-individual Variability (variance) 0.4 on all parameters501 (3)/
0.6 on all parameters502 (3)/
0.8 on all parameters503 (3)/
1 on all parameters504 (3)/
2 on Cl, 0.2 on Ka, Vc511 (3)/
2 on Cl, Ka, 0.2 on Vc512 (3)/
2 on all parameters513 (3)/
Abbreviations: Cl, clearance; IV, intravenous 1 h infusion; Ka, absorption rate; KM, Michaelis–Menten constant; Vc, central volume of distribution; VMAX, maximum rate; /, not applicable.
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Leven, C.; Coste, A.; Mané, C. Free and Open-Source Posologyr Software for Bayesian Dose Individualization: An Extensive Validation on Simulated Data. Pharmaceutics 2022, 14, 442. https://doi.org/10.3390/pharmaceutics14020442

AMA Style

Leven C, Coste A, Mané C. Free and Open-Source Posologyr Software for Bayesian Dose Individualization: An Extensive Validation on Simulated Data. Pharmaceutics. 2022; 14(2):442. https://doi.org/10.3390/pharmaceutics14020442

Chicago/Turabian Style

Leven, Cyril, Anne Coste, and Camille Mané. 2022. "Free and Open-Source Posologyr Software for Bayesian Dose Individualization: An Extensive Validation on Simulated Data" Pharmaceutics 14, no. 2: 442. https://doi.org/10.3390/pharmaceutics14020442

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop