Sparse Partial correlation ON Gene Expression with SPONGE

Markus List, Azim Dehghani Amirabad, Dennis Kostka, Marcel H. Schulz

2020-04-27

Purpose

SPONGE logo

SPONGE is the first method to solve the computationally demanding task of reporting significant ceRNA interactions efficiently on a genome-wide scale. Beyond ceRNAs, this method is well suited to infer other types of regulatory interactions such as transcription factor regulation.

Introduction

MicroRNAs (miRNAs) are small 19-22 nucleotide long molecules that facilitate the degradation of messenger RNA (mRNA) transcripts targeted via matching seed sequences. The competing endogenous RNA (ceRNA) hypothesis suggests that mRNAs that possess binding sites for the same miRNAs are in competition. This motivates the existence of so-called sponges, i.e., genes that exert strong regulatory control via miRNA binding in a ceRNA interaction network. It is currently an unsolved problem how to estimate miRNA-mediated ceRNA interactions genome-wide. The most widely used approach considers miRNA and mRNA expression jointly measured for the same cell state. Several partial association methods have been proposed for determining ceRNA interaction strength using conditional mutual information or partial correlation, for instance.

However, we identified three key limitations of existing approaches that prevent the construction of an accurate genome-wide ceRNA interaction network: (i) none of the existing methods considers the combinatorial effect of several miRNAs; (ii) due to the computational demand, the inference of a ceRNA interaction for all putative gene-miRNA-gene interactions in the human genome is prohibitive; (iii) an efficient strategy for determining the significance of inferred ceRNA interactions is missing, and thus important parameters of the system are neglected.

To overcome these challenges, we developed a novel method called Sparse partial correlation on gene expression (SPONGE). We reduce the computational complexity of constructing a genome-wide ceRNA interaction network in several steps. First, we consider only miRNA-gene interactions that are either predicted or experimentally validated. Second, we retain only miRNA-gene interactions that have a negative coefficient in a regularized regression model. Third, instead of each gene-miRNA-gene triplet, we compute a single sensitivity correlation (correlation - partial correlation) for each gene-gene pair given all shared miRNAs that pass the above filter as putative regulators. Finally, we derived the first mathematical formulation to simulate the null distribution of the process for different parameters of the system: number of miRNAs, correlation between genes and sample number. Our formulation enables the computation of empirical p-values for the statistic in a very efficient manner, an order of magnitude faster than previous methods. Analyses revealed that previous studies have underestimated the effect of these parameters in their network inference. Network centrality measures can be applied to SPONGE inferred ceRNA networks to reveal known and novel sponges, many of which are potential biomarkers.

Further details demonstrating how SPONGE improves over the state of the art and how SPONGE inferred ceRNA networks can be used for biomarker discovery will be available in our paper (manuscript submitted, link will be included here at a later point).

General Workflow

SPONGE workflow

Overview of the SPONGE workflow. (A) Predicted and/or experimentally validated gene-miRNA interactions are subjected to regularized regression on gene and miRNA expression data. Interactions with negative coefficients for miRNA regulators are retained since they indicate miRNA induced inhibition of gene expression. (B) We compute sensitivity correlation coefficients for gene pairs based on shared miRNAs identified in (A). (C) Given the sample number, we compute empirical null models for various gene-gene correlation coefficients (k, columns) and number of miRNAs (m, rows). Sensitivity correlation coefficients are assigned to the best matching null model and a p-value is inferred. (D) After multiple testing correction, significant ceRNA interactions can be used to construct a genome-wide, disease or tissue-specific ceRNA interaction network. In the following hands-on tutorial, we will highlight how each of these steps can be achieved with the SPONGE R package.

(A) gene-miRNA interactions

We start with loading the package and its dependencies

library(SPONGE)

SPONGE comes with a very small example gene and miRNA expression dataset useful for illustrating functionality. We suggest obtaining larger expression data sets via the GEOquery or TCGAbiolinks R packages, for instance. After loading the package, the example datasets can be accessed:

Gene expression:

head(gene_expr)
UST FBXO32 TMEM132A CTTNBP2 MITF RANBP3L DNMT3A NTN4
TCGA-CC-A7IH 9.763889 8.664702 8.143475 2.004897 5.449300 5.7478519 9.482231 8.355215
TCGA-DD-A3A9 4.186326 5.754722 9.618885 2.150949 5.330171 0.7554858 9.985951 6.665077
TCGA-CC-A5UE 2.394404 5.514267 5.041414 1.045723 5.688147 3.1671973 9.742771 8.601548
TCGA-BC-A3KF 3.378858 5.423568 7.644005 7.085019 5.983949 1.1212144 8.863079 8.595803
TCGA-DD-A3A6 8.016376 10.199888 9.349632 3.828246 8.824847 5.0691178 7.681065 8.423871

miRNA expression:

head(mir_expr)
MIMAT0000070 MIMAT0000680 MIMAT0000222 MIMAT0000460 MIMAT0000243
TCGA-CC-A7IH 8.110843 7.637696 14.397147 13.337312 17.77343
TCGA-DD-A3A9 9.425956 7.141432 14.627978 13.753494 13.84755
TCGA-CC-A5UE 10.017687 8.191404 16.030031 14.579990 16.12510
TCGA-BC-A3KF 11.260798 7.721752 17.036269 15.497766 16.15116
TCGA-DD-A3A6 7.717456 7.700341 7.605197 7.191296 13.79406

Note that the expected format for both expression matrices is that columns correspond to genes / miRNAs and rows correspond to samples. Please make sure that samples are ordered identically in both matrices and that each sample has an entry in both matrices (paired gene and miRNA expression data).

SPONGE uses a two-tier filtering approach to identify gene-miRNA interactions.

First, the user may incorporate prior knowledge to narrow down the number of gene-miRNA interactions. This could be, for instance, the output of a sequence-based miRNA target prediction software such as TargetScan or miRcode or experimental evidence obtained from databases such as miRTarBase or LncBase. The user is free to use his or her trusted resource(s) and only needs to make sure that the miRNA-gene interactions are formatted as SPONGE expects it:

SPONGE allows for an arbitrary number of miRNA-gene interaction matrices \(I\) that need to be formatted with genes \(G\) in rows and miRNAs \(M\) in columns. For each element \(i_{g, m} \in I\), we consider the miRNA-gene interaction if \(i_{g, m} > 0\). While SPONGE only checks if an entry is zero or not, this approach allows for additional information such as the respective number of binding sites or a score to be encoded in the matrix for later analysis. We included examples for TargetScan:

head(targetscan_symbol)
MIMAT0000062 MIMAT0000063 MIMAT0000064 MIMAT0000065 MIMAT0000066
A1BG 0 0 0 0 0
A1CF 1 1 1 1 1
A4GNT 0 0 0 0 0
AACS 0 0 0 0 0
AAED1 0 0 0 0 0

Note that the gene and miRNA identifiers in the interaction matrices need to be of the same type and format as the ones used in the expression matrices. Otherwise they can not be matched by SPONGE.

SPONGE combines user-provided matrices as the ones shown above by summing up their entries and subsequently identifies gene-miRNA interaction candidates with non-zero entries. In the second step, we use sparse regularized regression with the gene expression as dependent and miRNA expression as explanatory variables. More specifically, we use elasticnet (via the R package glmnet) to balance lasso and ridge regression. Lasso drives coefficients of miRNAs with negligible influence on gene expression to zero, while ridge regression prevents us from kicking out correlated miRNAs that have similar influence. Elasticnet has two parameters, \(\alpha\) is used to balance the influence of lasso and ridge regression. \(\lambda\) is the regularization parameter. We select the optimal parameters for elastic net as follows: For each \(\alpha = (0.1, 0.2, ..., 1.0)\) we perform 10x cross validation to obtain the optimal parameter \(\lambda\). The best \(\alpha\) is then selected such that the residual sum of squares error is minimal. We are only interested in miRNAs that repress gene expression. Hence, for each gene, we retain only those miRNAs as interaction partners that have a negative coefficient. Instead of checking if the coefficients are smaller than zero, SPONGE also allows for a more stringent threshold to be set. The default is -0.05. Alternatively, SPONGE offers the possibility to perform an F-test to identify important miRNAs. See documentation for details.

We apply step A of the SPONGE workflow as follows:

genes_miRNA_candidates <- sponge_gene_miRNA_interaction_filter(
gene_expr = gene_expr,
mir_expr = mir_expr,
mir_predicted_targets = targetscan_symbol)

The result is a list of genes, where each entry holds a data frame with retained miRNAs and their coefficients (or p-values in case the F-test is used). Note that the mir_predicted_targets parameter may also be NULL. In this case, no prior knowledge is used and all putative miRNA-gene interactions are used in elasticnet regression.

genes_miRNA_candidates[1:2]
## $ASAP2
##          mirna coefficient
## 1 MIMAT0000074  -0.2462659
## 
## $CBR4
## NULL

(B) ceRNA interactions

In the second step of the SPONGE workflow, we identify ceRNA actions candidates. SPONGE uses the information from (A) and checks for each pair of genes if they share one or more miRNAs with regulatory effect. This reduces the putative number of ceRNA interactions \(n\choose 2\) to consider dramatically. Next, SPONGE uses the ppcor R package to compute multiple miRNA sensitivity correlation () values. Note that this is a generalization of sensitivity correlation as defined by Paci et al.. These values capture the joint contribution of several miRNAs on the ceRNA regulation of two genes while accounting for their cross-correlation:

\[\begin{eqnarray}\label{formula_scor} mscor(g_1, g_2, M) & = & cor(g_1, g_2) - pcor(g_1, g_2 | M) \end{eqnarray}\]

where \(M = {m_1, ..., m_i}\) and \(i\) the number of shared miRNAs between \(g_1\) and \(g_2\).

We apply step B of the SPONGE workflow as follows:

ceRNA_interactions <- sponge(gene_expr = gene_expr,
                        mir_expr = mir_expr,
                        mir_interactions = genes_miRNA_candidates)

The result is a data table with both genes (A and B), the number of miRNAs (), gene-gene correlation (), partial correlation given all miRNAs () and the values, i.e. \(mscor = cor - pcor\):

head(ceRNA_interactions)
geneA geneB df cor pcor mscor
UST FBXO32 1 0.2529669 0.2550512 -0.0020843
FBXO32 CTTNBP2 1 0.3036081 0.2268930 0.0767151
FBXO32 MITF 3 0.1595507 0.0697054 0.0898452
CTTNBP2 MITF 1 0.3544184 0.3010409 0.0533775
TMEM132A DNMT3A 1 0.4417056 0.3851995 0.0565062
FBXO32 DCLK2 2 0.2046023 0.1147868 0.0898155

(C) Null-model-based p-value computation

A theory for the random distribution of values did not exist and previous studies using sensitivity correlation either used simple thresholds or random background distributions inferred from random triplets. Simulation experiments show that this approach does not account for the fact that the distribution of parameters is strongly affected by gene-gene correlation and the number of samples considred.

This motivated us to develop a strategy for inferring the distribution of values under the null hypothesis that miRNAs do not affect the correlation between two genes, i.e. \(mscor = 0\). At the basis of this is a method for sampling random covariance matrices under this null hypothesis in which we control i) the gene-gene correlation and ii) the number of miRNAs which corresponds to the number of columns in the covariance matrix. See [Computing additional covariance matrices] for details on how to construct these matrices. Since this sampling procedure is computationally intensive, we include pre-computed sets of covariance matrices for a range of parameter combinations, i.e. 10 covariance matrices for each pair of gene-gene correlation \(cor = (0.2, ..., 0.9)\) and number of miRNAs \(m = (1, 2,...,8)\). Using these covariance matrices and the package mvrnorm allows us to sample from the random distribution of values with respect to the available number of samples (the number of rows in our expression matrices):

mscor_null_model <- sponge_build_null_model(number_of_datasets = 100, number_of_samples = nrow(gene_expr))

We can plot the result of these simulations to see how the distribution is affected by gene-gene correlation and number of miRNAs (if ggplot2 is installed):

sponge_plot_simulation_results(mscor_null_model)

Obviously, this is a bit crude since we only samples 100 data points for each of the partitions to keep the compile time of the vignette in check. The default for the number of data sets to be sampled is muche more reasonable with a value of 1e6.

Using the above null models, SPONGE infers empirical p-values for each of the coefficients in step (B). This is achieved by first selecting the closest-matching null model, e.g. closest match for gene-gene correlation and number of miRNAs. Within this partition’s random distribution we now rank the value we computed. This rank can then be used to compute an empirical p-value. Note that the precision, i.e. the smallest p-value obtainable is limited by the number of data sets sampled. For example, sampling 100 data sets as we did here means the best p-value we can get is \(p = 0.01\). If we sample 1e6 data sets, the precision improves, with the best p-value being \(p = 1e-6\).

After computing p-values for all coefficients, we apply multiple testing correction for all values within a partition, accounting for the fact that null models with low gene-gene correlation will be frequented substantially more often than those with high gene-gene correlation. To infer p-values we do the following:

ceRNA_interactions_sign <- sponge_compute_p_values(sponge_result = ceRNA_interactions, 
                                                   null_model = mscor_null_model)

The above method adds two additional columns to the ceRNA results, namely \(p.val\) and \(p.adj\).

head(ceRNA_interactions_sign)
geneA geneB df cor pcor mscor p.val p.adj
FBXO32 SRGAP1 1 0.1223776 0.1237864 -0.0014088 0.52 0.5200000
SRGAP1 ESR1 1 0.1234821 -0.0011236 0.1246057 0.01 0.0300000
UST LIMCH1 1 0.1743921 0.1720018 0.0023903 0.37 0.5200000
UST FBXO32 1 0.2529669 0.2550512 -0.0020843 0.53 0.6183333
FBXO32 CTTNBP2 1 0.3036081 0.2268930 0.0767151 0.01 0.0350000
CTTNBP2 DCLK2 1 0.3186208 0.2666053 0.0520155 0.02 0.0350000

(D) ceRNA interaction network

The last step is fairly straight-forward. We decide on an FDR cutoff for selecting significant ceRNA interactions, e.g. FDR < 0.01 and extract those from the result.

ceRNA_interactions_fdr <- ceRNA_interactions_sign[which(ceRNA_interactions_sign$p.adj < 0.2),]
geneA geneB df cor pcor mscor p.val p.adj
2 SRGAP1 ESR1 1 0.1234821 -0.0011236 0.1246057 0.01 0.030
5 FBXO32 CTTNBP2 1 0.3036081 0.2268930 0.0767151 0.01 0.035
6 CTTNBP2 DCLK2 1 0.3186208 0.2666053 0.0520155 0.02 0.035
7 TMEM132A TET1 1 0.3128573 0.2308158 0.0820415 0.01 0.035
8 FBXO32 ASAP2 1 0.2666062 0.2118974 0.0547088 0.02 0.035
10 ASAP2 LIMCH1 1 0.2887748 0.2370206 0.0517542 0.03 0.042

The resulting network can also be plotted

sponge_plot_network(ceRNA_interactions_fdr, genes_miRNA_candidates)
## Loading required namespace: visNetwork

Network Analysis

The significant ceRNA interactions from above can be used to construct a ceRNA network in which genes (ceRNAs) are nodes and edges are drawn when a significant ceRNA interaction is predicted. SPONGE constructs such a network using the igraph R package and computed different network statistics for individual genes. Eigenvector and betweenness centrality can be used to assess the importance of a gene in the ceRNA network. In this example we only selected very few genes which makes this exercise a bit futile. However, if applied to larger gene sets, betweenness centrality reveals powerful ceRNAs that may pose biomarkers of miRNA regulation.

network_centralities <- sponge_node_centralities(ceRNA_interactions_fdr)

Note that additional information about the ceRNA effect strength can be incorporated via weighted eigenvector or betweeness centrality. In this case, we add a column weight to our results table as follows:

ceRNA_interactions_fdr_weight <- ceRNA_interactions_fdr
ceRNA_interactions_fdr_weight$weight <- -log10(ceRNA_interactions_fdr$p.adj)
weighted_network_centralities <- sponge_node_centralities(ceRNA_interactions_fdr)

We can also plot these results with a node degree distribution on top and centrality vs node degree below. The parameter top controls how many of the top x samples are labelled.

sponge_plot_network_centralities(weighted_network_centralities, top = 1)

You can also select individual plots

sponge_plot_network_centralities(weighted_network_centralities, measure = "btw", top = 1)

Parallelization and Shared Memory

Even though SPONGE is quite fast in inferring ceRNA interactions it will still take a few days to process a dataset with hundred of samples on a single CPU. We thus built SPONGE on top of the foreach R package:

The foreach R package will allow you to parallelize SPONGE over multiple CPUs. The beauty of this approach is that it is up to the user to decide which backend to use for this. We refer to the foreach package for details. One of the most used backends for foreach is the doParallel R package. Once a parallel compute environment is set up, SPONGE can use it automatically (no extra parameters needed):

library(doParallel)
library(foreach)

num.of.cores <- 2 #many more on a compute cluster

#if you want to use logging
#logging.file <- "where_my_log_file_should_go.log"
logging.file <- NULL

cl <- makeCluster(num.of.cores, outfile=logging.file) 
registerDoParallel(cl)

genes_miRNA_candidates <- sponge_gene_miRNA_interaction_filter(
gene_expr = gene_expr,
mir_expr = mir_expr,
mir_predicted_targets = targetscan_symbol)

ceRNA_interactions <- sponge(
gene_expr = gene_expr,
mir_expr = mir_expr,
mir_interactions = genes_miRNA_candidates)

stopCluster(cl) 

Note that if you would like to use the BiocParallel package you can simply register any parallel foreach backend such as the one used above as follows:

library("BiocParallel")
register(DoparParam(), default = TRUE)

A frequently encountered caveat of foreach is that each of the parallel workers will require a copy of the data its operating on. With large datasets this becomes an issue even on compute servers with large memory. We thus support the bigmemory R package to allow each parallel worker process / thread to access data in shared memory. To make use of the big memory package simply replace the gene_expr and mir_expr parameters with bigmemory description objects. We refer to the documentation of the bigmemory package for details. If you have access to a compute server with 40-60 cores, you can typically compute a genome-wide ceRNA network within a few hours.

Computing covariance matrices for the null model

SPONGE allows for sampling covariance matrices given a gene-gene correlation and a specific number of miRNAs. The package contains a number of precomputed matrices for various parameter combinations. However, it is also possibel to compute additional matrices:

more_covariance_matrices <- sample_zero_mscor_cov(m = 1, 
                      number_of_solutions = 10,
                      gene_gene_correlation = 0.5)

These can be used to simulate data to sample from the random distribution of coefficients given the number of samples available in the expression data.

mscor_coefficients <- sample_zero_mscor_data(cov_matrices = more_covariance_matrices,
number_of_samples = 200, number_of_datasets = 100)

hist(unlist(mscor_coefficients), main = "Random distribution of mscor coefficients")

Wider Application

SPONGE was primarily designed to infer ceRNA interactions efficiently. We point out, however, that the principle behind SPONGE for infering partial associations is applicable to other types of regulation in molecular biology. SPONGE is not limited to negative regulation as it is the case with miRNA regulation and can thus also be useful to study, for instance, RNA binding protein regulation or transcription factor regulation. Moreover, we could envision that this approach is also applicable outside of bioinformatics where partial association is of interest. To our knowledge, SPONGE presents the first method to sample random covariance matrices under the null hypothesis that partial correlation and correlation are equal, which may be useful as a starting point to gain a deeper understanding of the theoretical properties of partial correlations in the future.

Citation

List, M., Dehghani Amirabad, A., Kostka, D., & Schulz, M. H. (2019). Large-scale inference of competing endogenous RNA networks with sparse partial correlation. Bioinformatics, 35(14), i596-i604. doi:10.1093/bioinformatics/btz314