Skip to main content

Evaluation of network-guided random forest for disease gene discovery

Abstract

Background

Gene network information is believed to be beneficial for disease module and pathway identification, but has not been explicitly utilized in the standard random forest (RF) algorithm for gene expression data analysis. We investigate the performance of a network-guided RF where the network information is summarized into a sampling probability of predictor variables which is further used in the construction of the RF.

Results

Our simulation results suggest that network-guided RF does not provide better disease prediction than the standard RF. In terms of disease gene discovery, if disease genes form module(s), network-guided RF identifies them more accurately. In addition, when disease status is independent from genes in the given network, spurious gene selection results can occur when using network information, especially on hub genes. Our empirical analysis on two balanced microarray and RNA-Seq breast cancer datasets from The Cancer Genome Atlas (TCGA) for classification of progesterone receptor (PR) status also demonstrates that network-guided RF can identify genes from PGR-related pathways, which leads to a better connected module of identified genes.

Conclusions

Gene networks can provide additional information to aid the gene expression analysis for disease module and pathway identification. But they need to be used with caution and validation on the results need to be carried out to guard against spurious gene selection. More robust approaches to incorporate such information into RF construction also warrant further study.

Peer Review reports

Background

Gene expression analysis can quantify dynamic expression patterns under different biological conditions and thus help identify genes associated with complex diseases [1]. These biomarkers might improve patient risk prediction and can foster understanding of underlying molecular pathomechanisms. However, in the classic approach genes are often analyzed individually. Given the functional interdependencies between the molecular components, a complex disease such as cancer is rarely a consequence of an abnormality in a single gene [2, 3]. Therefore, it would be beneficial to incorporate molecular interactions into analysis, where the interactions can be summarized in the form of molecular networks [4]. Examples include protein-protein interaction (PPI) networks and gene regulatory networks where each node of these networks represents a gene and the edges between nodes reflect their interactions (see [3] for a review on different types of biological networks). In this regard, gene network information is believed to be beneficial for disease module and pathway identification where a disease module or pathway is expected to be a local cluster of highly connected genes within the network.

To identify disease associated genes, many statistical and machine learning approaches have been developed [1]. One popular machine learning method is the random forest (RF) algorithm [5]. It is a nonparametric approach that can accommodate different types of phenotypes including categorical or quantitative phenotypes and survival times [6]. Moreover, it can work with predictors of various scales or distributions and is suited for applications in high-dimensional settings such as transcriptomics data where the number of predictors can be larger than the number of observations [7, 8]. With the so-called variable importance measures, the algorithm can also highlight the relevance of each predictor to the prediction of phenotype [5]. This is especially handy for disease gene discovery where genes associated with disease phenotypes can be identified.

However, as with many other methods for transcriptome analysis, the standard RF algorithm only uses gene expression data for constructing the prediction model and identifying disease genes. The gene network information has not been explicitly utilized. Therefore, in this paper, we investigate a network-guided RF where the network information is summarized into a sampling probability of predictors which is further used in the construction of RF. This sampling probability can be considered as prior knowledge on the importance of each predictor on model construction. In the standard RF, this sampling probability of predictors is a uniform probability to reflect that we do not impose any prior knowledge on the importance of predictors. However, it is possible that we have certain prior knowledge or belief on the importance of predictors from external sources such as gene networks. For instance, hub genes in the gene network tend to play more important roles in disease progression [3]. Therefore, we may want to increase the usage frequency of these genes in the construction of RF. This can be achieved by modifying the sampling probability of predictors.

The strategy to modify the sampling probability of predictor variables in RF to prioritize certain predictors is not unknown in the bioinformatics literature. The Enriched RF [9] uses the false discovery rate (FDR) adjusted p-values from marginal association tests of each predictor to construct such sampling probabilities. The variable importance-weighted RF [10] first constructs a standard RF and obtains the variable importance measures of all predictors. The estimated variable importance measures are then normalized to be the sampling probabilities of predictors in the second-round RF construction.

The network-guided RF also adopts this strategy. Different from the Enriched RF and variable importance-weighted RF, it always considers network information as part of the prior knowledge to prioritize predictors. One example of network-guided RF is given by Wang and Liu (2018) [11] where they construct a variant of the random survival forest to build a better prediction model by selecting genes that show a great ability to predict the survival endpoint. In their RF construction, the sampling probability of predictors is based on p-values of marginal association tests and gene network information. However, the aforementioned approaches are constructed for a better predictive model instead of more accurate variable selection. Especially for the RF in Wang and Liu (2018), it is only applied on experimental data, no simulation studies have been designed to investigate its prediction and variable selection performance. Therefore, it is necessary to evaluate the network-guided RF from the disease gene identification perspective. Specifically, we would like to understand when the network information is beneficial for identifying disease genes and modules.

We conduct simulation studies to evaluate the performance of network-guided RF in terms of disease gene and module identification as well as prediction accuracy. We analyze the effect of incorporating information from marginal association tests or networks separately and together. A module-based synthetic gene network is first simulated and RNA-Seq data are then simulated based on the synthetic network. We further apply the method utilizing a protein-protein interaction network to identify genes relevant for classifying progesterone receptor (PR) status in breast cancer patients. We consider PR status of breast cancer because it has been extensively studied in the genomic literature and several molecular pathways are well known [12]. We use two independent breast cancer datasets from The Cancer Genome Atlas (TCGA) that were generated using microarray and RNA-Seq, respectively. We consider the concordance between these results as a validation for the discovery.

Materials and methods

Network-guided RF

In this paper, we work with binary phenotypes such as disease status, but the network-guided RF can be adopted for other types of responses as well.

For a binary classification problem, the standard RF consists of an ensemble of binary classification and regression trees (CARTs) [13] where each tree is built from a bootstrapped version of the training data. Each tree is grown via the principle of recursive partition where starting from the root node, the same node splitting procedure is applied recursively until certain stopping rules are met. The node splitting procedure consists of selecting a splitting variable and determining the splitting rule. To select the splitting variable, a pre-determined number of candidate splitting variables are randomly selected from all predictors. Each of these randomly sampled predictors is then investigated to search for the best splitting variable and to determine the splitting rule. The guiding principle for node splitting is to minimize the impurity of response values in each node, which is often measured by the Gini index for classification problem.

The network-guided RF is a variant of the standard RF to incorporate gene network information into RF construction for gene expression analysis. It achieves this by modifying the sampling probability of predictor variables during the node splitting procedure. In the standard RF, the node splitting procedure starts with randomly sampling a subset of predictor variables to be investigated for node splitting at a given node. The sampling probability is uniform, meaning that all predictors are equally likely to be selected as candidate splitting variables. However, with a given gene network, we have information on their topological importance. For instance, hub genes, which are connected to many other genes in the network, may have a higher importance. Hence, we can modify this sampling probability to reflect such network-based importance information and to prioritize the use of these genes in the construction of RF in the hope that it can help us identify disease modules and genes more efficiently. The network-guided RF takes this approach to incorporate the network information into the construction of RF.

In the network-guided RF, the creation of this sampling probability with a given gene network is based on the directed random walk (DRW) algorithm [14]. The core idea of the algorithm is to simulate a random walker on the given network which starts at a source node and, at each step, with probability of \(1-r\) it moves from the current node to a randomly selected neighboring node, or with a restart probability of r it goes back to the source node. After a number of steps, the probability distribution of the random walker being at each node in the network will reach an equilibrium and this stabilized distribution thus reflects the topological importance of genes with respect to the initial source node in the given gene network.

Mathematically, let A be the row-normalized adjacency matrix of the given gene network, where an adjacency matrix of a given network is a square matrix with the size being the same as the number of nodes in the network and with elements

$$\begin{aligned} A_{ij} = \mathcal {I}(\text {there exists an edge between node } i \text { and } j),\ \forall i \ne j, \end{aligned}$$

where \(\mathcal {I}(\cdot )\) is the indicator function. The DRW iterations are given by

$$\begin{aligned} \pi _{t+1} = (1-r) A^\top \pi _t + r \pi _0, \end{aligned}$$
(1)

where \(\pi _t\) is a vector whose ith element is the probability of the random walker being at node i at iteration t, and \(\pi _0\) is the initial distribution over the network, and r is the pre-determined restart probability. After a number of iterations, \(\pi _t\) becomes stable and can be considered as converged to an equilibrium distribution \(\pi ^*\).

If \(r=0\), then there is no restart and this algorithm reduces to the standard random walk over the network and the resulting equilibrium probability of each node is independent of the initial distribution \(\pi _0\), and is often proportional to the degree of the node, i.e., the more connections the node has to other nodes, the higher chance for the random walker to stay at the node. When non-zero restart probability r is adopted, the resulting equilibrium deviates from the aforementioned equilibrium distribution of standard random walk and is influenced by the initial distribution \(\pi _0\). In particular, as in [11], if \(\pi _0\) is constructed by assigning \(-\log (p_i)\) as its ith element where \(p_i\) is the p-value of marginal association test of gene i and normalizing it to a unit vector, then in the equilibrium distribution, genes that have large degrees in the network, have significant p-values and are closer to the previous two categories of genes will have higher probabilities.

In short, the construction of network-guided RF can be summarized as follows.

  1. (1)

    For a given gene network and any other external information, use the external information to construct an initial distribution \(\pi _0\) over all genes and run the DRW algorithm on the given network with iterations according to Eq. (1) to obtain the (approximate) equilibrium distribution \(\pi ^*\).

  2. (2)

    Draw ntree bootstrap samples, i.e. draw with replacement, from the gene expression dataset used for training.

  3. (3)

    For each bootstrap sample, grow a CART-based decision tree. During the tree construction process, at each node, mtry genes are randomly selected according to distribution \(\pi ^*\) as candidate splitting variables. The default value of mtry is \(\sqrt{p}\) where p is the total number of genes in the training set.

  4. (4)

    Grow each tree to full size until pre-determined stopping rules are met (e.g., minimum node size or complete purity of the node).

  5. (5)

    The nodes in the final layer of a tree are used for prediction of new observations. To make prediction with the RF, an observation goes through every decision tree in the forest and the final prediction for the observation is made based on aggregating results from all decision trees in the forest.

Selection of important genes

The so-called variable importance measure can be obtained from the network-guided RF. Specifically, we consider the permutation-based variable importance measure [5] to evaluate the importance of genes. Based on the variable importance, the most important genes are selected using an approach similar to the one in [11]. Starting with all genes in the dataset, at each step, the network-guided RF is constructed and the 10% lowest ranking genes are discarded. The remaining 90% of genes are used to construct the network-guided RF at the next step until a pre-determined minimum number of genes is retained. This selection procedure shares similar idea with recursive feature elimination (RFE) [15] and the only difference is that the number of genes to be retained is pre-determined in the current approach while this number is based on the prediction performance of the model in RFE. These selected genes are then considered as most important and relevant genes for the disease phenotype.

Simulation study

Here we describe our simulation study to evaluate the network-guided RFs. The description is structured according to the ADEMP scheme [16].

Aim

The simulation study is conducted to systematically evaluate the network-guided RFs on disease classification and disease gene identification accuracy under various scenarios.

Data generation

We generate synthetic gene expression data along with its underlying network structure using the R package SeqNet Version 1.1.3 [17]. The network with a given number of genes is first randomly generated and then kept fixed for all scenarios. The network follows a module-based construction where several small modules are first generated. Then these modules are connected in a way that the degrees of all genes follow a power law which is observed in many biological networks [18]. With a synthetic network, the simulator then generates data from a Gaussian graphical model and convert those values into RNA-seq gene expression data. The marginal distribution of expression for each gene is calibrated from a reference TCGA breast cancer RNA-seq dataset. More details of the data generation procedure can be found in [17].

The binary disease status is generated from a logistic regression model. In particular, the phenotype follows a Bernoulli distribution and the log-odds is modeled by the following equation.

$$\begin{aligned} \text {log-odds} = \beta _0 + \sum \limits _{i\in D} \beta _i X_i, \end{aligned}$$
(2)

where set D denotes the indices of disease genes, \(X_i\) is the standardized gene expression data of disease gene i with mean 0 and standard deviation 1, and \(\beta _0\) is the intercept and \(\beta _i\)’s are regression coefficients to reflect the effect sizes of disease genes. In our simulation, we set \(\beta _0 = 0\).

We consider various scenarios in the simulation and they are summarized in Table 1.

Table 1 Summary of different scenarios in simulation studies. Scenarios are ordered by the number of disease modules. Information on how the effect sizes of disease genes distribute within a disease module is also given

We have the Null case where no gene in the network is relevant for the disease status. This scenario gives us the opportunity to investigate the performance of network-guided RFs in terms of false selection of genes. In scenario RanEqu, disease genes are randomly distributed in the network and they have the same effect size, i.e., \(\beta _i = \beta , \forall i\in D\). In contrast, scenarios ModEqu and ModTopo consider a disease module where all disease genes come from one topological module in the network. The difference between these two scenarios is the way to assign effect sizes to these disease genes. In ModEqu all disease genes have the same effect size while in ModTopo, there is a main disease gene randomly selected within the module and the effect sizes of all other disease genes are then based upon the topological closeness to the main disease gene. Figure 1 gives an illustration of the disease modules and the assignment of effect sizes in these two scenarios. Scenarios TwoModEqu and TwoModTopo further extend these disease module-based scenarios to allow two different non-overlapping disease modules.

Fig. 1
figure 1

Illustration of disease modules with and without main disease gene. The size of the bubble reflects the effect size of the gene. When there is no main disease gene (as shown on the left), all disease genes have the same effect size. When there is a main disease gene (as shown on the right), the effect size of each disease gene is proportional to its closeness to the main disease gene within the module; the closer to the main disease gene, the larger the effect size

The number of disease genes in RanEqu and each disease module is approximately the first quartile of the sizes of all modules in the network generated by SeqNet which in our simulations is around 12-20 genes while the total number of genes is \(p\in \{1000, 3000\}\). We consider three different average effect size \(\beta =\{0.5, 1, 2\}\). For scenarios with equal effect sizes, \(\beta _i = \beta\) for all \(i\in D\). For disease modules with a main disease gene, the DRW algorithm with initial distribution concentrated only on the main disease gene (i.e., the distribution has probability one on the main disease gene and zero elsewhere) is first run to obtain an equilibrium distribution over the module. Then the effect sizes are calculated as \(\beta _i = \pi _i^** \beta * |M|\) where \(\pi _i^*\) is the equilibrium probability of gene i in the disease module from the DRW algorithm and |M| gives the number of genes in the disease module M. In this way, the coefficients in Eq. (2) always add up to \(\beta * |D|\) and thus, \(\beta\) is the average effect size.

For each scenario and combination of \((p, \beta )\), we simulate 100 independent replications with 2000 independent samples. Because we set \(\beta _0=0\) in the logistic model in Eq. (2), the case-to-control ratio is on average 1. In each replication, the whole dataset is further equally split into training and testing sets with each having 1000 samples.

Estimand

On the training set, each method estimates the importance of all genes and thus gives a ranking of genes. We calculate the permutation importance measure in all RF constructions. Based on the ranking, top |D| most important genes are identified and they are further used to build a RF model for prediction. In addition, we also record the number of times each gene is selected as one of the top genes to assess the disease gene identification performance.

Methods to be evaluated

We compare the following methods.

  1. 1.

    Oracle: standard RF with only disease genes. This serves as the benchmark for all other methods.

  2. 2.

    Standard RF: standard RF with all genes in the dataset.

  3. 3.

    Marginal-P: sampling probability of genes in RF construction is based on the p-values of marginal two-sample t-tests per gene, i.e., the initial distribution \(\pi _0\) used in [11] as we discussed in the previous section.

  4. 4.

    Network-guided RFs:

    • Topology: sampling probability of genes is based on the network structure only to reflect the gene network topology, i.e., \(r=0\) in the DRW algorithm.

    • Sampling probability of genes is based on marginal association information and network topology. If the p-values of marginal two-sample t-tests are used, it is denoted as Network-P. If the FDR-adjusted p-values of marginal two-sample t-tests are used, it is denoted as Network-Q. We fix the restart probability in the DRW algorithm to be \(r=0.3\) as in [11].

All RF implementations are based on the R package ranger Version 0.14.1 [19]. In the simulation, we set the number of trees to be 1000 and mtry to be the default value of ranger (i.e., at each node, we randomly sample \(\sqrt{p}\) genes as candidate splitting variables where p is the total number of genes in the training dataset). An R package networkRF has been prepared to include codes for all methods and simulation scenarios considered in our study. More information on the R package can be found in the section Data availability.

Performance measure

The performance of all methods is evaluated in the following three aspects:

  • Disease prediction: In each replication, each method builds a RF predictive model. This model is applied to the testing set to obtain the misclassification rate. The average misclassification rate is calculated based on all 100 replications.

  • False selection: In the Null case, the frequency of each gene being selected as important gene over all 100 replications is recorded to assess the false selection performance of all methods.

  • Sensitivity to select disease genes: In scenarios where there are disease genes, the average proportion of disease genes being selected by each method is reported as the performance measure for disease gene selection.

Experimental datasets

For the experimental data, we use two preprocessed and curated TCGA breast cancer gene expression datasets generated with two different technologies (microarray and RNA-sequencing) for prediction of progesterone receptor (PR) status that are obtained from the Bioconductor package curatedTCGAData [20]. Only data from primary tumors are used. We remove replicates and only keep the first observation and remove genes with more than 50% zero counts. We retain only white female patients and create two non-overlapping and balanced datasets. We have 283 and 284 patients for microarray and RNA-Seq datasets, respectively. Both datasets include 193 PR positive patients. Gene expression values are standardized to have mean 0 and standard deviation 1 per gene in each data set separately (same as in [21]).

Besides the gene expression data, we also use PPI network information from the STRING database via the R package STRINGdb [22]. We use STRING version 11.5 for human species and adopt default quality control on the interactions by the package. We further remove proteins with duplicated STRING ID and duplicated mapped gene ID. In total, we retain 14167 common genes in both datasets along with the corresponding PPI network consisting of 1,290,904 interactions. Please refer to the Data availability section for the access to the experimental datasets.

In the experimental data analysis, we do not include method Oracle because the disease genes are unknown. We also do not include method Network-Q for comparison because it considers similar information sources as Network-P. Therefore, we have in total four methods for comparison, namely standard RF, Marginal-P, Topology and Network-P where the first two methods do not use the PPI information while the last two incorporate network information into RF construction.

On both microarray and RNA-Seq datasets, each method constructs a RF with 10,000 trees (the same number of trees used in [21, 23] on similar datasets) and retains top 200 important genes and uses them to build a RF predictive model. Given the results in [23], we think this number is a reasonable choice for our datasets. The models built with microarray data are then tested on RNA-Seq data and vice versa to give the prediction accuracy.

Results

Simulation results

Prediction accuracy

We first look at the prediction accuracy of all methods under the different simulated scenarios.

Fig. 2
figure 2

Prediction performance of all methods in all simulation scenarios. The performance is measured by average misclassification rate calculated on the testing set over 100 repetitions. In each scenario, three average effect sizes are considered to represent the cases for weak, median and strong signals. The upper panel gives the results for \(p=1000\) total number of genes which is the same as the number of training samples, and the lower panel gives the results for \(p=3000\) total number of genes to represent the case of high-dimensional setting

As shown in Fig. 2, in the Null case, all methods are essentially performing random guess, so the misclassification rates are 0.5 as expected. In all other scenarios, Oracle has the best accuracy because it uses only the disease genes to build the predictive model, thus it serves as the benchmark for prediction accuracy.

When there exist disease genes, all methods have higher prediction accuracy as average effect size increases as expected. In addition, the prediction accuracy of all methods is not significantly affected by the different total number of genes, showing the advantage of RF-based methods in high dimensional settings.

When disease genes are not in any module as in the RanEqu scenario, network-guided RFs are clearly outperformed by methods without using network information. In fact, standard RF has the best accuracy in this scenario.

When disease genes are from disease module(s), the network-guided RFs show competitive prediction accuracies. This is especially true for Network-P where network information combined with p-values of marginal tests are used. The misclassification error of Network-P is among the lowest in most module-based scenarios, but the improvement over standard RF and Marginal-P is not substantial. The results for Network-Q, which also considers both network and marginal association information, are unstable, the method has comparable accuracy when there is only one disease module, but performs undesirably when there are two disease modules. The Topology method where only network topology information is used performs consistently undesirable with the largest error in most scenarios.

Overall, from the prediction perspective, network information does not add much value. This is not completely surprising because genes within a module are usually correlated with each other. Using all disease genes in module-based scenarios to construct predictive model may not be necessary. This is also manifested by the comparison with Oracle. Combined with the variable selection results in the next subsection, we can see that several methods can achieve near-optimal prediction accuracy in these scenarios without using all disease genes.

Disease gene identification

Now we look at disease gene identification and start with the Null case because this provides a clue on the number of falsely selected genes.

Fig. 3
figure 3

Number of genes being consistently selected as important genes by each method in the null case. We demonstrate this consistency by counting the number of repetitions within 100 repetitions that a given gene is selected as important genes. The plot shows counts of false selection at several consistency threshold level

In Fig. 3, we record the number of genes that have been consistently selected as important genes by each method in 100 repetitions. In Null case no gene should be relevant to the phenotype, so we expect that no gene should be consistently ranked at the top. However, as we can clearly see in Fig. 3, network-guided RFs have a tendency to consistently rank a subset of genes as the top important genes. A closer look at these genes reveals that this subset of genes concentrates on hub genes which are highly connected genes in the network. This is largely because the sampling probability prioritizes the use of hub genes in the RF construction. This increased usage frequency artificially creates the spurious importance when no gene is relevant to the phenotype. However, from our simulation, the good news is that when the total number of genes in the dataset increases, this phenomenon of consistent false selection becomes less severe.

Next we look at the sensitivity of all methods to select disease genes. Because the Oracle by design only uses disease genes, its sensitivity is always 1.

Fig. 4
figure 4

Sensitivity to select disease genes of all methods in all simulation scenarios. The performance is measured by average proportion of disease genes selected as important genes by each method over 100 repetitions. In each scenario, three average effect sizes are considered to represent the cases for weak, median and strong signals. The upper panel gives the results for \(p=1000\) total number of genes which is the same as the number of training samples, and the lower panel gives the results for \(p=3000\) total number of genes to represent the case of high-dimensional setting

Figure 4 shows that when average effect size increases, all methods improves on the sensitivity in general. When the disease genes are not in modules as in the scenario RanEqu, methods without using network information outperform network-guided RFs by a great margin. This is because network-guided RFs assign weights based on the network topology which in this case is irrelevant. Furthermore, in this scenario, Topology is always the worst as it puts too much weights on hub genes which are not necessarily disease genes.

When disease genes form module(s), the selection accuracy improves a lot, especially for Network-P. In most scenarios with disease modules, Network-P is one of the top performers. Network-Q again shows unstable performance. This could due to the adjustment it makes to the p-values which leads the method to put too much weight on only a small number of genes. The consequence is that, for instance, when there are two disease modules, the method has a higher chance to miss one disease module or can only capture the main disease genes within a disease module.

It is also interesting to observe that even though the difference between standard RF and Marginal-P is not huge, incorporating marginal association information does help to achieve a slightly better sensitivity in most cases.

Breast cancer datasets results

Now we look at the results for experimental data analysis. We start with the prediction performance of all methods which are summarized in Table 2. The numbers reported are the misclassification errors obtained on the corresponding data with the model trained with the dataset from the other technology. For instance, the standard RF trained by RNA-Seq data achieves 13.03% misclassification rate when it is applied to microarray data for testing.

Table 2 Prediction performance of all methods on the experimental datasets. The reported numbers are the misclassification errors on the corresponding data in the header with the model trained on the dataset with the other technology

Recall that the proportion of positive PR status is 0.682 and 0.680 in microarray and RNA-Seq dataset respectively, meaning that all methods are substantially better than random guessing. We also find that models trained with RNA-Seq data enjoy better prediction performance on microarray data than the other way around. While all methods have similar prediction accuracy, network-guided RFs do provide slightly better misclassification rates on both datasets.

Next we look at the identified genes, and the results here are only descriptive. We first look at the common genes that are ranked at the top by all four methods on both datasets. The UpSet diagram in Fig. 5 shows the common genes that are ranked at the top by all four methods on both TCGA breast cancer microarray and RNA-Seq datasets in the experimental data analysis.

Fig. 5
figure 5

Common top genes selected by each method on both TCGA breast cancer microarray and RNA-Seq datasets

We can see that in total there are 21 genes that are considered by all methods on both datasets as important genes.

Fig. 6
figure 6

Induced network of 21 common top genes selected by all 4 methods on both microarray and RNA-Seq datasets

The induced network of these 21 genes is shown in Fig. 6. The network consists of a connected module of 13 genes and 8 isolated genes. As shown in the figure, the module contains the core PR status related progesterone receptor (PGR) gene. In addition, gene PGR is known to be related to estrogen receptor-mediated (ESR-mediated) signaling and Gene expression (Transcription) pathways. In this induced network, we can find genes Estrogen Receptor 1 (ESR1), GATA Binding Protein 3 (GATA3) and Growth Regulating Estrogen Receptor Binding 1 (GREB1) from ESR-mediated signaling pathway and Androgen Receptor (AR) gene from Gene expression (Transcription) pathway. Gene SCUBE2, short for Signal Peptide, CUB Domain And EGF Like Domain Containing 2, has also been shown to play an important role in breast cancer progression, especially for the triple-negative breast cancer subtype [24].

Next we investigate the common top genes selected by network-guided RFs and by methods not using network information separately to see the differences that network information may bring. The selected genes (including the aforementioned 21 genes) and their induced networks are shown in Fig. 7. We highlight these identified genes by two different colors. Genes in blue are those 21 genes shown in Fig. 6. Genes in red are those identified only by each approach on both datasets.

Fig. 7
figure 7

a Induced networks of common top genes selected by network-guided RFs on both datasets. b Induced networks of common top genes selected by methods not using network information on both datasets. The genes in blue are those shown in Fig. 6 and genes in red are additional genes selected by each approach

When we look at the network of top genes identified by network-guided RFs, we observe that genes Epidermal Growth Factor Receptor (EGFR) and Insulin Like Growth Factor 1 Receptor (IGF1R) are added to the core module shown in Fig. 6. Gene EGFR belongs to Gene expression (Transcription) pathway and gene IGF1R is in the ESR-mediated signaling pathway. Furthermore, the inclusion of EGFR also builds a link between the core module to the Microtubule Associated Protein Tau (MAPT) gene which is among the top important genes selected by all methods on both datasets. In Fig. 6, gene MAPT is an isolated node, but network-guided RFs include EGFR into the set of important genes which further links to the gene MAPT and strengthens the module.

In contrast, the methods without using network information do not identify any other genes from two PGR-related pathways. They select Gastrin Releasing Peptide Receptor (GRPR) gene which has recently been found to be associated with the estrogen receptor (ER) positivity [25] and gene Serpin Family A Member 6 (SERPINA6) which is identified as a marker of resistance to neoadjuvant chemotherapy in HER2-negative breast cancer [26] (HER2 is short for Human epidermal growth factor receptor 2). More interestingly, the inclusion of gene Sushi Domain Containing 3 (SUSD3) builds links between gene FYVE, RhoGEF And PH Domain Containing 3 (FGD3) and the core module. Gene SUSD3 was shown to be highly expressed in ER\(\alpha\)-positive breast cancer tumors [27]. On the contrary, even though the inclusion of gene Dynein Axonemal Assembly Factor 4 (DYX1C1, also referred as DNAAF4) does creates links between existing genes to result in a more connected module, this gene is more well-known for its association with deficits in reading and spelling ability [28]. Apart from these genes, many isolated genes are included and the strengthening of the core module is very limited.

From this comparison, we can see that network information can be used in disease gene discovery and the information is likely to lead to a small amount of additional associated genes that can strengthen the core disease module. While if network information is not used, more isolated genes may be selected which could lead to challenges in understanding their contributions to the disease phenotype.

Discussion and conclusions

In this paper, we systematically evaluate the performance of network-guided RF in terms of variable selection and prediction. The network-guided RF incorporates external network information of predictors into RF construction which is believed to be beneficial to disease gene and module identification. Our results suggest that for disease prediction, network information does not add much value. In terms of disease gene discovery, when disease genes are randomly distributed within the network, network information only deteriorates the gene selection, but if they form disease module(s), network-guided RF can identify disease genes and module(s) more accurately. We also find that when disease status is independent from genes in the given network, spurious gene selection results can occur when using network information, especially on hub genes. This phenomenon needs serious attention because hub genes often connect to many pathways. False selection of these genes may lead to intuitive but false conclusions. In the experimental data analysis, our results indicate that network-guided RF may lead to genes within relevant pathways having a better chance to be identified which can further strengthen the core disease module and improve our understanding of the underlying molecular pathomechanisms. Specifically, we consider progesterone receptor status in breast cancer patients as an illustrative example because it has been extensively studied in the genomics literature and several molecular pathways are well known. With network-guided RF, we expect and indeed observe in our analysis that more genes (even though not novel) from well-known relevant pathways can be identified, while without using network information these genes such as EGFR and IGF1R cannot be selected. This demonstrates the potential gain on disease gene and module discovery.

In our future work, we plan to apply the network-guided RF to make new contributions to the understanding of complex diseases. However, the success of this approach strongly depends on the availability and correctness of network information and gene annotation.

A major limitation of the network-guided RF approach is that the gene selection procedure depends on a manually selected threshold for defining the top most important genes. It would be important to develop an automated variable selection procedure for RFs where the sampling probability of predictor variables is not uniform. Unlike in the commonly adopted procedures such as Boruta [29] or Vita [30], with a non-uniform sampling probability, the (approximate) null distribution of variable importance measures is currently unknown and needs further study in order to automate the variable selection procedures. We would also like to point out that it is even harder to consider shadow variables as in the AIR [31], because introducing more predictor variables will inevitably change the sampling probability, thus may affect not only the null distribution construction but also the estimation of the importance measure itself.

In the construction of RF, the sampling probability of predictors can be considered as prior knowledge on the importance of predictors. From Bayesian perspective, the sampling probability used in the standard RF is a non-informative prior while the one based on network information is informative. Our simulation studies, if viewed from a Bayesian perspective, demonstrates the result of potential prior-data conflict, especially in the scenario where disease genes are randomly distributed in the network. Even though the practical relevance of this particular scenario may be limited, from methodology development perspective, it would be interesting to consider a more robust prior such that when there is any disease module, the network information can provide enough information to benefit the detection and when there is no disease module, such information should not hinder the data-driven detection, especially not leading to consistent false selection.

Our approach by using microarry and RNA-Seq datasets for validation in the experimental analysis may not be ideal. As pointed out in [32, 33], the concordance between datasets coming from these two technologies may not be perfect and could be affected by a range of chemical treatment conditions. Therefore, it would be beneficial to apply network-guided RF on a large RNA-Seq dataset with carefully constructed networks.

We are aware that other approaches to incorporate network information have been published. Guan et al. (2018) [34] provide a general framework for incorporating prior knowledge into RF construction for biomarker discovery where network information may be considered. Zhao et al. (2020) [35] use network information in the feature engineering step and construct standard RF with these created features. Similarly, Adnan et al. (2019) [36] propose to use network edges as features in RF construction to obtain a better predictive model. Thus, it would be interesting to conduct a comparative study to compare different approaches in terms of disease gene discovery. We will leave this work for a future project.

Availability of data and materials

An R package networkRF implementing the network-guided RF approach and providing functions for simulation is available at GitHub (https://github.com/imbs-hl/networkRF). The experimental data analysis results published here are in part based on data generated by the TCGA Research Network: http://cancergenome.nih.gov/. The processed and quality controlled experimental datasets are also included in the R package. Simulated datasets with 1000 genes are made available at Zenodo (doi:10.5281/zenodo.8242661).

References

  1. Li WV, Li JJ. Modeling and analysis of RNA-seq data: a review from a statistical perspective. Quant Biol. 2018;6(3):195–209.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Goh KI, Cusick ME, Valle D, Childs B, Vidal M, Barabási AL. The human disease network. Proc Natl Acad Sci. 2007;104(21):8685–90.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Barabási AL, Gulbahce N, Loscalzo J. Network medicine: a network-based approach to human disease. Nat Rev Genet. 2011;12(1):56–68.

    Article  PubMed  PubMed Central  Google Scholar 

  4. Ideker T, Sharan R. Protein networks in disease. Genome Res. 2008;18(4):644–52.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Breiman L. Random forests. Mach Learn. 2001;45(1):5–32.

    Article  Google Scholar 

  6. Ishwaran H, Kogalur UB, Blackstone EH, Lauer MS. Random survival forests. Ann Appl Stat. 2008;2(3):841–60.

    Article  Google Scholar 

  7. Chen X, Ishwaran H. Random forests for genomic data analysis. Genomics. 2012;99(6):323–9.

    Article  CAS  PubMed  Google Scholar 

  8. Cutler DR, Edwards TC, Beard KH, Cutler A, Hess KT, Gibson J, et al. Random forests for classification in ecology. Ecology. 2007;88(11):2783–92. https://doi.org/10.1890/07-0539.1.

    Article  PubMed  Google Scholar 

  9. Amaratunga D, Cabrera J, Lee YS. Enriched random forests. Bioinformatics. 2008;24(18):2010–4.

    Article  CAS  PubMed  Google Scholar 

  10. Liu Y, Zhao H. Variable importance-weighted random forests. Quant Biol. 2017;5:338–51.

  11. Wang W, Liu W. Integration of gene interaction information into a reweighted random survival forest approach for accurate survival prediction and survival biomarker discovery. Sci Rep. 2018;8(1):13202.

    Article  PubMed  PubMed Central  Google Scholar 

  12. Lange CA, Yee D. Progesterone and breast cancer. Women’s Health. 2008;4(2):151–62.

    CAS  PubMed  Google Scholar 

  13. Breiman L, Friedman J, Stone CJ, Olshen RA. Classification and regression trees. CRC Press; 1984.

  14. Köhler S, Bauer S, Horn D, Robinson PN. Walking the interactome for prioritization of candidate disease genes. Am J Hum Genet. 2008;82(4):949–58.

    Article  PubMed  PubMed Central  Google Scholar 

  15. Díaz-Uriarte R, Alvarez de Andrés S. Gene selection and classification of microarray data using random forest. BMC Bioinformatics. 2006;7:1–13.

  16. Morris TP, White IR, Crowther MJ. Using simulation studies to evaluate statistical methods. Stat Med. 2019;38(11):2074–102.

    Article  PubMed  PubMed Central  Google Scholar 

  17. Grimes T, Datta S. SeqNet: an R package for generating gene-gene networks and simulating RNA-seq data. J Stat Softw. 2021;98(12):1–49.

  18. Milo R, Shen-Orr S, Itzkovitz S, Kashtan N, Chklovskii D, Alon U. Network motifs: simple building blocks of complex networks. Science. 2002;298(5594):824–7.

    Article  CAS  PubMed  Google Scholar 

  19. Wright MN, Ziegler A. ranger: a fast implementation of random forests for high dimensional data in C++ and R. J Stat Softw. 2017;77(1):1–17. https://doi.org/10.18637/jss.v077.i01.

  20. Ramos M, Geistlinger L, Oh S, Schiffer L, Azhar R, Kodali H, et al. Multiomic integration of public oncology databases in bioconductor. JCO Clin Cancer Informat. 2020;1:958–71.

    Article  Google Scholar 

  21. Degenhardt F, Seifert S, Szymczak S. Evaluation of variable selection methods for random forests and omics data sets. Brief Bioinform. 2019;20(2):492–503.

    Article  PubMed  Google Scholar 

  22. Szklarczyk D, Kirsch R, Koutrouli M, Nastou K, Mehryary F, Hachilif R, et al. The STRING database in 2023: protein-protein association networks and functional enrichment analyses for any sequenced genome of interest. Nucleic Acids Res. 2023;51(D1):D638–46.

    Article  CAS  PubMed  Google Scholar 

  23. Seifert S, Gundlach S, Szymczak S. Surrogate minimal depth as an importance measure for variables in random forests. Bioinformatics. 2019;35(19):3663–71.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Kumar S, Prajapati KS, Gupta S. The multifaceted role of signal peptide-CUB-EGF domain-containing protein (SCUBE) in cancer. Int J Mol Sci. 2022;23(18):10577.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Morgat C, MacGrogan G, Brouste V, Vélasco V, Sevenet N, Bonnefoi H, et al. Expression of gastrin-releasing peptide receptor in breast cancer and its association with pathologic, biologic, and clinical parameters: a study of 1,432 primary tumors. J Nucl Med. 2017;58(9):1401–7.

    Article  CAS  PubMed  Google Scholar 

  26. De Ronde JJ, Lips EH, Mulder L, Vincent AD, Wesseling J, Nieuwland M, et al. SERPINA6, BEX1, AGTR1, SLC26A3, and LAPTM4B are markers of resistance to neoadjuvant chemotherapy in HER2-negative breast cancer. Breast Cancer Res Treat. 2013;137:213–23.

    Article  CAS  PubMed  Google Scholar 

  27. Moy I, Todorović V, Dubash A, Coon J, Parker JB, Buranapramest M, et al. Estrogen-dependent sushi domain containing 3 regulates cytoskeleton organization and migration in breast cancer cells. Oncogene. 2015;34(3):323–33.

    Article  CAS  PubMed  Google Scholar 

  28. Bates T, Lind P, Luciano M, Montgomery G, Martin NG, Wright MJ. Dyslexia and DYX1C1: deficits in reading and spelling associated with a missense mutation. Mol Psychiatry. 2010;15(12):1190–6.

    Article  CAS  PubMed  Google Scholar 

  29. Kursa MB, Rudnicki WR. Feature selection with the Boruta package. J Stat Softw. 2010;36:1–13.

    Article  Google Scholar 

  30. Janitza S, Celik E, Boulesteix AL. A computationally fast variable importance test for random forests for high-dimensional data. ADAC. 2018;12:885–915.

    Article  Google Scholar 

  31. Nembrini S, König IR, Wright MN. The revival of the Gini importance? Bioinformatics. 2018;34(21):3711–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  32. Wang C, Gong B, Bushel PR, Thierry-Mieg J, Thierry-Mieg D, Xu J, et al. The concordance between RNA-seq and microarray data depends on chemical treatment and transcript abundance. Nat Biotechnol. 2014;32(9):926–32.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  33. Mantione KJ, Kream RM, Kuzelova H, Ptacek R, Raboch J, Samuel JM, et al. Comparing bioinformatic gene expression profiling methods: microarray and RNA-Seq. Med Sci Monit Basic Res. 2014;20:138.

    Article  PubMed  PubMed Central  Google Scholar 

  34. Guan X, Runger G, Liu L. Dynamic incorporation of prior knowledge from multiple domains in biomarker discovery. BMC Bioinformatics. 2020;21(2):1–10.

    Google Scholar 

  35. Zhao R, Hu B, Chen L, Zhou B. Identification of latent oncogenes with a network embedding method and random forest. BioMed Res Int. 2020;2020:5160396.

    Article  PubMed  PubMed Central  Google Scholar 

  36. Adnan N, Lei C, Ruan J. Robust edge-based biomarker discovery improves prediction of breast cancer metastasis. BMC Bioinformatics. 2020;21(14):1–18.

    Google Scholar 

Download references

Acknowledgements

Not applicable.

Funding

Open Access funding enabled and organized by Projekt DEAL. This work was supported by the German Federal Ministry of Education and Research (BMBF) funded e:Med Programme on systems medicine [grant 01ZX1510 (ComorbSysMed) to S.S.].

Author information

Authors and Affiliations

Authors

Contributions

S.S. conceived and oversaw the project. J.H. took the main responsibility in the execution of this project including programming, data integration and data analysis. All authors made critical input to the manuscript. All authors read and approved the final manuscript.

Corresponding author

Correspondence to Silke Szymczak.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare no competing interests.

Additional information

Publisher's Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Rights and permissions

Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article's Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article's Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Hu, J., Szymczak, S. Evaluation of network-guided random forest for disease gene discovery. BioData Mining 17, 10 (2024). https://doi.org/10.1186/s13040-024-00361-5

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13040-024-00361-5

Keywords