Contents

library(cellmig)
library(ggplot2)
library(ggforce)
library(patchwork)
library(rstan)

ggplot2::theme_set(new = theme_bw(base_size = 10))

1 Background

High-throughput cell migration assays generate complex, hierarchically structured datasets with inherent technical noise and biological variability. To accurately quantify treatment effects on cell migration velocity, it is essential to account for these sources of variation and to design experiments that provide sufficient statistical power. The cellmig R package implements a Bayesian hierarchical model for analyzing such data. See the “User manual” vignette to understand the key functionalities of cellmig.

Furthermore, cellmig includes functionality for simulating synthetic datasets. These simulations are invaluable for experimental planning, allowing researchers to assess how different experimental designs (e.g., varying numbers of biological replicates, technical replicates, or cells per well) affect the precision of treatment effect estimates.

This vignette demonstrates how to use cellmig to simulate cell migration data under a partially generative model. These functionalities are documented in this vignette. In short, we simulate data based on realistic parameter values derived from experimental data and then analyze the simulated data using cellmig to recover the parameters. This process validates the model and illustrates how simulation can guide experimental design and power analysis.

2 Installation

To install this package, start R (version “4.5”) and enter:

if (!require("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("cellmig")

3 Data simulation from partially generative model

We simulate data for an experiment with the following design:

3.1 Model specification

3.1.1 Setting \(\alpha_p\)

Plate-specific batch effects are modeled by drawing the plate offset \(\alpha_p\) from a normal distribution:

\[ \alpha_p \sim \text{Normal}(1.7, 0.1) \]

Here, \(\alpha_p\) represents the log-transformed mean velocity of the control treatment on plate \(p\). The mean (1.7) and standard deviation (0.1) are chosen based on experimental data. If batch effects are minimal, the standard deviation can be set to a smaller value (e.g., 0.01).

3.1.2 Setting \(\kappa_w\)

The velocities in each well are gamma distributed, and the gamma distribution is defined by a rate and shape parameter. The shape parameter for well \(w\), \(\kappa_w\), controls the form or skewness of the distribution and, to some extent, the variability in the data.

We simulate the values of \(\log(\kappa_w)\) by drawing randomly from a normal distribution with mean (\(\mu_{\kappa}\)) and standard deviation (\({\sigma}_{\kappa}\)). The values of \(\mu_{\kappa}\) and \({\sigma}_{\kappa}\) can either be fixed to point values, or be drawn from two normal distributions whose means and standard deviations are described by the inputs prior_kappa_mu_M, prior_kappa_sigma_M, prior_kappa_mu_SD, and prior_kappa_sigma_SD. To fix the values of \(\mu_{\kappa}\) and \({\sigma}_{\kappa}\) to point estimates set the scales to small values (e.g., set in control prior_kappa_mu_SD=0.01 and prior_kappa_sigma_SD).

3.1.3 Defining the offset

To correct for batch effects across plates, we designate one treatment as the reference (offset). Here, we set the offset to treatment 4 (i.e., the fourth treatment group, which has \(\delta_t = 0\)).

3.2 Generates dataframe with simulated velocities

We use the gen_partial function from cellmig to simulate the data. The function requires a control list specifying the experimental design and model parameters.

# set seed for reproducible results
set.seed(seed = 1253)
# simulate data
y_p <- gen_partial(control = list(N_biorep = 8, 
                                  N_techrep = 5, 
                                  N_cell = 50, 
                                  delta = c(-0.4, -0.2, -0.1, 0, 0.1, 0.2, 0.4),
                                  sigma_bio = 0.1, 
                                  sigma_tech = 0.05, 
                                  offset = 4,
                                  prior_alpha_p_M = 1.7,
                                  prior_alpha_p_SD = 0.1,
                                  prior_kappa_mu_M = 1.7,
                                  prior_kappa_mu_SD = 0.1,
                                  prior_kappa_sigma_M = 0,
                                  prior_kappa_sigma_SD = 0.1))
# see data structure
str(y_p$y)
FALSE 'data.frame': 14000 obs. of  6 variables:
FALSE  $ v       : num  3.24 6.03 4.4 10.96 4.36 ...
FALSE  $ well    : int  1 1 1 1 1 1 1 1 1 1 ...
FALSE  $ plate   : int  1 1 1 1 1 1 1 1 1 1 ...
FALSE  $ group   : int  1 1 1 1 1 1 1 1 1 1 ...
FALSE  $ compound: int  1 1 1 1 1 1 1 1 1 1 ...
FALSE  $ dose    : chr  "X" "X" "X" "X" ...

The output is a dataframe with columns:

  • v: Cell velocity

  • well: Well identifier

  • plate: Plate identifier

  • group: Treatment group

  • compound: Compound identifier (same as group in this simulation)

  • dose: Dose level (not used in this simulation, set to “X”)

Visualizing the simulated data

We can visualize the simulated cell velocities using scatter plots, with points jittered by well and colored by plate.

ggplot(data = y_p$y)+
  geom_sina(aes(x = paste0("t=", group), col = paste0("p=", plate), 
                y = v, group = well), size = 0.5)+
  theme_bw()+
  theme(legend.position = "top",
        strip.text.x = element_text(margin = margin(0.03,0,0.03,0, "cm")))+
  xlab(label = "dose")+
  ylab(label = "migration speed")+
  guides(color = guide_legend(override.aes = list(size = 3)))+
  scale_color_grey(name = "plate")+
  scale_y_log10()

Alternatively, we can visualize the well-specific mean velocities to highlight plate-specific batch effects:

ggplot(data = aggregate(v~well+group+plate, data = y_p$y, FUN = mean))+
  geom_sina(aes(x = paste0("t=", group), col = paste0("p=", plate), 
                y = v, group = well), size = 1)+
  theme_bw()+
  theme(legend.position = "top",
        strip.text.x = element_text(margin = margin(0.03,0,0.03,0, "cm")))+
  xlab(label = "dose")+
  ylab(label = "migration speed")+
  guides(color = guide_legend(override.aes = list(size = 3)))+
  scale_y_log10()+
  scale_color_grey(name = "plate")

3.2.1 Analyzing simulated data with cellmig

The simulated data must be formatted to match the input requirements of cellmig. Specifically, we need to convert some columns to character and add an offset column indicating the reference treatment.

sim_data <- y_p$y

# format simulated data to be used as input in cellmig
sim_data$well <- as.character(sim_data$well)
sim_data$compound <- as.character(sim_data$compound)
sim_data$plate <- as.character(sim_data$plate)
sim_data$offset <- 0
sim_data$offset[sim_data$group=="4"] <- 1

We now analyze the simulated data using cellmig with the following control parameters:

osd <- cellmig(x = sim_data,
               control = list(mcmc_warmup = 250,
                              mcmc_steps = 800,
                              mcmc_chains = 2,
                              mcmc_cores = 2,
                              mcmc_algorithm = "NUTS",
                              adapt_delta = 0.8,
                              max_treedepth = 10))

3.2.2 Comparing simulated vs. inferred parameters

We compare the inferred parameters (posterior means and 95% HDIs) with the true values used in the simulation.

3.2.2.1 Plate-specific offsets (\(\alpha_p\))

ggplot(data = osd$posteriors$alpha_p)+
  geom_point(aes(y = plate_id, x = exp(mean)))+
  geom_errorbarh(aes(y = plate_id, x = exp(mean), xmin = exp(X2.5.), 
                     xmax = exp(X97.5.)), height = 0.1)+
  geom_point(data = data.frame(v = exp(y_p$par$alpha_p),
                               plate = osd$posteriors$alpha_p$plate_id),
             aes(y = plate, x = v), col = "red")+
  scale_y_continuous(breaks = osd$posteriors$alpha_p$plate_id)+
  xlab(label = expression(alpha[p]*"'"))

3.2.2.2 Effect sizes (\(\delta_t\))

ggplot(data = osd$posteriors$delta_t)+
  geom_point(aes(y = group_id, x = mean))+
  geom_errorbarh(aes(y = group_id, x = mean, xmin = X2.5., xmax = X97.5.), 
                 height = 0.1)+
  geom_point(data = data.frame(delta = c(-0.4, -0.2, -0.1, 0.1, 0.2, 0.4), 
                               group_id = 1:6),
             aes(y = group_id, x = delta), col = "red")+
  xlab(label = expression(delta[t]))+
  ylab(label = "treatment")+
  scale_y_continuous(breaks = 1:8)

3.2.2.3 Biological (\(\sigma_{bio}\)) and technical (\(\sigma_{tech}\)) variability

plot(osd$fit, par = c("sigma_bio", "sigma_tech"))

4 Data simulation from fully generative model

We can also use cellmig to generate cell velocities from the prior distributions of the parameters \(\rightarrow\) data from prior predictive distribution.

In this scenario, the parameters, such as \(\delta_t\), will not be fixed to point values but rather generated from their priors.

4.1 Model specification

control <- list(N_biorep = 4, 
                N_techrep = 3, 
                N_cell = 30, 
                N_group = 8,
                prior_alpha_p_M = 1.7,
                prior_alpha_p_SD = 1.0,
                prior_kappa_mu_M = 1.7,
                prior_kappa_mu_SD = 1.0,
                prior_kappa_sigma_M = 0,
                prior_kappa_sigma_SD = 1.0,
                prior_sigma_bio_M = 0.0,
                prior_sigma_bio_SD = 1.0,
                prior_sigma_tech_M = 0.0,
                prior_sigma_tech_SD = 1.0,
                prior_mu_group_M = 0.0,
                prior_mu_group_SD = 1.0)
# generate data
y_f <- gen_full(control = control)
FALSE Chain 1: 
FALSE Chain 1:  Elapsed Time: 0 seconds (Warm-up)
FALSE Chain 1:                0.002 seconds (Sampling)
FALSE Chain 1:                0.002 seconds (Total)
FALSE Chain 1:

The generate data has a similar structure as before:

str(y_f)
FALSE List of 2
FALSE  $ y      :'data.frame':  2880 obs. of  8 variables:
FALSE   ..$ i       : int [1:2880] 1 2 3 4 5 6 7 8 9 10 ...
FALSE   ..$ v       : num [1:2880] 19.75 3.92 2.16 3.23 1.17 ...
FALSE   ..$ well    : chr [1:2880] "1" "1" "1" "1" ...
FALSE   ..$ plate   : chr [1:2880] "1" "1" "1" "1" ...
FALSE   ..$ group   : chr [1:2880] "1" "1" "1" "1" ...
FALSE   ..$ compound: chr [1:2880] "1" "1" "1" "1" ...
FALSE   ..$ dose    : chr [1:2880] "X" "X" "X" "X" ...
FALSE   ..$ trep_id : int [1:2880] 1 1 1 1 1 1 1 1 1 1 ...
FALSE  $ control:List of 19
FALSE   ..$ N_biorep            : num 4
FALSE   ..$ N_techrep           : num 3
FALSE   ..$ N_cell              : num 30
FALSE   ..$ N_group             : num 8
FALSE   ..$ prior_alpha_p_M     : num 1.7
FALSE   ..$ prior_alpha_p_SD    : num 1
FALSE   ..$ prior_kappa_mu_M    : num 1.7
FALSE   ..$ prior_kappa_mu_SD   : num 1
FALSE   ..$ prior_kappa_sigma_M : num 0
FALSE   ..$ prior_kappa_sigma_SD: num 1
FALSE   ..$ prior_sigma_bio_M   : num 0
FALSE   ..$ prior_sigma_bio_SD  : num 1
FALSE   ..$ prior_sigma_tech_M  : num 0
FALSE   ..$ prior_sigma_tech_SD : num 1
FALSE   ..$ prior_mu_group_M    : num 0
FALSE   ..$ prior_mu_group_SD   : num 1
FALSE   ..$ offset              : num 1
FALSE   ..$ N_plate             : num 4
FALSE   ..$ N_well_reps         : num 3

4.2 Compare density of velocities from partially vs. fully generative models

w <- data.frame(v_f = y_f$y$v[1:2000], v_p = y_p$y$v[1:2000])
 ggplot(data = w)+
    geom_point(aes(x = v_f, y = v_p), size = 0.5)+
    geom_density_2d(aes(x = v_f, y = v_p), col = "orange")+
    scale_x_log10(name = "Velocity from fully generative model", 
                  limits = c(0.01, 10^4))+
    scale_y_log10(name = "Velocity from partially generative model", 
                  limits = c(0.01, 10^4))+
    annotation_logticks(base = 10, sides = "lb")+
    theme_bw(base_size = 10)
FALSE Warning: Removed 10 rows containing non-finite outside the scale range
FALSE (`stat_density2d()`).
FALSE Warning: Removed 10 rows containing missing values or values outside the scale range
FALSE (`geom_point()`).

5 Power analysis

How many biological replicates do we need to capture certain effect size (\(\delta\))? Similar question can be asked in order to optimize the number of technical replicates or the number of cells per well.

The code below takes considerable time to be executed. This is because we generate N_biorep times N_sim datasets and fit a model. To avoid this during R-package checks, the following chunks will not be evaluated. Do this yourselves.

Important note: using multicore execution you can considerably speed-up this analysis!

# Constants
N_bioreps <- c(3, 6, 9)
N_sim <- 10
true_deltas <- c(-0.3, -0.15, 0, 0.2, 0.4)
offset <- 3

# power analysis
deltas <- vector(mode = "list", length = length(N_bioreps)*N_sim)
i <- 1
for(N_biorep in N_bioreps) {
  for(b in 1:N_sim) {
    # simulate data
    y_p <- gen_partial(control = list(N_biorep = N_biorep, 
                                      N_techrep = 3, 
                                      N_cell = 40, 
                                      delta = true_deltas,
                                      sigma_bio = 0.1, 
                                      sigma_tech = 0.05, 
                                      offset = offset,
                                      prior_alpha_p_M = 1.7,
                                      prior_alpha_p_SD = 0.1,
                                      prior_kappa_mu_M = 1.7,
                                      prior_kappa_mu_SD = 0.1,
                                      prior_kappa_sigma_M = 0,
                                      prior_kappa_sigma_SD = 0.1))
    
    # format simulated data to be used as input in cellmig
    sim_data <- y_p$y
    sim_data$well <- as.character(sim_data$well)
    sim_data$compound <- as.character(sim_data$compound)
    sim_data$plate <- as.character(sim_data$plate)
    sim_data$offset <- 0
    sim_data$offset[sim_data$group==offset] <- 1
    
    # run cellmig
    o <- cellmig(x = sim_data,
                   control = list(mcmc_warmup = 300,
                                  mcmc_steps = 1000,
                                  mcmc_chains = 1,
                                  mcmc_cores = 1,
                                  mcmc_algorithm = "NUTS",
                                  adapt_delta = 0.8,
                                  max_treedepth = 10))
    
    delta <- o$posteriors$delta_t
    delta$b <- b
    delta$N_biorep <- N_biorep
    delta$true_deltas <- true_deltas[-offset]
    delta$TP <- (delta$X2.5. <= delta$true_deltas & 
                   delta$X97.5. >= delta$true_deltas) &
      !(delta$X2.5. <= 0 & delta$X97.5. >= 0)
    deltas[[i]] <- delta
    i <- i + 1
  }
}

rm(i, delta, o, sim_data, y_p, b, N_biorep, offset, true_deltas)

deltas <- do.call(rbind, deltas)

What do you see? For Large effect (\(|\delta_t|>>0\)) we need few biological replicates to capture the true effect and not the null effect (\(\delta_t=0\)), i.e., in nearly all simulations we have a true positive. For smaller effects, this is not the case, and we probably need many more biological replicates to each a high true positive rate.

ggplot(data = aggregate(TP~N_biorep+true_deltas, data = deltas, FUN = sum))+
  geom_point(aes(x = N_biorep, y = TP, col = abs(true_deltas), 
                 group = as.factor(true_deltas)), size = 2, alpha = 0.5)+
  geom_line(aes(x = N_biorep, y = TP, col = abs(true_deltas), 
                group = as.factor(true_deltas)), alpha = 0.5)+
  ylab(label = "Number of true positives (TPs)")+
  scale_color_distiller(name = expression("|"*delta[t]*"|"),palette="Spectral")+
  theme_bw(base_size = 10)

6 Session Info

sessionInfo()
FALSE R version 4.5.1 Patched (2025-08-23 r88802)
FALSE Platform: x86_64-pc-linux-gnu
FALSE Running under: Ubuntu 24.04.3 LTS
FALSE 
FALSE Matrix products: default
FALSE BLAS:   /home/biocbuild/bbs-3.22-bioc/R/lib/libRblas.so 
FALSE LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.0
FALSE 
FALSE locale:
FALSE  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
FALSE  [3] LC_TIME=en_GB              LC_COLLATE=C              
FALSE  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
FALSE  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
FALSE  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
FALSE [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
FALSE 
FALSE time zone: America/New_York
FALSE tzcode source: system (glibc)
FALSE 
FALSE attached base packages:
FALSE [1] stats     graphics  grDevices utils     datasets  methods   base     
FALSE 
FALSE other attached packages:
FALSE [1] rstan_2.32.7        StanHeaders_2.32.10 patchwork_1.3.2    
FALSE [4] ggforce_0.5.0       ggplot2_4.0.0       cellmig_0.99.16    
FALSE [7] BiocStyle_2.37.1   
FALSE 
FALSE loaded via a namespace (and not attached):
FALSE  [1] gtable_0.3.6          xfun_0.53             bslib_0.9.0          
FALSE  [4] QuickJSR_1.8.0        inline_0.3.21         lattice_0.22-7       
FALSE  [7] vctrs_0.6.5           tools_4.5.1           generics_0.1.4       
FALSE [10] yulab.utils_0.2.1     stats4_4.5.1          curl_7.0.0           
FALSE [13] parallel_4.5.1        tibble_3.3.0          pkgconfig_2.0.3      
FALSE [16] ggplotify_0.1.2       RColorBrewer_1.1-3    S7_0.2.0             
FALSE [19] RcppParallel_5.1.11-1 lifecycle_1.0.4       compiler_4.5.1       
FALSE [22] farver_2.1.2          stringr_1.5.2         treeio_1.33.0        
FALSE [25] tinytex_0.57          codetools_0.2-20      ggtree_3.17.1        
FALSE [28] ggfun_0.2.0           htmltools_0.5.8.1     sass_0.4.10          
FALSE [31] yaml_2.3.10           lazyeval_0.2.2        pillar_1.11.0        
FALSE [34] jquerylib_0.1.4       tidyr_1.3.1           MASS_7.3-65          
FALSE [37] cachem_1.1.0          magick_2.9.0          nlme_3.1-168         
FALSE [40] aplot_0.2.9           tidyselect_1.2.1      digest_0.6.37        
FALSE [43] stringi_1.8.7         dplyr_1.1.4           reshape2_1.4.4       
FALSE [46] purrr_1.1.0           bookdown_0.44         labeling_0.4.3       
FALSE [49] polyclip_1.10-7       fastmap_1.2.0         grid_4.5.1           
FALSE [52] cli_3.6.5             magrittr_2.0.4        loo_2.8.0            
FALSE [55] dichromat_2.0-0.1     pkgbuild_1.4.8        ape_5.8-1            
FALSE [58] withr_3.0.2           rappdirs_0.3.3        scales_1.4.0         
FALSE [61] rmarkdown_2.29        matrixStats_1.5.0     gridExtra_2.3        
FALSE [64] evaluate_1.0.5        knitr_1.50            V8_7.0.0             
FALSE [67] gridGraphics_0.5-1    rstantools_2.5.0      rlang_1.1.6          
FALSE [70] isoband_0.2.7         Rcpp_1.1.0            glue_1.8.0           
FALSE [73] tidytree_0.4.6        tweenr_2.0.3          BiocManager_1.30.26  
FALSE [76] jsonlite_2.0.0        R6_2.6.1              plyr_1.8.9           
FALSE [79] fs_1.6.6