sRACIPE 1.22.0
This document illustrates the use of sRACIPE to simulate any circuit or network or topology (used interchangeably) and analyze the generated data. sRACIPE implements a randomization-based method for gene circuit modeling. It allows us to study the effect of both the gene expression noise and the parametric variation on any gene regulatory circuit (GRC) using only its topology, and simulates an ensemble of models with random kinetic parameters at multiple noise levels. Statistical analysis of the generated gene expressions reveals the basin of attraction and stability of various phenotypic states and their changes associated with intrinsic and extrinsic noises. sRACIPE provides a holistic picture to evaluate the effects of both the stochastic nature of cellular processes and the parametric variation.
if (!requireNamespace("BiocManager", quietly = TRUE))
install.packages("BiocManager")
BiocManager::install("sRACIPE")Or install the development version of the package.
BiocManager::install(“vivekkohar/sRACIPE”)library(sRACIPE)For simplicity, we will start with the toggle switch with mutual inhibition and self activation of both genes as a test case. Additionally, to keep the simulations fast, we will use fewer models, small integration time and longer integration step size. We recommend using the default settings for most parameters for actual simulations.
One can use the topology stored in a text file or loaded as a dataframe. The typical format of the topology file is a 3 column file where the first column is name of the source gene, second column is name of the target gene and last column is the interaction type (1 - activation, 2-inhibition). The first line should contain the header (Source Target Interaction). We will work with a demo circuit from the package.
library(sRACIPE)
# Load a demo circuit
data("demoCircuit")
demoCircuit##   Source Target Type
## 1      A      B    2
## 2      B      A    2
## 3      A      A    1
## 4      B      B    1We will use a reduced number of models (using numModels) for demonstration. The simulations will return a RacipeSE object.
rSet <- sRACIPE::sracipeSimulate(circuit = demoCircuit, numModels = 20,
                             plots = FALSE, integrateStepSize = 0.1, 
                             simulationTime = 30)## circuit file successfully loaded## Generating gene thresholds## generating thresholds for uniform distribution1...
## ========================================We can plot the simulated data using the sracipePlotData function or using plots=TRUE in sracipeSimulate. The data can be normalized before plotting. Otherwise it will be normalized by the plotting function. By default, two clusters are identified and models colored according to hierarchical clustering.
rSet <- sRACIPE::sracipeNormalize(rSet)
rSet <- sRACIPE::sracipePlotData(rSet, plotToFile = FALSE)The simulations can be used to perform in-silico perturbation analysis. For example, here we will limit a gene’s production rate to mimic its knockdown and show how that changes the relative proportion of models in different clusters.
data("demoCircuit")
rSet <- sRACIPE::sracipeSimulate(circuit = demoCircuit, 
                             numModels = 50, plots = FALSE, 
                             integrateStepSize = 0.1, 
                             simulationTime = 30)## circuit file successfully loaded## Generating gene thresholds## generating thresholds for uniform distribution1...
## ========================================kd <- sRACIPE::sracipeKnockDown(rSet, plotToFile = FALSE,
                                reduceProduction=50)The network can be plotted in an interactive viewer or html file in the results folder.
 sRACIPE::sracipePlotCircuit(rSet, plotToFile = FALSE)One can perform stochastic simulations similarly by specifying additional parameters to the sracipeSimulate function, namely, nNoise (the number of noise levels at which the stochastic simulations should be carried out), initialNoise (the starting noise level) and noiseScalingFactor (the multiplicative factor by which noise should be reduced for multiple noise levels). For annealing, use anneal=TRUE alongwith the above mentioned parameters. For simulations at one noise level only, use nNoise = 1 and set initialNoise parameter to the specific noise.
Now the returned object will contain additional elements in the assays which correspond to the simulations at different noise levels (noise specified by the name of the element).
rSet <- sRACIPE::sracipeSimulate(circuit = demoCircuit, numModels = 20, 
                             initialNoise = 15, noiseScalingFactor = 0.1,
                             nNoise = 2,
                             plots = TRUE, plotToFile = FALSE, 
                             integrateStepSize = 0.1, 
                             simulationTime = 30)## circuit file successfully loaded## Generating gene thresholds## generating thresholds for uniform distribution1...
## ========================================Here, calling the sracipeSimulate function simulated the circuit at zero noise level as well as the two (nNoise) other noise levels 15 (initialNoise), 1.5 (initialNoise*noiseScalingFactor). The first three plots (hierarchical clustering heatmap, Umap, PCA) correspond to deterministic data and the last two plots contain the data from stochastic simulations projected on the principal components of the deterministic simulations.
Note that the rSet now contains stochastic simulations as well as additional elements like umap, pca, assignedClusters. These are added when the data is plotted. As mentioned previously, the additional elements of the assays are named “15” and “1.5” which correspond to noise levels.
For annealing simulations, one can set anneal=TRUE in the sracipeSimulate function. With anneal=FALSE (constant noise), simulations at different noise levels are independent of each other. These are useful if one is primarily interested in the gene expressions at different noise levels and at zero noise (used for normalizing the data). With annealing, the steady state solutions at higher noise levels are used as the intial conditions for lower noise levels such that each model converges to its most stable state when the noise is zero.
Using annealing, ideally the number of noise levels should be very large and noiseScalingFactor close to 1 as we want to reduce the noise very slowly. In practice, we found nNoise ~ 30 and initialNoise ~50 divided by sqrt(number_gene) as good starting values. Constant noise and annealing noise simulations pca plots can be used for better approximations of these parameters. The initialNoise should be such that there is a single cluster at this high noise level (essentially the gene expression values are random and circuit topology has little effect). Next, noiseScalingFactor should be adjusted such that there are sufficient noise levels when this single cluster splits into multiple clusters observed in deterministic simulations.
With annealing,
the models converge to their most stable steady state
at zero noise. Thus, the number of models is more stable clusters
will increase and number in less
stable clusters will decrease. Note that for non zero noise, the stable states
can be different from the stable states at zero noise. In our illustrative
example shown abpve, the previous two stable states of a toggle circuit are no
longer stable at high noise (“15”) and instead the previously unstable high high
state is stable now. Briefly, noise can change the stable states and zero noise
simulations using annealing can
gives us an idea about the relative stability of states
when there are multiple stable states.
Further, one can modify the parameters and/or initial conditions and simulate the circuit with modified parameters and/or initial conditions using the parameters genParams = FALSE and/or genIC = FALSE.
rSet <- sRACIPE::sracipeSimulate(circuit = demoCircuit, numModels = 20, 
                             plots = FALSE, integrate = FALSE)## circuit file successfully loaded## Generating gene thresholds## generating thresholds for uniform distribution1...
## ========================================params <- sRACIPE::sracipeParams(rSet)
modifiedParams <- as.matrix(params) 
modifiedParams[,1] <- 0.1*modifiedParams[,1]
sRACIPE::sracipeParams(rSet) <- DataFrame(modifiedParams)
rSet <- sRACIPE::sracipeSimulate(rSet, plots = FALSE, genParams = FALSE)## ========================================Knockout of a gene is implemented by changing the production rate and initial condition of the gene to zero. The knockOut parameter in the function sracipeSimulate can be used to perform these knockout simulations. If simulations are to be carried out for knockouts of different genes, the genes should be specified as a list where each list element will contain the names of the gene to be knocked out. For example, knockout = list(“gene1”, “gene2”, c(“gene3”, “gene4”), “gene5”) will knockout gene1, gene2, gene5 one by one and knockout gene3 and gene4 simultaneously. knockOut = “all”, each gene is knocked out one by one and the results are returned as an element knockOutSimulations which, similar to stochasticSimulations, is a list of dataframes containing the gene expressions obtained by knockout one or more genes. Enabling plots=TRUE will plot the results. As the expression of knockout gene is zero, we compute PCA with unperturbed genes for both the unperturbed simulations as well as the perturbed simulations. So for each knockout, we have two plots containing the scatter plot of unperturbed simulations and perturbed simulations on the PCs of unperturbed simulations (excluding the gene to be perturbed).
Kohar V, Lu M (2018). “Role of noise and parametric variation in the dynamics of gene regulatory circuits.” npj Systems Biology and Applications, 4, 40. https://www.nature.com/articles/s41540-018-0076-x.
sessionInfo()## R version 4.4.1 (2024-06-14)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.1 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.20-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_GB              LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## time zone: America/New_York
## tzcode source: system (glibc)
## 
## attached base packages:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] sRACIPE_1.22.0              Rcpp_1.0.13                
##  [3] SummarizedExperiment_1.36.0 Biobase_2.66.0             
##  [5] GenomicRanges_1.58.0        GenomeInfoDb_1.42.0        
##  [7] IRanges_2.40.0              S4Vectors_0.44.0           
##  [9] BiocGenerics_0.52.0         MatrixGenerics_1.18.0      
## [11] matrixStats_1.4.1           BiocStyle_2.34.0           
## 
## loaded via a namespace (and not attached):
##  [1] tidyselect_1.2.1        dplyr_1.1.4             farver_2.1.2           
##  [4] bitops_1.0-9            fastmap_1.2.0           digest_0.6.37          
##  [7] lifecycle_1.0.4         magrittr_2.0.3          compiler_4.4.1         
## [10] rlang_1.1.4             sass_0.4.9              tools_4.4.1            
## [13] utf8_1.2.4              yaml_2.3.10             knitr_1.48             
## [16] askpass_1.2.1           S4Arrays_1.6.0          labeling_0.4.3         
## [19] htmlwidgets_1.6.4       reticulate_1.39.0       DelayedArray_0.32.0    
## [22] plyr_1.8.9              RColorBrewer_1.1-3      abind_1.4-8            
## [25] KernSmooth_2.23-24      withr_3.0.2             grid_4.4.1             
## [28] fansi_1.0.6             caTools_1.18.3          colorspace_2.1-1       
## [31] ggplot2_3.5.1           scales_1.3.0            gtools_3.9.5           
## [34] MASS_7.3-61             tinytex_0.53            cli_3.6.3              
## [37] rmarkdown_2.28          crayon_1.5.3            generics_0.1.3         
## [40] umap_0.2.10.0           RSpectra_0.16-2         httr_1.4.7             
## [43] reshape2_1.4.4          visNetwork_2.1.2        cachem_1.1.0           
## [46] stringr_1.5.1           zlibbioc_1.52.0         BiocManager_1.30.25    
## [49] XVector_0.46.0          vctrs_0.6.5             Matrix_1.7-1           
## [52] jsonlite_1.8.9          bookdown_0.41           magick_2.8.5           
## [55] jquerylib_0.1.4         glue_1.8.0              stringi_1.8.4          
## [58] gtable_0.3.6            UCSC.utils_1.2.0        munsell_0.5.1          
## [61] tibble_3.2.1            pillar_1.9.0            htmltools_0.5.8.1      
## [64] gplots_3.2.0            openssl_2.2.2           GenomeInfoDbData_1.2.13
## [67] R6_2.5.1                evaluate_1.0.1          lattice_0.22-6         
## [70] highr_0.11              png_0.1-8               bslib_0.8.0            
## [73] gridExtra_2.3           SparseArray_1.6.0       xfun_0.48              
## [76] pkgconfig_2.0.3