Contents

1 Introduction

If many genes are perturbed in a population of cells, this can lead to diseases like cancer. The perturbations can happen in different ways, e.g. via mutations, copy number abberations or methylation. However, not all perturbations are observed in all samples.

Nested Effects Model-based perturbation inference (NEM\(\pi\)) uses observed perturbation profiles and gene expression data to infer unobserved perturbations and augment observed ones. The causal network of the perturbed genes (P-genes) is modelled as an adjacency matrix \(\phi\) and the genes with observed gene expression (E-genes) are modelled with the attachment \(\theta\) with \(\theta_{ij}=1\), if E-gene \(j\) is attached to S-gene \(i\). If E-gene \(j\) is attached to P-gene \(i\), \(j\) shows an effect for a perturbation of P-gene \(i\). Hence, \(\phi\theta\) predicts gene expression profiles, which can be compared to the real data. NEM\(\pi\) iteratively infers a network \(\phi\) based on gene expression profiles and a perturbation profile, and the perturbation profile based on a network \(\phi\).

2 Installation and loading

Use devtools to install the latest version from github or use the BiocManahger to install the package from bioconductor.

if (!requireNamespace("BiocManager", quietly = TRUE)) install.packages("BiocManager")
BiocManager::install("nempi")

Load the package with the library function.

library(nempi)

3 Small example

We look at a small example for which we first simulate data and then infer the unobserved perturbations. We draw a random network for the perturbed genes (P-genes). Then we simulate gene expression for each sample given the subset of P-genes that has been perturbed in the sample. E.g., if P-gene A is upstream of P-gene B and P-gene A has been perturbed, all E-genes attached to B also show an effect.

3.1 Data simulation

library(mnem)
seed <- 8675309
Pgenes <- 10
Egenes <- 5
samples <- 100
edgeprob <- 0.5
uninform <- floor((Pgenes * Egenes) * 0.1)
Nems <- mw <- 1
noise <- 1
multi <- c(0.2, 0.1)
set.seed(seed)
simmini <- simData(Sgenes = Pgenes, Egenes = Egenes, Nems = Nems, mw = mw, nCells = samples,
    uninform = uninform, multi = multi, badCells = floor(samples * 0.1), edgeprob = edgeprob)
data <- simmini$data
ones <- which(data == 1)
zeros <- which(data == 0)
data[ones] <- rnorm(length(ones), 1, noise)
data[zeros] <- rnorm(length(zeros), -1, noise)
epiNEM::HeatmapOP(data, col = "RdBu", cexRow = 0.75, cexCol = 0.75, bordercol = "transparent",
    xrot = 0, dendrogram = "both")
Heatmap of the simulated log odds. Effects are blue and no effects
are red. Rows denote the observed E-genes and columns the samples annoted by
P-genes. Each P-gene
has been perturbed in many cells. The E-genes are annotated as how they are
attached in the ground truth. E.g. E-genes named '1' are attached to S-gene
'1' in the ground truth.

Figure 1: Heatmap of the simulated log odds
Effects are blue and no effects are red. Rows denote the observed E-genes and columns the samples annoted by P-genes. Each P-gene has been perturbed in many cells. The E-genes are annotated as how they are attached in the ground truth. E.g. E-genes named ‘1’ are attached to S-gene ‘1’ in the ground truth.

The typical data input for NEM\(\pi\) consists of a data matrix with samples as columns and E-genes as rows. The columns are either labeled by their perturbed gene(s) or unlabeled (default: ""). After the data simulation all samples are labeled. We unlabel \(50\%\) of the sample and pretend we do not know, which P-gene has been perturbed.

lost <- sample(1:ncol(data), floor(ncol(data) * 0.5))
colnames(data)[lost] <- ""

3.2 Perturbation inference

We use NEM\(\pi\) and other methods to infer the perturbations. We use the area under the precision-recall curve as the two measures of accuracy. We also plot the NEM\(\pi\) result.

res <- nempi(data)
fit <- pifit(res, simmini, data)
print(fit$auc)
## [1] 0.7788576
ressvm <- classpi(data)
fit <- pifit(ressvm, simmini, data, propagate = FALSE)
print(fit$auc)
## [1] 0.7090377
resnn <- classpi(data, method = "nnet")
fit <- pifit(resnn, simmini, data, propagate = FALSE)
print(fit$auc)
## [1] 0.6273228
resrf <- classpi(data, method = "randomForest")
fit <- pifit(resrf, simmini, data, propagate = FALSE)
print(fit$auc)
## [1] 0.6987766
col <- rgb(seq(0, 1, length.out = 10), seq(1, 0, length.out = 10), seq(1, 0, length.out = 10))
plot(res, heatlist = list(col = "RdBu"), barlist = list(col = col))

Compared to support vector machines (svm), neural nets (nnet) and random forest (rf) class prediction, NEM\(\pi\) achieves a higher accuracy.

Note that NEM\(\pi\) is in general more powerful, if the P-genes are connected in a denser network. The other methods perform equally well for sparse or even disconnected network \(\phi\). However, they usually profit from combinatorial perturbations.

3.3 Prior matrix

Alternatively, we can also provide NEM\(\pi\) with a probabilistic perturbation matrix \(\Gamma\) as a prior. In the rows are the potentially perturbed genes and in the columns are the samples. The entries are between \(0\) and \(1\), with the sum of all entries of a sample summing to \(1\).

Gamma <- matrix(0, Pgenes, ncol(data))
rownames(Gamma) <- seq_len(Pgenes)
colnames(Gamma) <- colnames(data)
for (i in seq_len(Pgenes)) {
    Gamma[i, grep(paste0("^", i, "_|_", i, "$|_", i, "_|^", i, "$"), colnames(data))] <- 1
}
Gamma <- apply(Gamma, 2, function(x) return(x/sum(x)))
Gamma[is.na(Gamma)] <- 0

epiNEM::HeatmapOP(Gamma, col = "RdBu", cexRow = 0.75, cexCol = 0.75, bordercol = "transparent",
    xrot = 0, dendrogram = "both")
Heatmap of the probabilsitic perturbation matrix.

Figure 2: Heatmap of the probabilsitic perturbation matrix

colnames(data) <- sample(seq_len(Pgenes), ncol(data), replace = TRUE)
res <- nempi(data, Gamma = Gamma)

fit <- pifit(res, simmini, data)
print(fit$auc)
## [1] 0.7788576

3.4 Final perturbation matrix

The final perturbation matrix \(\Omega\) over all samples is slightly different from the matrix \(\Gamma\) we used as input. \(\Gamma\) only denotes the most upstream P-gene perturbed. E.g., if A is upstream of B, than \(\Gamma\) only denotes a perturbation of A, even though B is also perturbed in every samples in which A is perturbed. We can compute it by the matrix multiplication \(\Omega = \phi^T \times \Gamma\).

Omega <- t(mnem::transitive.closure(res$res$adj)) %*% res$Gamma
epiNEM::HeatmapOP(Omega, col = "RdBu", cexRow = 0.75, cexCol = 0.75, bordercol = "transparent",
    xrot = 0, dendrogram = "both")

4 Session information

sessionInfo()
## R version 4.3.1 (2023-06-16)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.18-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.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] stats     graphics  grDevices utils     datasets  methods   base     
## 
## other attached packages:
## [1] nempi_1.10.0     mnem_1.18.0      BiocStyle_2.30.0
## 
## loaded via a namespace (and not attached):
##   [1] snowfall_1.84-6.2        RBGL_1.78.0              deldir_1.0-9            
##   [4] formatR_1.14             permute_0.9-7            rlang_1.1.1             
##   [7] magrittr_2.0.3           clue_0.3-65              flexclust_1.4-1         
##  [10] minet_3.60.0             matrixStats_1.0.0        e1071_1.7-13            
##  [13] compiler_4.3.1           mgcv_1.9-0               flexmix_2.3-19          
##  [16] gdata_3.0.0              png_0.1-8                vctrs_0.6.4             
##  [19] stringr_1.5.0            pkgconfig_2.0.3          fastmap_1.1.1           
##  [22] magick_2.8.1             utf8_1.2.4               rmarkdown_2.25          
##  [25] graph_1.80.0             xfun_0.40                modeltools_0.2-23       
##  [28] randomForest_4.7-1.1     cachem_1.0.8             epiNEM_1.26.0           
##  [31] jsonlite_1.8.7           fpc_2.2-10               jpeg_0.1-10             
##  [34] gmodels_2.18.1.1         parallel_4.3.1           prabclus_2.3-3          
##  [37] cluster_2.1.4            R6_2.5.1                 stringi_1.7.12          
##  [40] bslib_0.5.1              RColorBrewer_1.1-3       limma_3.58.0            
##  [43] jquerylib_0.1.4          diptest_0.76-0           Rcpp_1.0.11             
##  [46] bookdown_0.36            knitr_1.44               zoo_1.8-12              
##  [49] snow_0.4-4               ggm_2.5                  BoolNet_2.1.9           
##  [52] Matrix_1.6-1.1           splines_4.3.1            nnet_7.3-19             
##  [55] igraph_1.5.1             tidyselect_1.2.0         abind_1.4-5             
##  [58] yaml_2.3.7               vegan_2.6-4              lattice_0.22-5          
##  [61] tibble_3.2.1             evaluate_0.22            Rtsne_0.16              
##  [64] tsne_0.1-3.1             proxy_0.4-27             RcppEigen_0.3.3.9.3     
##  [67] mclust_6.0.0             kernlab_0.9-32           pillar_1.9.0            
##  [70] BiocManager_1.30.22      stats4_4.3.1             ellipse_0.5.0           
##  [73] generics_0.1.3           ggplot2_3.4.4            fastICA_1.2-3           
##  [76] munsell_0.5.0            scales_1.2.1             RcppArmadillo_0.12.6.4.0
##  [79] gtools_3.9.4             class_7.3-22             apcluster_1.4.11        
##  [82] glue_1.6.2               Linnorm_2.26.0           tools_4.3.1             
##  [85] interp_1.1-4             robustbase_0.99-0        data.table_1.14.8       
##  [88] XML_3.99-0.14            fastcluster_1.2.3        grid_4.3.1              
##  [91] amap_0.8-19              bdsmatrix_1.3-6          wesanderson_0.3.6       
##  [94] latticeExtra_0.6-30      naturalsort_0.1.3        colorspace_2.1-0        
##  [97] sfsmisc_1.1-16           nlme_3.1-163             pcalg_2.7-9             
## [100] latex2exp_0.9.6          cli_3.6.1                fansi_1.0.5             
## [103] ggdendro_0.1.23          dplyr_1.1.3              corpcor_1.6.10          
## [106] Rgraphviz_2.46.0         gtable_0.3.4             DEoptimR_1.1-3          
## [109] sass_0.4.7               digest_0.6.33            BiocGenerics_0.48.0     
## [112] htmltools_0.5.6.1        lifecycle_1.0.3          statmod_1.5.0           
## [115] MASS_7.3-60

5 References:

Appendix

Markowetz, F., Bloch, J., and Spang, R. (2005). Non-transcriptional pathway features reconstructed from secondary effects of rna interference. Bioinformatics, 21(21), 4026–4032.

Markowetz, F., Kostka, D., Troyanskaya, O. G., and Spang, R. (2007). Nested effects models for high-dimensional phenotyping screens. Bioinformatics, 23(13), i305–i312.

Pirkl, M., Beerenwinkel, N.; Single cell network analysis with a mixture of Nested Effects Models, Bioinformatics, Volume 34, Issue 17, 1 September 2018, Pages i964–i971, https://doi.org/10.1093/bioinformatics/bty602.

Ritchie ME, Phipson B, Wu D, Hu Y, Law CW, Shi W, Smyth GK (2015). “limma powers differential expression analyses for RNA-sequencing and microarray studies.” Nucleic Acids Research, 43(7), e47.