Contents

1 Overview

One cause of diseases like cancer is the dysregulation of signalling pathways. The interaction of two or more genes is changed and cell behaviour is changed in the malignant tissue.

The estimation of causal effects from observational data has previously been used to elucidate gene interactions. We extend this notion to compute Differential Causal Effects (DCE). We compare the causal effects between two conditions, such as a malignant tissue (e.g., from a tumor) and a healthy tissue to detect differences in the gene interactions.

However, computing causal effects solely from given observations is difficult, because it requires reconstructing the gene network beforehand. To overcome this issue, we use prior knowledge from literature. This largely improves performance and makes the estimation of DCEs more accurate.

Overall, we can detect pathways which play a prominent role in tumorigenesis. We can even pinpoint specific interaction in the pathway that make a large contribution to the rise of the disease.

You can learn more about the theory in our publication.

2 Installation

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

3 Load required packages

Load dce package and other required libraries.

# fix "object 'guide_edge_colourbar' of mode 'function' was not found"
# when building vignettes
# (see also https://github.com/thomasp85/ggraph/issues/75)
library(ggraph)

library(curatedTCGAData)
library(TCGAutils)
library(SummarizedExperiment)

library(tidyverse)
library(cowplot)
library(graph)
library(dce)

set.seed(42)

4 Introductory example

To demonstrate the basic idea of Differential Causal Effects (DCEs), we first artificially create a wild-type network by setting up its adjacency matrix. The specified edge weights describe the direct causal effects and total causal effects are defined accordingly (Pearl 2010). In this way, the detected dysregulations are endowed with a causal interpretation and spurious correlations are ignored. This can be achieved by using valid adjustment sets, assuming that the underlying network indeed models causal relationships accurately. In a biological setting, these networks correspond, for example, to a KEGG pathway (Kanehisa et al. 2004) in a healthy cell. Here, the edge weights correspond to proteins facilitating or inhibiting each others expression levels.

graph_wt <- matrix(c(0, 0, 0, 1, 0, 0, 1, 1, 0), 3, 3)
rownames(graph_wt) <- colnames(graph_wt) <- c("A", "B", "C")
graph_wt
##   A B C
## A 0 1 1
## B 0 0 1
## C 0 0 0

In case of a disease, these pathways can become dysregulated. This can be expressed by a change in edge weights.

graph_mt <- graph_wt
graph_mt["A", "B"] <- 2.5 # dysregulation happens here!
graph_mt
##   A   B C
## A 0 2.5 1
## B 0 0.0 1
## C 0 0.0 0
cowplot::plot_grid(
  plot_network(graph_wt, edgescale_limits = c(-3, 3)),
  plot_network(graph_mt, edgescale_limits = c(-3, 3)),
  labels = c("WT", "MT")
)

By computing the counts based on the edge weights (root nodes are randomly initialized), we can generate synthetic expression data for each node in both networks. Both X_wt and X_mt then induce causal effects as defined in their respective adjacency matrices.

X_wt <- simulate_data(graph_wt)
X_mt <- simulate_data(graph_mt)

X_wt %>%
  head
##         A   B    C
## [1,] 1117 398  802
## [2,]  964 244  501
## [3,]  963 246  469
## [4,] 1204 502 1032
## [5,]  848 125  251
## [6,] 1163 455  885

Given the network topology (without edge weights!) and expression data from both WT and MT conditions, we can estimate the difference in causal effects for each edge between the two conditions. These are the aforementioned Differential Causal Effects (DCEs).

res <- dce(graph_wt, X_wt, X_mt)

res %>%
  as.data.frame %>%
  drop_na
##   source target       dce dce_stderr    dce_pvalue
## 1      A      B 1.5443343 0.03062434 3.373144e-114
## 2      A      C 1.5234426 0.04449333  1.207257e-84
## 3      B      C 0.1152442 0.17882577  5.200452e-01

Visualizing the result shows that we can recover the dysregulation of the edge from A to B. Note that since we are computing total causal effects, the causal effect of A on C has changed as well.

plot(res) +
  ggtitle("Differential Causal Effects between WT and MT condition")

5 DCE reconstruction with non-trivial network

To get a better feeling for the behavior of dce, we will look at DCE estimates for a larger pathway. In particular, we create a \(20\) node wild-type (WT) network with edge probability \(0.3\) as well as a dysregulated mutated (MT) network.

set.seed(1337)

# create wild-type and mutant networks
graph_wt <- create_random_DAG(20, 0.3)
graph_mt <- resample_edge_weights(graph_wt)

cowplot::plot_grid(
  plot_network(as(graph_wt, "matrix"), labelsize = 0, arrow_size = 0.01),
  plot_network(as(graph_mt, "matrix"), labelsize = 0, arrow_size = 0.01),
  labels = c("WT", "MT")
)

Next, we simulate gene expression data and compute DCEs.

# simulate gene expression data for both networks
X_wt <- simulate_data(graph_wt)
X_mt <- simulate_data(graph_mt)

# compute DCEs
res <- dce::dce(graph_wt, X_wt, X_mt)

df_dce <- res %>%
  as.data.frame %>%
  drop_na %>%
  arrange(dce_pvalue)

Finally, we compare the estimated to the ground truth DCEs.

# compute ground truth DCEs
dce_gt <- trueEffects(graph_mt) - trueEffects(graph_wt)
dce_gt_ind <- which(dce_gt != 0, arr.ind = TRUE)

# create plot
data.frame(
  source = paste0("n", dce_gt_ind[, "row"]),
  target = paste0("n", dce_gt_ind[, "col"]),
  dce_ground_truth = dce_gt[dce_gt != 0]
) %>%
  inner_join(df_dce, by = c("source", "target")) %>%
  rename(dce_estimate = dce) %>%
ggplot(aes(x = dce_ground_truth, y = dce_estimate)) +
  geom_abline(color = "gray") +
  geom_point() +
  xlab("DCE (ground truth") +
  ylab("DCE (estimate)") +
  theme_minimal()

We observe that dce is able to nicely recover DCEs of moderate as well as large and small magnitude.

6 Application to real data

Pathway dysregulations are a common cancer hallmark (Hanahan and Weinberg 2011). It is thus of interest to investigate how the causal effect magnitudes in relevant pathways vary between normal and tumor samples.

6.1 Retrieve gene expression data

As a showcase, we download breast cancer (BRCA) RNA transcriptomics profiling data from TCGA (Tomczak, Czerwińska, and Wiznerowicz 2015).

brca <- curatedTCGAData(
  diseaseCode = "BRCA",
  assays = c("RNASeq2*"),
  version = "2.0.1",
  dry.run = FALSE
)
## Working on: BRCA_RNASeq2Gene-20160128
## see ?curatedTCGAData and browseVignettes('curatedTCGAData') for documentation
## loading from cache
## Working on: BRCA_RNASeq2GeneNorm-20160128
## see ?curatedTCGAData and browseVignettes('curatedTCGAData') for documentation
## loading from cache
## Working on: BRCA_colData-20160128
## see ?curatedTCGAData and browseVignettes('curatedTCGAData') for documentation
## loading from cache
## Working on: BRCA_metadata-20160128
## see ?curatedTCGAData and browseVignettes('curatedTCGAData') for documentation
## loading from cache
## Working on: BRCA_sampleMap-20160128
## see ?curatedTCGAData and browseVignettes('curatedTCGAData') for documentation
## loading from cache
## harmonizing input:
##   removing 13161 sampleMap rows not in names(experiments)
##   removing 5 colData rownames not in sampleMap 'primary'

This will retrieve all available samples for the requested data sets. These samples can be classified according to their site of origin.

sampleTables(brca)
## $`BRCA_RNASeq2Gene-20160128`
## 
##   01   06   11 
## 1093    7  112 
## 
## $`BRCA_RNASeq2GeneNorm-20160128`
## 
##   01   06   11 
## 1093    7  112
data(sampleTypes, package = "TCGAutils")
sampleTypes %>%
  dplyr::filter(Code %in% c("01", "06", "11"))
##   Code          Definition Short.Letter.Code
## 1   01 Primary Solid Tumor                TP
## 2   06          Metastatic                TM
## 3   11 Solid Tissue Normal                NT

We can extract Primary Solid Tumor and matched Solid Tissue Normal samples.

# split assays
brca_split <- TCGAsplitAssays(brca, c("01", "11"))

# only retain matching samples
brca_matched <- as(brca_split, "MatchedAssayExperiment")

brca_wt <- assay(brca_matched, "01_BRCA_RNASeq2GeneNorm-20160128")
brca_mt <- assay(brca_matched, "11_BRCA_RNASeq2GeneNorm-20160128")

6.2 Retrieve biological pathway of interest

KEGG (Kanehisa et al. 2004) provides the breast cancer related pathway hsa05224. It can be easily retrieved using dce.

pathways <- get_pathways(pathway_list = list(kegg = c("Breast cancer")))
brca_pathway <- pathways[[1]]$graph

Luckily, it shares all genes with the cancer data set.

shared_genes <- intersect(nodes(brca_pathway), rownames(brca_wt))
glue::glue(
  "Covered nodes: {length(shared_genes)}/{length(nodes(brca_pathway))}"
)
## Covered nodes: 145/145

6.3 Estimate Differential Causal Effects

We can now estimate the differences in causal effects between matched tumor and normal samples on a breast cancer specific pathway.

res <- dce::dce(brca_pathway, t(brca_wt), t(brca_mt))

Interpretations may now begin.

res %>%
  as.data.frame %>%
  drop_na %>%
  arrange(desc(abs(dce))) %>%
  head
##   source target        dce dce_stderr   dce_pvalue
## 1  WNT8A   FZD4 -4342.2001  2876.9003 1.326486e-01
## 2   FGF3  FGFR1 -1553.3334  1322.3358 2.413890e-01
## 3  WNT8B   FZD4 -1540.1078   235.1719 4.038543e-10
## 4  WNT7A   FZD4 -1334.3963   598.5797 2.680676e-02
## 5  FGF21  FGFR1  -917.1445  1128.4631 4.172471e-01
## 6  WNT8A   FZD7   817.6733   954.3545 3.924979e-01
plot(
  res,
  nodesize = 20, labelsize = 1,
  node_border_size = 0.05, arrow_size = 0.01,
  use_symlog = TRUE,
  shadowtext = TRUE
)

7 Latent Confounding Adjustment

We illustrate here how dce can help to adjust for some special types of unobserved confounding, such as batch effects. One needs a relatively large data set in order to detect confounding well.

We first generate the unconfounded data:

set.seed(1)
epsilon <- 1e-100
network_size <- 50
graph_wt <- as(create_random_DAG(network_size, prob = .2), "matrix")
graph_wt["n1", "n2"] <- epsilon
graph_mt <- graph_wt
graph_mt["n1", "n2"] <- 2

cowplot::plot_grid(
  plot_network(graph_wt, edgescale_limits = c(-2, 2)),
  plot_network(graph_mt, edgescale_limits = c(-2, 2)),
  labels = c("WT", "MT")
)

truth <- trueEffects(graph_mt) - trueEffects(graph_wt)
plot_network(graph_wt, value_matrix = truth, edgescale_limits = c(-2, 2))

X_wt <- simulate_data(n = 100, graph_wt)
X_mt <- simulate_data(n = 100, graph_mt)

For the unconfounded data dce estimates the differential causal effects well:

res <- dce(graph_mt, X_wt, X_mt, deconfounding = FALSE)

qplot(truth[truth != 0], res$dce[truth != 0]) +
  geom_abline(color = "red", linetype = "dashed") +
  xlab("true DCE") +
  ylab("estimated DCE")
## Warning: `qplot()` was deprecated in ggplot2 3.4.0.
## This warning is displayed once every 8 hours.
## Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
## generated.
## Warning: Removed 34 rows containing missing values (`geom_point()`).

plot_network(graph_wt, value_matrix = -log(res$dce_pvalue)) +
  ggtitle("-log(p-values) for DCEs between WT and MT condition")

On the other hand, if our data come from two different batches, where the gene expression of each gene is shifted by some amount depending on the batch, then dce will have many false positive findings:

batch <- sample(c(0, 1), replace = TRUE, nrow(X_wt))
bX_wt <- apply(X_wt, 2, function(x) x + max(x) * runif(1) * batch)
bX_mt <- apply(X_mt, 2, function(x) x + max(x) * runif(1) * batch)

res_without_deconf <- dce(graph_mt, bX_wt, bX_mt, deconfounding = FALSE)

cowplot::plot_grid(
  plot_network(
    graph_wt,
    value_matrix = -log(res_without_deconf$dce_pvalue + epsilon)
  ) +
    ggtitle("-log(p-values) without deconfounding"),
  qplot(truth[truth != 0], res_without_deconf$dce[truth != 0]) +
    geom_abline(color = "red", linetype = "dashed") +
    xlab("true DCE") +
    ylab("estimated DCE"),
  nrow = 1
)
## Warning: Removed 34 rows containing missing values (`geom_point()`).

However, the performance is improved when the confounding adjustment is used:

res_with_deconf <- dce(graph_mt, bX_wt, bX_mt, deconfounding = 1)

cowplot::plot_grid(
  plot_network(
    graph_wt,
    value_matrix = -log(res_with_deconf$dce_pvalue + epsilon)
  ) +
    ggtitle("-log(p-values) with deconfounding"),
  qplot(truth[truth != 0], res_with_deconf$dce[truth != 0]) +
    geom_abline(color = "red", linetype = "dashed") +
    xlab("true DCE") +
    ylab("estimated DCE"),
  nrow = 1
)
## Warning: Removed 34 rows containing missing values (`geom_point()`).

8 Session information

sessionInfo()
## R Under development (unstable) (2023-10-22 r85388)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.19-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] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] dce_1.11.0                  graph_1.81.0               
##  [3] cowplot_1.1.1               lubridate_1.9.3            
##  [5] forcats_1.0.0               stringr_1.5.0              
##  [7] dplyr_1.1.3                 purrr_1.0.2                
##  [9] readr_2.1.4                 tidyr_1.3.0                
## [11] tibble_3.2.1                tidyverse_2.0.0            
## [13] TCGAutils_1.23.0            curatedTCGAData_1.23.7     
## [15] MultiAssayExperiment_1.29.0 SummarizedExperiment_1.33.0
## [17] Biobase_2.63.0              GenomicRanges_1.55.0       
## [19] GenomeInfoDb_1.39.0         IRanges_2.37.0             
## [21] S4Vectors_0.41.0            BiocGenerics_0.49.0        
## [23] MatrixGenerics_1.15.0       matrixStats_1.0.0          
## [25] ggraph_2.1.0                ggplot2_3.4.4              
## [27] BiocStyle_2.31.0           
## 
## loaded via a namespace (and not attached):
##   [1] bitops_1.0-7                  httr_1.4.7                   
##   [3] GenomicDataCommons_1.27.0     prabclus_2.3-3               
##   [5] Rgraphviz_2.47.0              numDeriv_2016.8-1.1          
##   [7] tools_4.4.0                   utf8_1.2.4                   
##   [9] R6_2.5.1                      vegan_2.6-4                  
##  [11] mgcv_1.9-0                    sn_2.1.1                     
##  [13] permute_0.9-7                 withr_2.5.1                  
##  [15] graphite_1.49.0               prettyunits_1.2.0            
##  [17] gridExtra_2.3                 flexclust_1.4-1              
##  [19] cli_3.6.1                     sandwich_3.0-2               
##  [21] labeling_0.4.3                sass_0.4.7                   
##  [23] diptest_0.76-0                mvtnorm_1.2-3                
##  [25] robustbase_0.99-0             proxy_0.4-27                 
##  [27] Rsamtools_2.19.0              FMStable_0.1-4               
##  [29] Linnorm_2.27.0                plotrix_3.8-2                
##  [31] limma_3.59.0                  RSQLite_2.3.1                
##  [33] generics_0.1.3                BiocIO_1.13.0                
##  [35] gtools_3.9.4                  wesanderson_0.3.6            
##  [37] Matrix_1.6-1.1                fansi_1.0.5                  
##  [39] logger_0.2.2                  abind_1.4-5                  
##  [41] lifecycle_1.0.3               multcomp_1.4-25              
##  [43] yaml_2.3.7                    edgeR_4.1.0                  
##  [45] mathjaxr_1.6-0                SparseArray_1.3.0            
##  [47] BiocFileCache_2.11.0          Rtsne_0.16                   
##  [49] grid_4.4.0                    blob_1.2.4                   
##  [51] promises_1.2.1                gdata_3.0.0                  
##  [53] ppcor_1.1                     bdsmatrix_1.3-6              
##  [55] ExperimentHub_2.11.0          crayon_1.5.2                 
##  [57] lattice_0.22-5                GenomicFeatures_1.55.0       
##  [59] KEGGREST_1.43.0               magick_2.8.1                 
##  [61] pillar_1.9.0                  knitr_1.44                   
##  [63] rjson_0.2.21                  fpc_2.2-10                   
##  [65] corpcor_1.6.10                codetools_0.2-19             
##  [67] mutoss_0.1-13                 glue_1.6.2                   
##  [69] RcppArmadillo_0.12.6.4.0      data.table_1.14.8            
##  [71] vctrs_0.6.4                   png_0.1-8                    
##  [73] Rdpack_2.5                    mnem_1.19.0                  
##  [75] gtable_0.3.4                  kernlab_0.9-32               
##  [77] assertthat_0.2.1              amap_0.8-19                  
##  [79] cachem_1.0.8                  xfun_0.40                    
##  [81] rbibutils_2.2.16              S4Arrays_1.3.0               
##  [83] mime_0.12                     RcppEigen_0.3.3.9.3          
##  [85] tidygraph_1.2.3               survival_3.5-7               
##  [87] fastICA_1.2-3                 statmod_1.5.0                
##  [89] interactiveDisplayBase_1.41.0 ellipsis_0.3.2               
##  [91] TH.data_1.1-2                 tsne_0.1-3.1                 
##  [93] nlme_3.1-163                  naturalsort_0.1.3            
##  [95] bit64_4.0.5                   progress_1.2.2               
##  [97] gmodels_2.18.1.1              filelock_1.0.2               
##  [99] bslib_0.5.1                   colorspace_2.1-0             
## [101] DBI_1.1.3                     nnet_7.3-19                  
## [103] mnormt_2.1.1                  tidyselect_1.2.0             
## [105] bit_4.0.5                     compiler_4.4.0               
## [107] curl_5.1.0                    rvest_1.0.3                  
## [109] expm_0.999-7                  xml2_1.3.5                   
## [111] TFisher_0.2.0                 ggdendro_0.1.23              
## [113] DelayedArray_0.29.0           shadowtext_0.1.2             
## [115] bookdown_0.36                 rtracklayer_1.63.0           
## [117] harmonicmeanp_3.0             sfsmisc_1.1-16               
## [119] scales_1.2.1                  DEoptimR_1.1-3               
## [121] RBGL_1.79.0                   rappdirs_0.3.3               
## [123] snowfall_1.84-6.2             apcluster_1.4.11             
## [125] digest_0.6.33                 rmarkdown_2.25               
## [127] XVector_0.43.0                htmltools_0.5.6.1            
## [129] pkgconfig_2.0.3               dbplyr_2.3.4                 
## [131] fastmap_1.1.1                 rlang_1.1.1                  
## [133] shiny_1.7.5.1                 farver_2.1.1                 
## [135] jquerylib_0.1.4               zoo_1.8-12                   
## [137] jsonlite_1.8.7                BiocParallel_1.37.0          
## [139] mclust_6.0.0                  RCurl_1.98-1.12              
## [141] magrittr_2.0.3                modeltools_0.2-23            
## [143] GenomeInfoDbData_1.2.11       munsell_0.5.0                
## [145] Rcpp_1.0.11                   viridis_0.6.4                
## [147] stringi_1.7.12                zlibbioc_1.49.0              
## [149] MASS_7.3-60.1                 plyr_1.8.9                   
## [151] AnnotationHub_3.11.0          org.Hs.eg.db_3.18.0          
## [153] flexmix_2.3-19                parallel_4.4.0               
## [155] ggrepel_0.9.4                 Biostrings_2.71.1            
## [157] graphlayouts_1.0.1            splines_4.4.0                
## [159] multtest_2.59.0               hms_1.1.3                    
## [161] locfit_1.5-9.8                qqconf_1.3.2                 
## [163] fastcluster_1.2.3             igraph_1.5.1                 
## [165] reshape2_1.4.4                biomaRt_2.59.0               
## [167] BiocVersion_3.19.0            XML_3.99-0.14                
## [169] evaluate_0.22                 metap_1.9                    
## [171] pcalg_2.7-9                   BiocManager_1.30.22          
## [173] tzdb_0.4.0                    tweenr_2.0.2                 
## [175] httpuv_1.6.12                 polyclip_1.10-6              
## [177] clue_0.3-65                   BiocBaseUtils_1.5.0          
## [179] ggforce_0.4.1                 xtable_1.8-4                 
## [181] restfulr_0.0.15               e1071_1.7-13                 
## [183] later_1.3.1                   viridisLite_0.4.2            
## [185] class_7.3-22                  snow_0.4-4                   
## [187] ggm_2.5                       ellipse_0.5.0                
## [189] memoise_2.0.1                 AnnotationDbi_1.65.0         
## [191] GenomicAlignments_1.39.0      cluster_2.1.4                
## [193] timechange_0.2.0

References

Hanahan, Douglas, and Robert A Weinberg. 2011. “Hallmarks of Cancer: The Next Generation.” Cell 144 (5): 646–74.

Kanehisa, Minoru, Susumu Goto, Shuichi Kawashima, Yasushi Okuno, and Masahiro Hattori. 2004. “The Kegg Resource for Deciphering the Genome.” Nucleic Acids Research 32 (suppl_1): D277–D280.

Pearl, Judea. 2010. “Causal Inference.” Causality: Objectives and Assessment, 39–58.

Tomczak, Katarzyna, Patrycja Czerwińska, and Maciej Wiznerowicz. 2015. “The Cancer Genome Atlas (Tcga): An Immeasurable Source of Knowledge.” Contemporary Oncology 19 (1A): A68.