Abstract
To analyze gene expression data with sophisticated grouping structures and to extract hidden patterns from such data, feature selection is of critical importance. It is well known that genes do not function in isolation but rather work together within various metabolic, regulatory, and signaling pathways. If the biological knowledge contained within these pathways is taken into account, the resulting method is a pathway-based algorithm. Studies have demonstrated that a pathway-based method usually outperforms its gene-based counterpart in which no biological knowledge is considered. In this article, a pathway-based feature selection is firstly divided into three major categories, namely, pathway-level selection, bilevel selection, and pathway-guided gene selection. With bilevel selection methods being regarded as a special case of pathway-guided gene selection process, we discuss pathway-guided gene selection methods in detail and the importance of penalization in such methods. Last, we point out the potential utilizations of pathway-guided gene selection in one active research avenue, namely, to analyze longitudinal gene expression data. We believe this article provides valuable insights for computational biologists and biostatisticians so that they can make biology more computable.
1. Introduction
Data obtained from the high-throughput technologies such as microarrays or RNA-sequencing (RNA-seq) is a recurring theme in many fields such as computational biology and bioinformatics. Given these advanced technologies are expensive, the number of observations/subjects is usually small, i.e., on the scales of several to hundreds. Another special characteristic of the high-throughput technologies is that they can measure thousands of variables/features simultaneously. As far as the statistical modeling is considered, a classic regression model becomes nonidentifiable when all measured variables are used as predictors for such a data set; let alone one may also be interested in exploring the nonlinear association at higher orders or the interactions among these variables. To deal with the data in which the number of variables is extremely larger than the number of samples, the implementation of a feature selection process that identifies a subset of genes with the optimal predictive performance [1] is in demand.
Feature selection has outstanding merits. Especially, the resulting subset of genes speeds up the learning process, improves predictive accuracy, and leads to a better biological implication. The classic feature selection, we call it “gene-based feature selection” to avoid ambiguity in this article, is stratified into three subtypes, say, filter, embedded, and wrapper methods [1, 2]. These three categories have their own unique characteristics. For instance, a filter method usually screens individual features one by one according to their relevancy level with the outcome of interest [1]. The feature selection of an embedded method is usually realized by using a penalized regression model such as the Least Absolute Shrinkage and Selection Operator (LASSO) model [3]. Such a method can simultaneously select relevant features and estimate those coefficients (the effect size of those features) in the final model; in addition to that it consumes less computing time than a wrapper method.
Nevertheless, the gene subset/list selected by a gene-based feature selection algorithm has several drawbacks. First, the predictive performance on new independent samples is unsatisfactory; the overfitting phenomenon is always apparent. Second, the gene lists trained from different data sets barely overlap. Reproducibility or stability of the final models (with different data, the same method gives different gene lists with few or no overlaps) is low, leading to a generalization of the resulting gene list impossible. Last, most of these methods use the difference of gene expression level between different phenotypes as a critical criterion to select the genes associated with the outcome. However, differentially expressed genes (DEGs) are not necessarily to be true driver genes. Ignoring biological information may result in a meaningless biological implication for the resultant gene list.
Furthermore, it is well known that genes do not function in isolation but rather work together within various metabolic, regulatory, and signaling pathways. The interdependencies among genes are often represented as a collection of pathways/gene sets in which potential coregulated or coexpressed genes are grouped together. In this review, the terms “pathway”, “network”, and “gene set” have same implication/meaning and are exchangeable to one another.
The biological information contained within pathways can be utilized to impose additional constraints on the prediction tasks, forcing training methods to select more scientifically meaningful genes rather than those statistically significant genes (such as genes more differentially expressed between two phenotypes). A feature selection process that incorporates pathway knowledge by one means or another is referred to as pathway-based feature selection herein, which has currently grown into a hot topic in computational biology and bioinformatics.
So far, to the best of our knowledge, no survey on pathway-based feature selection methods in the literature has been given yet. The objective of this article is to provide a selective review on such methods.
2. Pathway-Based Feature Selection Methods
Based on to what a feature refers, pathway-based feature selection methods may be classified into three categories; see Figure 1. The first category contains pathway analysis methods such as [4, 5] in which a feature corresponds to a pathway, with the objectives of selecting the whole pathways associated with the phenotypes of interest. Since the methods in this category have been reviewed by many researchers previously and several well-known algorithms have been compared exclusively using simulations and real-world data [6–15] and our attention is mainly focused on the selection of individual genes related to the phenotypes of interest, we skip this topic in the article.
The second category considers a bilevel selection process, which identifies not only relevant pathways but also important genes that contribute critically to the significance of identified relevant pathways. The bilevel selection methods can be further divided into three major categories, forward selection, backward selection, and simultaneous selection [16]. In a forward selection process such as [10], the selection of relevant gene sets is carried out firstly and then followed by the selection of relevant individual genes. In contrast, the selection steps in a backward selection process such as [17] take the reversed order. Last, a simultaneous selection process such as [18] performs the selection of significant gene sets and the selection of important genes at the same time, as its name implies. The simultaneous selections of gene sets and genes are usually accomplished with the aids of a penalized model where a penalty term imposing some restrictions on the β coefficients that represent the association magnitude with the outcome is added to the objective function.
In the last category, a feature corresponds to an individual gene. The methods of this type incorporate the pathway knowledge as a priori to facilitate the selection of relevant genes, aiming to improve the resulting gene list's predictive ability and/or reproducibility. Although we had intended to reserve the syntax of “pathway-based feature selection” for this specific subfield, we frame a specific term “a pathway-guided gene selection” for it instead to avoid confusions. Given our attention is focused on the methods capable of selecting important individual genes [16], the bilevel selection algorithms, e.g., [10, 19], may be loosely classified into the pathway-guided gene selection category.
3. Pathway-Guided Gene Selection Methods
3.1. Three Major Categories
In our previous study [20], we stratified a pathway-guided gene selection method into three classes on the basis of which piece of pathway information was incorporated and how such information was incorporated, namely, weighting, stepwise forward, and penalty. In the following subsections, a detailed description of and discussion on these three categories are given.
3.2. Stepwise Forward
The stepwise forward methods usually rank all genes according to a specific discriminative score. Then the methods start from the most significant gene and evaluate the performance of the resulting gene subset based on some predetermined metric. The step iterates until no further gain upon this performance statistic can be obtained. A bilevel selection method, the significance analysis of microarray gene set reduction (SAMGSR) algorithm [10], can be put into this category. This method consists of two steps. Its first step is essentially an extension of the significance analysis of microarray (SAM) method [21] to all genes inside a gene set, and a new statistic called SAMGS [4] which is the square sum of SAM statistics for all genes inside a specific gene set is generated. The significance level of a gene set is determined using permutation tests. Obviously, this step carries out the selection of significant pathways firstly so that the SAMGSR method belongs to the forward bilevel selection category. In the second step, a subset of important genes is extracted from each significant pathway identified by the first step on the basis on the magnitudes of individual genes' SAM statistics. The realization of this extraction is by the means of stepwise forward. Specifically, the genes inside each significant pathway are ordered decreasingly based on the magnitude of their SAM statistics. Then the reduction step gradually partitions the entire gene set into two subsets: the reduced subset that includes the first k genes and the residual subset including the remaining genes for k = 1,…, |j|, where |j| is the size of gene set j. At each partition, the significance level of the reduced subset is evaluated using the p-value of SAMGS statistic for its corresponding residual subset. The iteration stops until this p-value is larger than a predetermined threshold for the first time.
Another typical example of a stepwise forward method is the algorithm proposed by Chuang et al. [22]. This method starts from a seed gene and identifies a gene list by gradually adding the neighboring gene that provides the highest mutual information between the average of expression values for all included genes and the outcome. In this example, network topology information that records how genes are connected instead of the grouping membership information is taken into consideration.
Two big drawbacks of a stepwise forward method are as follows: (1) the methods may fail to identify those ‘driving' genes with subtle changes because the inclusion of a gene depends largely on its expression values or expression differences among different phenotypes; (2) the selection process of important genes is usually separated from the final model construction.
3.3. Weighting
The weighting methods construct a pathway knowledge-based weight that reflects how important a gene is inside the gene-to-gene interaction network for each gene and then balance between the weight and its gene expression values to determine the significance level of the specific gene. For example, the reweighted recursive feature elimination (RRFE) method [23] uses the GeneRank algorithm [24] to alter the ranking criterion of the support vector machine recursive feature elimination (SVM-RFE) algorithm, and then identifies a subset with the best discriminative power. More specifically, the resulting GeneRanks are used as weights and combined with the coefficients of SVM to increase the chance of a gene with more directly connected neighbors being selected.
In the RRFE method, the weights are combined with the statistics (i.e., the coefficients in a SVM model). An alternative strategy of weighting is to combine the weights directly with gene expression values to generate weighted gene expression values and then implement a gene-based feature selection method such as LASSO to identify relevant genes. An example of this category is [25], in which the weighted expression profiles were used to classify two major subtypes of non-small-cell lung cancer. Overall, the weighting methods are the least implemented in the literature, compared to the methods in other two categories. This may be due to that the constructed weights are subject to biases and errors, which might lead to inferiority of the resulting gene lists.
3.4. Penalty
In a penalty model, an extra penalty term that records pathway information is combined with an objective function such as the log likelihood function to generate the final objective function. The identification of relevant genes is realized by the means of finding the best subset of genes that optimize this function. To name several penalty methods, Zhu et al. [26] combined the network-constrained penalty term given by [27] with a SVM model and proposed the network-based SVM method to discriminate two different phenotypes. Similarly, Chen et al. [28] also combined the network-constrained penalty term with a SVM model and proposed the netSVM method for the purpose of classification. More recently, Sokolov et al. [29] generalized the elastic net penalty term to incorporate pathway knowledge and then combined the proposed penalty term with an objective function to select relevant genes. The proposed term is referred to as the generalized elastic net (gelnet) function, and it includes the elastic net as a special case. The big disadvantage of a penalty method is that its computing burden is moderate or even heavy. Three separate figures (Figures 2–4) were made to elucidate these three major types of pathway-guided gene selection methods in detail. A review of typical examples in each category is given in Table 1.
Table 1.
Reference | Brief description of the proposed method and its characteristics | Category |
---|---|---|
Zhu et al. [26] | The proposed network-based SVM method combines the network-constrained penalty (see equation (1)) with a SVM model to carry out feature selection and classification. It makes SVM models capable of carrying out feature selection; the network-constrained penalty gives heavier weights to genes with more direct neighbors (thus increases the chance of such genes being selected) and encourages a grouping effect. But the method only deals with binary classification and considers immediate neighbors. |
Penalty |
Chen et al. [28] | The netSVM method also combines the network-constrained penalty (see equation (1)) with a SVM model. Its advantages and disadvantages are similar to the network-based SVM method by Zhu et al [26] (see above) |
Penalty |
Sokolov et al. [29] | The generalized elastic net penalty function is given and combined with an objective function to select important genes. This is named as the GELnet method. The authors claimed that this penalty function includes many well-known penalty terms and the method is so flexible that it can deal with many outcome types. There is an independent R package (i.e., gelnet) to implement this method, but now this package can only conduct binary classification. |
Penalty |
Zhang et al. [53] | The Net-Cox method adds a network-constrained penalty term to the corresponding partial likelihood function of a Cox model, aiming to select important prognostic genes The Matlab codes are available online, making the implementation of this method easy. This method only considers direct neighbors. |
Penalty |
Bandyopadhyay et al. [32] | After ranking genes in a pathway according to their marginal classification power, the proposed BPFS method starts from the gene with the largest power and then adds genes The authors claimed that this method goes beyond the immediate neighbors and considers redundant gene elimination. Also, missing genes in the pathway databases are mapped to the network using a probabilistic technique. However, the method is hard to comprehend, and no codes are available. |
Stepwise forward |
Lee et al. [33] | In each pathway, the method reorders genes according to their t-scores, and then the subset of genes whose combined expression has optimal discriminative power called CORGs is identified. Only the membership of genes is considered. The method is simple and easy to implement. |
Stepwise forward |
Razi et al. [34] | The proposed NBCG method starts with a seed gene and traverses the network to find the optimal subset on the basis of Shapley value. The method uses the concept of Shapley value to take into account the collective power of the resulting gene subset. The choice of a seed gene may result in excluding a gene subset with subtle individual effects but significant concordant effect. |
Stepwise forward |
Wu et al. [54] | The shortest path method (with well-known genes related to the disease under study, i.e., gastric cancer as seeds) is used to mine candidate genes and the combination of random forest +incremental feature selection is used to obtain the optimal subset. The proposed method considers topology information of a network. The use of a wrapper method (RF+IFS) and permutation tests may slow the method down. |
Stepwise forward1 |
Tian et al. [20] | The weighted-SAMGSR method extends the SAMGSR algorithm by weighing SAMGS statistics according to genes' connectivity levels in the network. The method considers both the membership information and the connectivity level, and can handle two-class and multiple-class classification. The R-codes are available in the supplementary material. Computing time is a big concern since permutation tests are needed to calculate p-values of test statistics. |
A hybrid of weighting and stepwise forward |
Johannes et al. [23] | The RRFE method uses the GeneRank algorithm to alter the ranking criterion of the SVM-RFE algorithm and selects a subset with the best discriminative power. Weighing the coefficients of SVM models with their GeneRanks to increase the probability of a gene with more connected genes being selected, an independent R package (i.e., pathClass) is provided to implement this method. The method only considers how many direct neighbors a gene has and ignores topology information completely. |
Weighting |
Chan et al. [39] | The wgSVM-SCAD method weighs the expression values of genes in a pathway according to their t-values and then uses a penalized SVM model (with SCAD penalty) to identify relevant genes. The proposed method only considers membership information and the weights are only based on the relevance score (i.e., t-values) instead of pathway information. |
Weighting |
Tian et al. [16] | Using sign averages of all genes inside a gene set to represent corresponding gene set, the proposed methods (i.e., one forward bi-level selection method and one backward bi-level selection method) filter out insignificant gene sets and insignificant genes in a specific order. The sign average metric provides a better representation of a gene set than mean, median and the first PC. The proposed methods only consider membership information. |
Bi-level selection |
Lim and Wong [19] | In both FSNet and PFSNet methods, a fuzzy value is assigned to each gene for each sample and then majority voting is used to determine important genes. The codes are available online. The proposed methods only consider the gene grouping membership information. |
Bi-level selection |
Note: Bilevel selection algorithms are regarded as a special case of pathway-guided gene selection algorithms.
1Can be loosely categorized into the indicated category (e.g., stepwise forward).
3.5. Penalty Function
Given the fact that penalization plays a critical role in both the pathway-guided gene selection and in bilevel selection methods, we discuss the commonly used penalty terms in both methods in the following sections.
3.5.1. Network-Constrained Penalty
For a penalty method, one well-known network-constrained penalty term was proposed by [27]. It is notated as
(1) |
Here w(u,v) denotes the weight of edge (u, v). It usually takes the value of 1 if gene u and gene v are connected, 0 otherwise. The degree of gene u (denoted as du) is the sum of edge weights over all vertices connected with u, i.e., ∑u~vw(u, v). This term introduces a smooth solution of β coefficients (which represent the association magnitudes and directions of genes with the outcome) on the network via penalizing the weighted sum of squares of the scaled difference of the coefficients between connected genes. Li & Li [27] specifically stated that scaling the β coefficients using their respective degrees of freedom on the network “allows the genes with more connections to have larger coefficients so that small changes of expressions of such genes can lead to large changes in the response”. Several studies had adopted and imposed this penalty term on different objective functions. For instance, Chen et al. [28] had imposed this constraint on a support vector machine (SVM) model and developed a new approach called the network-constrained support vector machine (netSVM) method. For a more detailed description on the penalty functions at the pathway level, the work by Pan et al. [30] and Table 2 are referred.
Table 2.
Methods | Mathematical notation | Characteristics |
---|---|---|
Li & Li, 2008 [27] |
Here, du is the degree of freedom for gene u, recording the sum of weights for all genes connected to gene u. w(u, v) is the weight for the edge between genes u and v. |
Aims at smoothing the β coefficients over the network, ignoring that neighboring genes might have β's in opposite directions. |
| ||
[55] |
Here, is the estimated value of β coefficient for gene u, and sign (x) represents the sign of x, if x>0 sign(x)=1; x<0 sign(x)=-1; otherwise sign(x)=0. |
Accounts for that two connected genes might have β's with different signs, but may not work well since it is difficult to estimate the signs for β's. |
| ||
[30] | Shrinks the weighted β's of two neighboring genes towards each other, but the estimates may be severely biased. | |
[26, 56] | for γ = ∞, it becomes |
A 2-step procedure is used to reduce biases; it is proved that this performs better than that with smaller γ |
| ||
[57] |
Here, I (x) is an indicator. If the condition x is true I(x)=1, otherwise its value is 0. |
Encourages simultaneous selection of neighboring genes in the network. But the Indictor function I is not continuous and thus needs special care. |
| ||
The generalize elastic net: [29] |
Here D and P are additional penalty weights for individual genes (gene-level penalty) and gene pairs (pathway-level penalty). |
Includes the network-constrained penalty term by [27] as a special case, capable of accommodating any positive semi-definite measure of dissimilarity between pairs of genes. |
3.5.2. General Penalty Framework for a Bilevel Selection Method
For a bilevel selection process, Breheny & Huang [31] presented a general framework of the penalty functions used, which is
(2) |
where the subscript j, k represents gene k (k=1,2,… Kj, where Kj is the size of gene set j) inside group j (j=1,2,…J, where J is the number of gene sets under consideration). In this formula, an outer penalty function fo, e.g., the bridge penalty, is applied to a sum of inner penalties fI, e.g., the LASSO. The outer penalty regularizes the coefficients of all genes within the specific get sets while the inner penalty function penalizes on the coefficients before individual genes. Table 3 summarizes those penalty terms commonly used in a simultaneous bilevel selection process.
Table 3.
Methods | Mathematical notation | Characteristics |
---|---|---|
Group LASSO [58] |
General formfo(∑k=1KjfI(|βj,k|)) See equation (2) for what fo, fI and βj,k represent Outer bridge penalty + inner ridge penalty |
It cannot identify the important genes within the selected gene sets and thus is actually incapable of bilevel selection and also heavily shrinks large coefficients (leading to estimate biases for large coefficients) |
Group bridge [59] | Outer bridge penalty+ inner LASSO penalty | It can provide sparse solutions at both pathway and gene levels, but it is associated with big empirical difficulties since the bridge penalty is not everywhere differentiable. |
Group MCP [31] | Outer MCP penalty+ inner MCP penalty | Allow coefficients to grow large and groups to remain sparse. |
Group exponential LASSO [18] | Outer exponential penalty + inner LASSO penalty | A decay parameter controls the degree to which gene selection is coupled together within gene sets and has several advantages over the other composite penalty term such as group bridge. |
Sparse group LASSO [60] |
taking the additive format |
Convex and thus highly likely to get the global minimum, but extra care is needed since the group coordinate descent algorithms cannot be applied. |
Note: the general formatting for group LASSO, group bridge, and group MCP was given by Breheny & Huang [31]. It is too general to guarantee all combinations of outer and inner penalties produce sensible models. Thus the second general form was proposed by Huang et al. [59] to address this issue specifically.
After searching in the literature, it is found that pathway-guided gene selection methods have been widely applied in cancer studies. Specifically, a pathway-guided gene selection algorithm may cast some insight on identifying diagnostic gene signatures capable of distinguishing cancer patients from normal controls; different subtypes of a specific cancer; or histologic stages, or identifying prognostic signatures that predict the survival time of cancer patients. By searching in the PubMed using the keywords of feature selection, pathway/network, gene expression, and cancer and then inspecting their relevance, we found roughly 40 articles which utilize pathway-guided gene selection algorithms to study a variety of cancers. Figure 5 provides the statistics of these articles by stratifying them according to the cancer types under study. From this figure, it is observed that the most frequently studied cancer types are breast cancer, e.g., the studies by [23, 26, 28, 29, 32–35] and lung cancer, e.g., the studies by [16, 20, 33, 36–40].
Among these studies, the penalty method is the most prevalent method, being followed by the stepwise forward method. This observation provides evidence to support our statement that the strategy of a penalized regression model to select relevant genes has gained increasing attention and the weighting methods have been underutilized compared to the other two categories. Given there are several public repositories such as The Cancer Genome of Atlas (TCGA: https://portal.gdc.cancer.gov/), the Gene Expression Omnibus (GEO: https://www.ncbi.nlm.nih.gov/), and Array Express [41], we believe more investigation will boom to utilize pathway-guided gene selection methods to study other cancer types and other complex diseases.
4. Pathway Information
4.1. Topology or Grouping Information
As we mentioned in the early section, different algorithms may account for different pathway knowledge. For examples, some algorithms consider pathway topology information (e.g., which genes are connected to which genes) whereas some ignore it. In the methods that omit topology information, genes are grouped into many gene sets and only the group membership of genes is considered. From the perspective of weighting, the methods using grouping information weigh every gene inside a specific pathway equally while the first type of methods may prioritize the genes with high connectivity level. Based on whether topology information is considered, a pathway-guided gene selection method can be divided into either a functional score based method or a topology-based method. In a functional score based method such as [10, 18], only the grouping membership of genes is considered to generate an evaluation score, with an implicit assumption that all genes inside a specific pathway coregulate/cofunction together. In contrast, in a topology-based method such as [28] more structured pathway knowledge rather than grouping information is considered.
4.2. Data-Driven versus Canonical Pathways
Several studies, e.g., [42, 43], have concluded that pathway-guided gene selection does not outperform classic gene-based feature selection methods in terms of predictive accuracy. This inferiority may be explained by the fact that the pathway knowledge retrieved from those canonical pathway databases/knowledge-bases such as the Kyoto Encyclopedia of Gene and Genomes (KEGG) [44], Gene Ontology (GO) [45], and Reactome [46] conveys no or limited meaningful information for a specific dataset or condition/disease. In contrast, the pathways constructed in a “data-driven” way may be more informative for the diseases under investigation and thus be preferred over the canonical pathways. Here, “data-driven” means that specific data of a specific condition/disease are used to build up pathways [47, 48]. The construction for those data-driven pathways is usually accomplished with the aids of a coexpression module detection technique, e.g., the Weighted Gene Coexpression Network Analysis (WGCNA) [49] and Algorithm for the Reconstruction of Accurate Cellular Network (ARACNE) [50]. Also, there exist some elegant algorithms, e.g., [51, 52], that are able to figure out grouping structures and carry out feature selection simultaneously. No matter which strategy it takes, in the “data-driven” pathway construction pathway structure is inferred from data.
On the other hand, data-driven pathways provide no information about causality given they cannot determine genes' positions in the whole network and thus cannot distinguish the regulatory/upstream genes apart from the regulated/downstream genes [61]. In addition, different form the static representations of the biological pathways, say, protein-to-protein interaction, metabolic networks, or signaling networks curated in those canonical databases, these data-driven pathways vary from data to data and thus may be subject to random noises and difficult to be interpretable from a biological point of view [62]. Finally, the resulting models by using data-driven pathways may be subject to overfitting since the build-up of coexpression/coregulation modules and the selection of relevant features are usually carried out on the same dataset.
Therefore, a through evaluation on which pathways are used during data analysis is highly desirable, in order to maximize the information extraction and to infer true biological meaning.
5. Potential Research Area
So far, the feature selection algorithms we have talked are mainly for cross-sectional data in which data were collected at a single time point. The number of feature selection algorithms for longitudinal data in which the subjects were followed up across time and the corresponding data were collected at different time points is not comparable to that of cross-selection data. To name several, the EDGE method [63, 64], the Generalized Estimating Equation- (GEE-) based screening procedure by [65], the penalized-GEE method [66], and the Penalized-GEE with Grid Search (PGS) method by [67] are included in this small-sized list of longitudinal feature selection algorithms.
As far as the pathway-based feature selection algorithms are considered, to the best of our knowledge, one of our extensions to the SAMGSR method [10], the two-level SAMGSR method, is the only approach that incorporates pathway information to specifically deal with longitudinal data [68]. In the two-level SAMGSR method, the reduction step of the SAMGSR algorithm [10] is applied twice hierarchically. Specifically, the selected gene sets are further reduced to their respective important components, i.e., genes, and then the important time points in selected genes are identified subsequently. Nevertheless, the two-level SAMGSR only considers the grouping membership information. The results of several real-world applications where the diseases under investigation include non-small-cell lung cancer, multiple sclerosis, and traumatic injury [36, 68, 69] have suggested the performance improvement for a pathway-guided method only considering the grouping information over a conventional method may be trivial. In contrast, when a pathway-based method accounts for extra pathway knowledge such as the connectivity information among genes and regulation direction recording which genes regulate which genes, its performance might be promoted dramatically.
One major finding of our previous studies [68, 70] is that the gene expression profiles across different time points may be regarded as a gene set and then some suitable pathway analysis methods may be adopted to select relevant genes for longitudinal data. In the light of this, summary scores at the pathway level such as means, medians [71], the first principal components (PCs) [72], and the sign averages [17, 73] which average out the signed expression values, with signs indicating the association directions between genes and outcome, or more statistically complicated ones like the pathway deregulation scores (PDS) [74], may be chosen to generate pseudo genes as representatives for respective pathways, and then a longitudinal feature selection process has been downgraded to a classic feature selection process.
Furthermore, one may be also interested in finding those monotonically changed genes as the disease progresses, which may be regarded as a special case of the feature selection for longitudinal data. The word “monotonic” means descending or ascending change patterns across time or stages/grades. To the best of our knowledge, no pathway-based algorithms have been proposed to tackle this specific topic. Therefore, more investigation is warranted to explore if a pathway-guided method is superior to a conventional method such as [75] in selecting monotonic genes. In summary, pathway-guided gene selection may play more roles on identifying potential biomarkers for longitudinal omics data.
6. Conclusions
In this article, we present a review on pathway-based feature selection algorithms. First, based on to what a feature corresponds, pathway-based feature selection methods are classified into three categories, pathway-level selection methods, bilevel selection methods, and pathway-guided gene selection methods. By focusing on the selection of individual genes where pathway information is incorporated as a prior to guide feature selection, pathway-guided gene selection methods were reviewed and discussed in detail. Additionally, given the importance of penalization in the process of feature selection, the commonly used penalty functions in a pathway-guided gene selection method were reviewed. Last, we point out one potential research area in which pathway-guided gene selection deserves more attention, namely, longitudinal gene expression data analysis.
We believe this review provides valuable insights for computational biologists/biostatisticians and stimulates them to develop more elegant pathway-guided gene selection algorithms. The development and wide application of such algorithms to reveal underlying pattern, elucidate the etiology and progression of complex diseases, and guide more “personalized” treatment strategies will contribute substantially to make biology more computable.
Acknowledgments
This study was supported by a fund (no. 31401123) from the Natural Science Foundation of China.
Contributor Information
Suyan Tian, Email: windytian@hotmail.com.
Chi Wang, Email: chi.wang@uky.edu.
Conflicts of Interest
No conflicts of interest have been declared.
Authors' Contributions
Suyan Tian and Chi Wang designed the study. Suyan Tian, Chi Wang, and Bing Wang wrote the paper. Suyan Tian and Chi Wang participated in the critical reviewing of the manuscript. All authors reviewed and approved the final manuscript.
References
- 1.Saeys Y., Inza I., Larrañaga P. A review of feature selection techniques in bioinformatics. Bioinformatics. 2007;23(19):2507–2517. doi: 10.1093/bioinformatics/btm344. [DOI] [PubMed] [Google Scholar]
- 2.Hira Z. M., Gillies D. F. A review of feature selection and feature extraction methods applied on microarray data. Advances in Bioinformatics. 2015;2015:13. doi: 10.1155/2015/198363. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Tibshirani R. Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society: Series B. 1996;58(1):267–288. [Google Scholar]
- 4.Dinu I., Potter J. D., Mueller T., et al. Improving gene set analysis of microarray data by SAM-GS. BMC Bioinformatics. 2007;8:p. 242. doi: 10.1186/1471-2105-8-242. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Wu D., Lim E., Vaillant F., Asselin-Labat M.-L., Visvader J. E., Smyth G. K. ROAST: Rotation gene set tests for complex microarray experiments. Bioinformatics. 2010;26(17):2176–2182. doi: 10.1093/bioinformatics/btq401. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Creixell P., Reimand J., Haider S., et al. Pathway and network analysis of cancer genomes. Nature Methods. 2015;12(7):615–621. doi: 10.1038/nmeth.3440. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Khatri P., Sirota M., Butte A. J. Ten years of pathway analysis: current approaches and outstanding challenges. PLoS Computational Biology. 2012;8(2) doi: 10.1371/journal.pcbi.1002375.e1002375 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Bayerlová M., Jung K., Kramer F., Klemm F., Bleckmann A., Beißbarth T. Comparative study on gene set and pathway topology-based enrichment methods. BMC Bioinformatics. 2015;16:p. 334. doi: 10.1186/s12859-015-0751-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Liu Q., Dinu I., Adewale A. J., Potter J. D., Yasui Y. Comparative evaluation of gene-set analysis methods. BMC Bioinformatics. 2007;8:p. 431. doi: 10.1186/1471-2105-8-431. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Dinu I., Potter J. D., Mueller T., et al. Gene-set analysis and reduction. Briefings in Bioinformatics. 2009;10(1):24–34. doi: 10.1093/bib/bbn042. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Goeman J. J., Bühlmann P. Analyzing gene expression data in terms of gene sets: Methodological issues. Bioinformatics. 2007;23(8):980–987. doi: 10.1093/bioinformatics/btm051. [DOI] [PubMed] [Google Scholar]
- 12.Hung J.-H., Yang T.-H., Hu Z., Weng Z., DeLisi C. Gene set enrichment analysis: Performance evaluation and usage guidelines. Briefings in Bioinformatics. 2012;13:281–291. doi: 10.1093/bib/bbr049.bbr049 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.García-Campos M. A., Espinal-Enríquez J., Hernández-Lemus E. Pathway analysis: state of the art. Frontiers in Physiology. 2015;6:1–16. doi: 10.3389/fphys.2015.00383. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Tarca A. L., Bhatti G., Romero R. A comparison of gene set analysis methods in terms of sensitivity, prioritization and specificity. PLoS ONE. 2013;8(11) doi: 10.1371/journal.pone.0079217. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Jaakkola M. K., Elo L. L. Empirical comparison of structure-based pathway methods. Briefings in Bioinformatics. 2016;17(2):336–345. doi: 10.1093/bib/bbv049. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Tian S., Wang C., Chang H. H., Sun J. Identification of prognostic genes and gene sets for early-stage non- small cell lung cancer using bi-level selection methods. Scientific Reports. 2017:1–8. doi: 10.1038/srep46164. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17.Eng K. H., Wang S., Bradley W. H., Rader J. S., Kendziorski C. Pathway index models for construction of patient-specific risk profiles. Statistics in Medicine. 2013;32(9):1524–1535. doi: 10.1002/sim.5641. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18.Breheny P., Riverside N., Cphb N., City I. The group exponential lasso for bi-level variable selection. Biometrics. 2015;71:731–740. doi: 10.1111/biom.12300. [DOI] [PubMed] [Google Scholar]
- 19.Lim K., Wong L. Finding consistent disease subnetworks using PFSNet. Bioinformatics. 2014;30(2):189–196. doi: 10.1093/bioinformatics/btt625. [DOI] [PubMed] [Google Scholar]
- 20.Tian S., Chang H. H., Wang C. Weighted-SAMGSR: Combining significance analysis of microarray-gene set reduction algorithm with pathway topology-based weights to select relevant genes. Biology Direct. 2016;11:p. 50. doi: 10.1186/s13062-016-0152-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Tusher V. G., Tibshirani R., Chu G. Significance analysis of microarrays applied to the ionizing radiation response. Proceedings of the National Acadamy of Sciences of the United States of America. 2001;98(9):5116–5121. doi: 10.1073/pnas.091062498. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Chuang H.-Y., Lee E., Liu Y.-T., Lee D., Ideker T. Network-based classification of breast cancer metastasis. Molecular Systems Biology. 2007;3:1–10. doi: 10.1038/msb4100180. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Johannes M., Brase J. C., Fröhlich H., et al. Integration of pathway knowledge into a reweighted recursive feature elimination approach for risk stratification of cancer patients. Bioinformatics. 2010;26(17):2136–2144. doi: 10.1093/bioinformatics/btq345. [DOI] [PubMed] [Google Scholar]
- 24.Morrison J. L., Breitling R., Higham D. J., Gilbert D. R. GeneRank: Using search engine technology for the analysis of microarray experiments. BMC Bioinformatics. 2005;6:p. 233. doi: 10.1186/1471-2105-6-233. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Zhang A., Tian S. Classification of early-stage non--small cell lung cancer by weighing gene expression profiles with connectivity information. Biometrical Journal. 2018;60(3):537–546. doi: 10.1002/bimj.201700010. [DOI] [PubMed] [Google Scholar]
- 26.Zhu Y., Shen X., Pan W. Network-based support vector machine for classification of microarray samples. BMC Bioinformatics. 2009;10(Suppl I):p. S21. doi: 10.1186/1471-2105-10-S1-S21. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27.Li C., Li H. Network-constrained regularization and variable selection for analysis of genomic data. Bioinformatics. 2008;24(9):1175–1182. doi: 10.1093/bioinformatics/btn081. [DOI] [PubMed] [Google Scholar]
- 28.Chen L., Xuan J., Riggins R. B., Clarke R., Wang Y. Identifying cancer biomarkers by network-constrained support vector machines. BMC Systems Biology. 2011;5:p. 161. doi: 10.1186/1752-0509-5-161. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Sokolov A., Carlin D. E., Paull E. O., Baertsch R., Stuart J. M. Pathway-based genomics prediction using generalized elastic net. PLoS Computational Biology. 2016;12(3):1–23. doi: 10.1371/journal.pcbi.1004790. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 30.Pan W., Xie B., Shen X. Incorporating predictor network in penalized regression with application to microarray data. Biometrics. 2010;66(2):474–484. doi: 10.1111/j.1541-0420.2009.01296.x. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 31.Breheny P., Huang J. Penalized methods for bi-level variable selection. Statistics and Its Interface. 2010;2(3):369–380. doi: 10.4310/SII.2009.v2.n3.a10. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Bandyopadhyay N., Kahveci T., Goodison S., Sun Y., Ranka S. Pathway-based feature selection algorithm for cancer microarray data. Advances in Bioinformatics. 2009;2009:16. doi: 10.1155/2009/532989.532989 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 33.Lee E., Chuang H.-Y., Kim J.-W., Ideker T., Lee D. Inferring pathway activity toward precise disease classification. PLoS Computational Biology. 2008;4 doi: 10.1371/journal.pcbi.1000217.e1000217 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34.Razi A., Afghah F., Singh S., Varadan V. Network-based enriched gene subnetwork identification?: a game-theoretic approach. Biomedical Engineering and Computational Biology. 2016;7:1–14. doi: 10.4137/BECB.S38244. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35.Zhang Q., Li J., Wang D., Wang Y. Finding disagreement pathway signatures and constructing an ensemble model for cancer classification. Scientific Reports. 2017:1–11. doi: 10.1038/s41598-017-10258-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 36.Zhang L., Wang L., Du B., Wang T., Tian P., Tian S. Classification of non-small cell lung cancer using significance analysis of microarray-gene set reduction algorithm. BioMed Research International. 2016;2016:8. doi: 10.1155/2016/2491671.2491671 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Doungpan N., Engchuan W., Chan J. H., Meechai A. GSNFS: Gene subnetwork biomarker identification of lung cancer expression data. BMC Medical Genomics. 2016;9 doi: 10.1186/s12920-016-0231-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38.Engchuan W., Meechai A., Tongsima S., Doungpan N., Chan J. H. Gene-set activity toolbox (GAT): a platform for microarray-based cancer diagnosis using an integrative gene-set analysis approach. Journal of Bioinformatics and Computational Biology. 2016 doi: 10.1142/S0219720016500153.1650015 [DOI] [PubMed] [Google Scholar]
- 39.Chan W. H., Mohamad M. S., Deris S., et al. Identification of informative genes and pathways using an improved penalized support vector machine with a weighting scheme. Computers in Biology and Medicine. 2016;77:102–115. doi: 10.1016/j.compbiomed.2016.08.004. [DOI] [PubMed] [Google Scholar]
- 40.Li C., Li X., Miao Y. SubpathwayMiner: a software package for flexible identification of pathways. Nucleic Acids Research. 2009;37 doi: 10.1093/nar/gkp667. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Parkinson H., Sarkans U., Kolesnikov N., et al. Arrayexpress update-An archive of microarray and high-throughput sequencing-based functional genomics experiments. Nucleic Acids Research. 2011;39(1):D1002–D1004. doi: 10.1093/nar/gkq1040. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42.Cun Y., Fröhlich H. F. Prognostic gene signatures for patient stratification in breast cancer - accuracy, stability and interpretability of gene selection approaches using prior knowledge on protein-protein interactions. BMC Bioinformatics. 2012;13 doi: 10.1186/1471-2105-13-69. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 43.Staiger C., Cadot S., Kooter R., et al. A critical evaluation of network and pathway-based classifiers for outcome prediction in breast cancer. PLoS ONE. 2012;7(4) doi: 10.1371/journal.pone.0034796. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Ogata H., Goto S., Sato K., Fujibuchi W., Bono H., Kanehisa M. KEGG: kyoto encyclopedia of genes and genomes. Nucleic Acids Research. 1999;27(1):29–34. doi: 10.1093/nar/27.1.29. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45.Ashburner M., Ball C. A., Blake J. A., et al. Gene ontology: tool for the unification of biology. The Gene Ontology Consortium. Nature Genetics. 2000;25(1):25–29. doi: 10.1038/75556. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Croft D., Mundo A. F., Haw R. The Reactome pathway knowledgebase. Nucleic Acids Research. 2014;42(1):D472–D477. doi: 10.1093/nar/gkt1102. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Auslander N., Wagner A., Oberhardt M., Ruppin E. Data-driven metabolic pathway compositions enhance cancer survival prediction. PLoS Computational Biology. 2016:1–17. doi: 10.1371/journal.pcbi.1005125. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48.Henriques D., Villaverde A. F., Rocha M., Saez-Rodriguez J., Banga J. R. Data-driven reverse engineering of signaling pathways using ensembles of dynamic models. PLoS Computational Biology. 2017;13(2) doi: 10.1371/journal.pcbi.1005379.e1005379 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 49.Langfelder P., Horvath S. WGCNA: an R package for weighted correlation network analysis. BMC Bioinformatics. 2008;9:p. 559. doi: 10.1186/1471-2105-9-559. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 50.Margolin A. A., Nemenman I., Basso K., et al. ARACNE: an algorithm for the reconstruction of gene regulatory networks in a mammalian cellular context. BMC Bioinformatics. 2006;7(supplement 1):p. S7. doi: 10.1186/1471-2105-7-s1-s7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 51.Yang S., Yuan L., Lai Y., Shen X., Wonka P., Ye J. Feature grouping and selection over an undirected graph. KDD. 2012:922–930. doi: 10.1145/2339530.2339675. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 52.Zhu Y., Shen X., Pan W. Simultaneous grouping pursuit and feature selection over an undirected graph. Journal of the American Statistical Association. 2013;108(502):713–725. doi: 10.1080/01621459.2013.770704. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Zhang W., Ota T., Shridhar V., Chien J., Wu B., Kuang R. Network-based survival analysis reveals subnetwork signatures for predicting outcomes of ovarian cancer treatment. PLoS Computational Biology. 2013;9(3) doi: 10.1371/journal.pcbi.1002975.e1002975 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Wu X., Tang H., Guan A., Sun F., Wang H., Shu J. Finding gastric cancer related genes and clinical biomarkers for detection based on gene-gene interaction network. Mathematical Biosciences. 2016;276:1–7. doi: 10.1016/j.mbs.2015.12.001. [DOI] [PubMed] [Google Scholar]
- 55.Li C., Li H. Variable selection and regression analysis for graph-structured covariates with an application to genomics. The Annals of Applied Statistics. 2010;4(3):1498–1516. doi: 10.1214/10-AOAS332. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 56.Luo C., Pan W., Shen X. A Two-Step Penalized Regression Method with Networked Predictors. Statistics in Biosciences. 2012;4(1):27–46. doi: 10.1007/s12561-011-9051-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 57.Kim S., Pan W., Shen X. Network-based penalized regression with application to genomic data. Biometrics: Journal of the International Biometric Society. 2013;69(3):582–593. doi: 10.1111/biom.12035. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 58.Yuan M., Lin Y. Model selection and estimation in regression with grouped variables. Journal of the Royal Statistical Society: Series B (Statistical Methodology) 2006;68(1):49–67. doi: 10.1111/j.1467-9868.2005.00532.x. [DOI] [Google Scholar]
- 59.Huang J., Breheny P., Ma S. A Selective review of group selection in high-dimensional models. Statistical Science. 2012;27(4):481–499. doi: 10.1214/12-STS392. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 60.Wu T. T., Lange K. Coordinate descent algorithms for lasso penalized regression. The Annals of Applied Statistics. 2008;2(1):224–244. doi: 10.1214/07-AOAS147. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 61.Dam S., Võsa U., van der Graaf A., Franke L., de Magalhães J. P. Gene co-expression analysis for functional classification and gene–disease predictions. Briefings in Bioinformatics. 2017:1–18. doi: 10.1093/bib/bbw139. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 62.Serin E. A., Nijveen H., Hilhorst H. W., Ligterink W. Learning from co-expression networks: Possibilities and challenges. Frontiers in Plant Science. 2016;7 doi: 10.3389/fpls.2016.00444. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 63.Leek J. T., Monsen E., Dabney A. R., Storey J. D. EDGE: Extraction and analysis of differential gene expression. Bioinformatics. 2006;22(4):507–508. doi: 10.1093/bioinformatics/btk005. [DOI] [PubMed] [Google Scholar]
- 64.Storey J. D., Xiao W., Leek J. T., Tompkins R. G., Davis R. W. Significance analysis of time course microarray experiments. Proceedings of the National Acadamy of Sciences of the United States of America. 2005;102(36):12837–12842. doi: 10.1073/pnas.0504609102. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 65.Xu P., Zhu L., Li Y. Ultrahigh dimensional time course feature selection. Biometrics: Journal of the International Biometric Society. 2014;70(2):356–365. doi: 10.1111/biom.12137. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 66.Wang L., Zhou J., Qu A. Penalized generalized estimating equations for high-dimensional longitudinal data analysis. Biometrics. 2012;68(2):353–360. doi: 10.1111/j.1541-0420.2011.01678.x. [DOI] [PubMed] [Google Scholar]
- 67.Zheng Y., Fei Z., Zhang W., et al. PGS: A tool for association study of high-dimensional microRNA expression data with repeated measures. Bioinformatics. 2014;30(19):2802–2807. doi: 10.1093/bioinformatics/btu396. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 68.Tian S., Wang C., Chang H. H. To select relevant features for longitudinal gene expression data by extending a pathway analysis method. F1000Research. 2018;7:p. 1166. doi: 10.12688/f1000research.15357.1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 69.Zhang L., Wang L., Tian P., Tian S., Brusgaard K. Identification of genes discriminating multiple sclerosis patients from controls by adapting a pathway analysis method. PLoS ONE. 2016;11(11):p. e0165543. doi: 10.1371/journal.pone.0165543.0165543 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 70.Tian S., Wang C., Chang H. H. A longitudinal feature selection method identifies relevant genes to distinguish complicated injury and uncomplicated injury over time. BMC Medical Informatics and Decision Making. 2018;18(S5) doi: 10.1186/s12911-018-0685-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 71.Guo Z., Zhang T., Li X., et al. Towards precise classification of cancers based on robust gene functional expression profiles. BMC Bioinformatics. 2005;6:p. 58. doi: 10.1186/1471-2105-6-58. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 72.Bild A. H., Yao G., Chang J. T., et al. Oncogenic pathway signatures in human cancers as a guide to targeted therapies. Nature. 2006;439(7074):353–357. doi: 10.1038/nature04296. [DOI] [PubMed] [Google Scholar]
- 73.Zhao S. D., Parmigiani G., Huttenhower C., Waldron L. Más-o-menos: a simple sign averaging method for discrimination in genomic data analysis. Bioinformatics. 2014;30(21):3062–3069. doi: 10.1093/bioinformatics/btu488. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 74.Drier Y., Sheffer M., Domany E. Pathway-based personalized analysis of cancer. Proceedings of the National Acadamy of Sciences of the United States of America. 2013;110(16):6388–6393. doi: 10.1073/pnas.1219651110. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 75.Wang H., Sun H., Chang T., et al. Discovering monotonic stemness marker genes from time-series stem cell microarray data. BMC Genomics. 2015;16(Suppl 2):p. S2. doi: 10.1186/1471-2164-16-S2-S2. [DOI] [PMC free article] [PubMed] [Google Scholar]