Skip to main content
BioData Mining logoLink to BioData Mining
. 2017 Jan 26;10:2. doi: 10.1186/s13040-017-0126-8

Meta-analytic support vector machine for integrating multiple omics data

SungHwan Kim 1,2, Jae-Hwan Jhong 1, JungJun Lee 1, Ja-Yong Koo 1,
PMCID: PMC5270233  PMID: 28149325

Abstract

Background

Of late, high-throughput microarray and sequencing data have been extensively used to monitor biomarkers and biological processes related to many diseases. Under this circumstance, the support vector machine (SVM) has been popularly used and been successful for gene selection in many applications. Despite surpassing benefits of the SVMs, single data analysis using small- and mid-size of data inevitably runs into the problem of low reproducibility and statistical power. To address this problem, we propose a meta-analytic support vector machine (Meta-SVM) that can accommodate multiple omics data, making it possible to detect consensus genes associated with diseases across studies.

Results

Experimental studies show that the Meta-SVM is superior to the existing meta-analysis method in detecting true signal genes. In real data applications, diverse omics data of breast cancer (TCGA) and mRNA expression data of lung disease (idiopathic pulmonary fibrosis; IPF) were applied. As a result, we identified gene sets consistently associated with the diseases across studies. In particular, the ascertained gene set of TCGA omics data was found to be significantly enriched in the ABC transporters pathways well known as critical for the breast cancer mechanism.

Conclusion

The Meta-SVM effectively achieves the purpose of meta-analysis as jointly leveraging multiple omics data, and facilitates identifying potential biomarkers and elucidating the disease process.

Electronic supplementary material

The online version of this article (doi:10.1186/s13040-017-0126-8) contains supplementary material, which is available to authorized users.

Keywords: Support vector machine, Meta-analysis, Data integration, TCGA

Introduction

Over the last decade, the technologies of microarray and massively parallel sequencing generate multiple omics sources from a large cohort at an unprecedented rate. Besides, since the experimental costs have dropped, a huge amount of data sets have been accumulated in public data repositories (e.g., Gene Expression Omnibus (GEO) and Sequence Read Archive (SRA)). And yet low reproducibility has been a chronic concern due to mid-and-small size of each individual experimental unit (e.g., 40–100) and low signal-to-noise ratios of genomic expression data [24, 26, 27]. In an effort to tackling these challenges, effective data integration methods have been widely spotlighted in biomedical research [2]. The traditional meta-analysis integrates significance levels or effect sizes of similar data sets (similar design or biological hypothesis), and has proven to be effective in discovering significant biomarkers [14, 37]. Multi-study data integration is also known as “horizontal meta-analysis” that combines multiple homogeneous omics data [38]. Moreover, many large consortia such as the Cancer Genome Atlas (TCGA) and Lung Genomics Research Consortium (LGRC) have generated different types of omics data (e.g., mRNA, methylation, CNV and so on) using samples from a single cohort. Datasets are aligned vertically by samples, and thus integration of such multi-omics data is called “vertical omics integrative analysis” [38]. Jointly leveraging multi-layers of omics data, vertical omics integration facilitates deciphering biological processes, capturing the interplay of multi-level genomic features, and elucidating how a priori knowledge of biological information (e.g., pathway database) functions within the framework of systems biology.

Generally high-throughput microarray and sequencing data have been extensively applied to monitor biomarkers and biological processes related to many diseases [4], to predict complex diseases (e.g., cancer diagnosis, [36]), prognosis [45], and therapeutic outcomes [23]. In particular, the recent classification and prediction tools have notably advanced the translational and clinical applications (e.g. MammaPrint [43]), Oncotype DX [30] and Breast Cancer Index BCI [49]. In this trend, the support vector machine (SVM) has been also popularly applied to many genomic applications and proved as one of the most powerful prediction methods [3, 15, 29] attributed to unmatched flexibility of non-linear decision boundary. Commonly gene selection (a.k.a. feature reduction) pertaining to outcomes diminishes the dimension of expression data, enabling to shorten the training time and to enhance interpretability. In addition, gene selection removes a large number of irrelevant genes that potentially undermine precise prediction, and notably the idea of feature selection using SVMs can extend to the setting of multi-omics data analysis ([18, 25]). As this concern related, many researchers have put tremendous efforts to circumvent low accuracy of the SVMs when analyzing high-dimensional genomic data. For instance, Brown et al. [5] introduced a functional gene classification including the usage of various similarity functions (e.g., kernels modeling prior knowledge of genes). Moreover, as SVM takes on the small subset of samples that differentiate between class labels with an exclusion of the remaining samples, it is believed to have the potential to handle large feature spaces and the ability to identify outliers. Guyon et al. [9] also proposed a gene selection method that utilizes the SVM based on Recursive Feature Elimination (RFE) recursively removing insignificant features to increase classification performance. In spite of SVM’s outstanding fortes in many applications, the current SVMs are only focused towards single data analysis, and so inevitably run into the problem of low reproducibility. To address this problem, we propose a meta-analytic framework based on the support vector machine (Meta-SVM). The proposed Meta-SVM is motivated by the recent meta-analytic method exploiting the meta-analytic logistic regression (Meta-logistic; [22]). To our best knowledge, no method has been introduced, which extends the SVMs to combining multiple studies in a meta-analytic fashion. Related to this, we develop a novel implementation strategy in spirit of Newton’s method to estimate parameters of the Meta-SVM. It is commonplace that the objective function of SVM is formed with the hinge loss and a range of penalty terms (e.g., L 1-lasso, group lasso and etcs). Importantly we, however, adopts the sparse group lasso technique (i.e., both L 1-lasso and group lasso, simultaneously) to capture both common and study specific genetic effects across all studies. The proposed method, on this ground, achieves the identical purpose of rOP [41] and AW [21], meta-logistic [22] whose feature selection allows to detect specific effects. In genomic applications, it cannot be emphasized enough that data integration analysis has proved its practical utility and has become commonplace to identify key regulators of cancer. Thus, many have paid attention to credible validation strategies that build on multiple studies [7, 35]. Besides, meta-analysis essentially aids to adjust tissue specific effects possibly distorting the analysis of individual datasets [21]. The optimization strategy to estimate, therefore, focuses on how to maneuver these two terms (L 1-lasso and group lasso) in the formula. To overcome some of known traditional optimization rules (e.g., linear and quadratic programming), which mostly entails heavy computing tasks, we propose an approximation method to relax computational complexity in favor of concise implementation. The idea is to approximate the hinge loss including but not limited to penalty terms by a quadratic form, and thereby we can apply the classical coordinate descent algorithm to optimize the whole objective function.

The paper is outlined as follows. In Methods section, we introduce the meta-analytic method that builds on the support vector machine (Meta-SVM) and its implementation strategy at length. Simulation studies section shows experimental studies to benchmark performance of feature detection under various experimental scenarios. In Applications to real genomic data section, we demonstrate the advantages of Meta-SVM in two real data applications using publicly available omics data, and concluding remarks are presented in Concluding remark section. An R package “metaSVM” is publicly available online at author’s github page (https://sites.google.com/site/sunghwanshome/).

Methods

Meta-analytic support vector machine (Meta-SVM)

Consider M independent studies, consisting of n (m) subjects of m-th study for 1≤mM. Let yi(m) be a scalar of binary phenotypes and xi(m)=xi1(m),,xip(m) be a vector, each containing p common variables of the i-th subject for 1≤in (m) and 1≤mM. We consider an objective function of the L 1 support vector machine using the single m-th data set

Qλβ(m)=i=1n(m)1yi(m)fxi(m);β(m)++λj=1p|βj(m)|, 1

where λ>0, fxi(m);β(m)=β0(m)+j=1pxij(m)βj(m) for 1≤in (m) and β(m)=β0(m),,βp(m)Rp+1. Due to the linearity of fxi(m);β(m), this is typically known as the linear support vector machine. And our major interest is to estimate the solution of β (m) that minimizes (1). By extension, in pursuit of integrating the M studies to a unified model, we propose the meta-analytic support vector machine that builds on multiple data via both group lasso and L 1 lasso (a.k.a sparse group lasso):

Qλ1,λ2(β)=m=1Mi=1n(m)1yi(m)fxi(m);β(m)++λ1j=1pm=1Mβj(m)2+λ2m=1Mj=1p|βj(m)|, 2

where λ 1,λ 2>0, β=(β (1),…,β (M)). Here it is interesting to note that the group lasso penalty, m=1Mβj(m)2 comes into play to integrate the effect size of the j-th variable across M data sets. Of note, the L 1 lasso penalty encourages the sparsity within a group that potentially circumvents the all-in and all-out fashion. Thus, this property is in line with meta-analytic feature selection even when heterogeneous studies are present in analysis, since the sparse group lasso allows to accommodate both common effects across all studies and study specific effects simultaneously. Let

β^(m)=argminβ(m)Rp+1Qλ1,λ2β(m)

be the sparse group lasso estimator of the meta-analytic support vector machine for m-th study for 1≤mM.

Implementation strategy

For estimating β, the SVM traditionally exploits the linear or quadratic programming well-suited to SVM’s dual problem. To our best knowledge, no coordinate descent-type optimization has yet been proposed to address the sparse group lasso problem despite the coordinate-type approach’s utility for implementation. The coordinate descent algorithm is one of the most popular algorithms that are built on the convexity assumption. To apply this algorithm to (2), an approximation to the smooth objective function is required on account of the non-differential property of the hinge loss and the group lasso penalty. With a little of algebraic trick, the group lasso penalty can be made twice-differentiable. Precisely, we add some sufficiently small constant inside the square root, in the way that the first and second derivative of the L 1-lasso and group lasso penalty terms can be made at βj(m)=0. When it comes to the non-differential hinge loss, Zhang et al. [48] proposed the successive quadratic algorithm (SQA): a generalization of Newton’s method for unconstrained optimization such that it finds a step away from the current point of iteration by minimizing a quadratic approximation of the problem. Taken together, the objective function (2) can be approximated to

Q~λ1,λ2(β)=m=1M1212n(m)i=1n(m)yi(m)f(xi(m);β(m))+14n(m)i=1n(m)|yi(m)f(xi(m);β(m))|+14n(m)i=1n(m)[yi(m)f(xi(m);β(m))]2|yi(m)f(xi(m);β(m))|+λ1j=1pm=1Mβj(m)2+λ2m=1Mj=1p|βj(m)|, 3

where β (m)∗ is an estimated coefficient vector at the current point for 1≤mM. Contrary to (2), Q~λ1,λ2(β) is differentiable with respect to β, convex and separable with respect to all of variables so that we can apply the coordinate descent algorithm by means of Newton’s method. Update

βj(m)(t+1)βj(m)(t)Q~λ1,λ2β0(m)(t+1),,βj1(m)(t+1),βj(m)(t),,βp(m)(t)j+12Q~λ1,λ2β0(m)(t+1),,βj1(m)(t+1),βj(m)(t),,βp(m)(t)j+1,j+1 4

and iterate for 1≤jp and 1≤mM until convergence. More details are provided in Appendix.

Simulation studies

To evaluate the performance of the proposed Meta-SVM method in the genomic setting, we simulated expression profiles with arbitrary correlated gene structures and variable effect sizes as follows: Simulate gene correlation structure for P=30 genes, N=20 samples in each study, and M=3. In each study, 10 out of 30 genes belong to C=2 independent clusters.

  • Randomly sample gene cluster labels of 30 genes (C p∈{0,1,2} and 1≤pP), such that C=2 clusters each containing 5 genes are generated (Σp=1P1(Cp=c)=5, 1≤cC=2) and the remaining 20 genes are unclustered genes (Σp=1P1(Cp=0)=20).

  • For any cluster c (1≤cC) in study m (1≤mM), sample Σc(m)W1(ψ,60), where ψ=0.5I 5×5+0.5J 5×5, W −1 denotes the inverse Wishart distribution, I is the identity matrix and J is the matrix with all the entries being 1. Set vector σc(m) as the square roots of the diagonal elements in Σc(m). Calculate σc(m) such that σc(m)Σc(m)σc(m)=Σc(m).

  • Denote by p1(c),,p5(c) as the indices for genes in cluster c. In other words, Cpj(c)=c, where 1≤c≤2 and 1≤j≤5. Sample expression of clustered genes by Xp1(c)n(m),,Xp5(c)n(m))MVN(0,RΣc(m)), where 1≤nN=20, 1≤mM and R is an arbitrary constant for adjusting of total variance (R=1 as default). Sample expression for unclustered genes Xpn(m)N(0,R) for 1≤nN and 1 ≤mM if C p=0.

  • To simulate differential expression pattern, sample effect sizes μp(m) from Unif(0.1,0.5) for 1≤p≤10 as differential expression (DE) genes and set μp(m)=0 for 11≤pP as non-DE genes.

  • For the first 10 control samples, Ypn(m)=Xpn(m)(1pP,1nN/2=10, 1≤mM). For cases, Yp(n+10)(m)=Xp(n+10)(m)+μp(m)(1pP,1nN/2=10,1mM).

All tuning parameters (λ 1 and λ 2) are chosen by cross-validation, and the simulations were repeated 50 times. Table 1 summarizes the results of all simulation studies. It is noteworthy that the Meta-SVM achieves higher Youden index (= sensitivity + specificity −1) compare to the meta-logistic regression model across all experimental scenarios (i.e., R=0.1,0.3 and 0.5), and thus this suggests the Meta-SVM performs better in identifying the true signal features. Given that the meta-logistics model results in low sensitivity, the meta-logistic model has a tendency to overly penalize the effect size of features. In contrast, when data are sampled with low variance (R=0.1), specificity of the meta-logistic model is shown to be a little higher than that of the Meta-SVM (e.g., 1, 0.997 and 0.994 for the Meta-logistic, and 0.9843, 0.9837 and 0.9737 for the Meta-SVM), and yet the meta-logistic model still suffers low sensitivity at the expense of high specificity. Inspired by the simulation design introduced by meta-analysis of rth ordered p-value (rOP) [41], we also designed simulation schemes such that only a few studies provide major signals that differentiate binary outcomes like real data. To this end, we replaced signal genes of one or two studies with complete random noise (i.e., sampled from N(0,R); no signal genes). This leads to only one or two signal genes, respectively, among three data sets. Under this simulation scenario, the Meta-SVM still performs better as in Table 1, presenting higher Youden index than the meta-logistic model no matter how many random noises are imposed.

Table 1.

Shown are the results of experimental studies to compare the meta-logistic model with the meta-analytic SVM

Meta-SVM Meta-logistic regression
Variance (R) Sensitivity (SE) Specificity (SE) Youden Sensitivity (SE) Specificity (SE) Youden
No inclusion of random study
0.1 0.828 (0.001) 0.9843 (0) 1.812 0.1073 (0) 1 (0) 1.107
0.3 0.8127 (0.002) 0.8707 (0.001) 1.683 0.2087 (0.001) 0.996 (0) 1.205
0.5 0.76 (0.002) 0.867 (0.001) 1.627 0.2633 (0.001) 0.9123 (0.001) 1.176
Inclusion of one random study
0.1 0.8007 (0.011) 0.9837 (0.002) 1.784 0.102 (0.004) 0.997 (0.001) 1.099
0.3 0.6673 (0.013) 0.8497 (0.009) 1.517 0.2113 (0.009) 0.966 (0.005) 1.177
0.5 0.6013 (0.017) 0.852 (0.009) 1.453 0.2527 (0.01) 0.8667 (0.008) 1.119
Inclusion of two random studies
0.1 0.624 (0.016) 0.9737 (0.009) 1.598 0.0847 (0.005) 0.994 (0.001) 1.079
0.3 0.51 (0.016) 0.8433 (0.006) 1.353 0.1727 (0.011) 0.9317 (0.005) 1.104
0.5 0.4167 (0.012) 0.85 (0.009) 1.267 0.256 (0.012) 0.8193 (0.006) 1.075

Applications to real genomic data

In this section, we apply the Meta-SVM methods to two real examples of idiopathic pulmonary fibrosis expression profiles (IPF; 221 samples in four studies of binary outcome (i.e., case and control)) and breast cancer expression profiles provided by The Cancer Genome Atlas (TCGA) including mRNA, copy number variation (CNV) and epigenetic DNA methylation (http://cancergenome.nih.gov/; 300 samples of estrogen receptor binary outcome (i.e., ER+ and ER-)). It should be noticed that we integrate in the first application (IPF) four homogeneous studies in a fashion of horizontal integration, whereas we align in the second application (breast cancer) three genomic data by the common cohort in the context of vertical integration. Integrating multilevel-omics data is reasonable, in that inter-regulation flows in systems biology are present from CNV to mRNA and from DNA methylation to mRNA [16]. Therefore, these inter-omics features aligned on identical protein coding regions can be jointly estimated in the group lasso. Table 2 outlines the data descriptions, for a total of seven data sets and source references. In the pre-processing stage, genes and DNA methylation probes were matched across homogeneous studies and multi-omics data, and centered with scaling. Non-expressed and/or non-informative genes were filtered according to the rank sum of mean intensities and variances across studies. Importantly noted is that this filtering procedure has been used in a previous meta-analysis work [47] and this filtering step is unbiased since class labels are not involved in the process. This generated 110 common genes in IPF study and 108 common genes and matched methylation probes in TCGA for down-stream prediction analysis.

Table 2.

Shown are the brief descriptions of the eight microarray datasets of disease-related binary phenotypes (e.g., case and control). All datasets are publicly available

Name Study Type # of samples Control Case Reference
TCGA breast cancer mRNA 300 234 (ER+) 66 (ER-) The Cancer Genome Atlas (TCGA)
TCGA breast cancer Methylation 300 234 (ER+) 66 (ER-) The Cancer Genome Atlas (TCGA)
TCGA breast cancer CNV 300 234 (ER+) 66 (ER-) The Cancer Genome Atlas (TCGA)
KangA (batch 1) IPF mRNA 63 11 52 Kang et al (2012). GSE47460
KangB (batch 2) IPF mRNA 96 21 75 Kang et al. (2012) GSE47460
Konishi IPF mRNA 38 15 23 Konishi et al. (2009), GSE10667
Pardo IPF mRNA 24 11 13 Pardo et al. (2005), GSE2052

We applied gene set enrichment analysis to TCGA breast cancer data to figure out if our identified gene sets are in line with underlying biological pathways from the KEGG database [12]. It is notable that the identified gene set of the TCGA multiple omics data in Table 3 is significantly enriched in the ABC transporters pathways, which is already well-known to be correlated to breast cancer mechanisms, particularly related to estrogen receptor and drug resistance [8,28]. To our surprise, the ABC transporters pathway is considerably relevant to breast cancer mechanisms in many ways. For instance, breast cancer resistance protein (BCRP) is an ATP-binding cassette (ABC) transporter known as a molecular cause of multidrug resistance (MDR) in diverse cancer cells [46]. Besides Nakanishi et al. [28] discovered that up-regulation of BCRP mRNA expression was shown in estrogen receptor (ER)-positive breast cancer. This identified pathway has been consistently verified as critical for cancer outcomes and sensitivity to therapeutic treatments [8,19]. In previous study under the similar design [10], ABCC8 and ABCC11 in Table 3 are believed to be modifiers of progression and response to the chemotherapy of breast cancer.

Table 3.

This table includes selected features of multiple omics data via the Meta-SVM

Four studies of lung disease (IPF)
C20orf114 MMP7 CXCL14 AGER TMEM100 THY1 CXCL2 HSD17B6 CCL18 CPA3 GEM
LEPREL1 ANXA3 CYP1B1 LRRC32 EMP2 FHL2 ADM C7 ITGA7 IGFBP2 BACE2 FKBP11
RGS5 FCGR3A SRPX FBLN2 HPCAL1 SOX4 CD248 CLDN5 LTBP1 ALOX5AP
Three multi-omics data of breast cancer (TCGA)
ABCC11 ABCC8 ACOX2 CAMP CST9L GRPR LAMP3 LCN2 LTF
MUCL1 NME5 THRSP VTCN1
- This gene set is significantly enriched in the ABC transporters (KEGG)
(FDR adjusted p-value = 0.025).

Generally idiopathic pulmonary fibrosis (IPF) is one of fatal lung diseases with a poor prognosis. Thus, it is quite imperative to monitor potential predictors of outcome. The original studies in Table 2 [17,32] posed a hypothesis on molecular biomarkers associated with IPF, and presented differentially expressed (DE) genes that distinguish IPF and control patients. For instance, Konishi et al. [17] identified in qRT-PCR microarray experiments MMP7, AGER and MMP7 are significantly higher and AGER is significantly lower in IPF. Pardo et al. [32] also pointed out that MMP7 is more significantly overexpressed compared with control lungs. Note that Meta-SVM is shown to be consistent with known evidence as detecting AGER and MMP7. Our findings in Table 3 also include CCL18. Importantly, it has been repeatedly reported that expression of CCL18 relates to course of pulmonary function parameters in patients with pulmonary fibrosis [33,34]. However, there was a little discrepancy regarding the roles of CCL18 according to the previous studies [31,33]. And yet, since the Meta-SVM incorporates multiple data together, we can still give more credence to CCL18 as a molecular biomarker to predict IPF.

Of the 33 identified genes of IPF data (See Table 3 and Additional file 1: Table S1), we further reduce the number of genes for post-hoc analysis by exploring significant gene modules, equivalently gene-gene interaction, via Netbox [6]. NetBox is an analytic software well-suited to detect connecting genes to a network, identifying statistically significant “linker” genes on the basis of four public data sources: NCI-Nature Pathway Interaction Database [40], Human Protein Reference Database [13], MSKCC Cancer Cell Map (http://www.mskcc.org/), and Reactome [11]. We implemented gene-gene interaction analysis, and successfully detected four gene modules, each of which constitutes mutually correlated genes. Additional file 1: Figure S1 displays the structure of combined networks based on four distinct gene modules. Focusing on the genes that belong to the four modules, we examine on MMP7 [32,44,50], LTBP1 [20], FHL2 [1], CXCL2 [42], THY1 [39] and AGER [17] to confirm whether or not these are associated with IPF (See Additional file 1: Table S3). MMP7 is traditionally thought of as the predictive signature since MMP7 of IPF patients is among the molecules that are more significantly overexpressed compared with control lungs [32]. More interestingly, Bauer et al. [1] identified a novel set of 12 disease-relevant translational gene markers including FHL2, MMP7 that are able to separate almost all patients with IPF from control subjects in multiple large-scale cohorts. Related to CXCL2, [42] investigated the pathogenesis of pulmonary fibrosis relevant to the imbalance in the expression of these angiogenic and angiostatic CXC chemokines. This study demonstrates in the bleomycin model that the amount of CXCL2 is found positively correlated with measures of fibrosis. When it comes to novel therapeutic targets, profiling DNA methylation changes to fibrosis has been increasingly spotlighted by observing hypomethylation of oncogene promoters. In doing so, Sanders et al. [39] reported that hypermethylation epigenetically decreases THY1 (See Additional file 1: Table S3) in IPF fibroblasts as IPF suppressor genes. Taken together, the Meta-SVM is found to be efficient in identifying potential biomarkers that facilitate elucidating the disease process.

Concluding remark

In this article, we introduce a meta-analytic framework using the support vector machine. The objective function of Meta-SVM applies the hinge loss and the sparse group lasso, and so we also develop a novel strategy for implementing the sparse group lasso in the context of Newton’s method. More importantly, the proposed Meta-SVM shows many advantages in discovering the underlying true signals and in detecting gene sets enriched for cancer disease process validated as biologically significant. Putting all things together, we conclude that the proposed meta-SVM is a reasonable choice to effectively achieve the common aims of meta-analysis. This is not that surprising given that the Meta-SVM takes advantages of the meta-analytic design that jointly leverages multiple omics data. For future study, we may improve computational speed via low-level programming languages (e.g., C/C++ or Fortran) since coordinate descent algorithm sometimes leads to heavy computation due to slow convergence at the exchange of the straightforward algorithm structure. Usage of diverse kernels (e.g., quadratic and radial basis kernels) can be a possible choice to improve performance of feature discovery, and prediction accuracy. Moreover, it is worthwhile to impose interaction terms in the model, making it possible to account for the complex association among genomic features. We leave these ideas for future tasks.

Appendix

Optimization of a penalized univariate quadratic function

Univariate Lasso problem

Consider a quadratic function q defined as

q(z)=b2(zc)2+dforzR,

where b>0 and c,dR. Let q λ be a penalized quadratic function given as

qλ(z)=q(z)+λzforzR

and denote

zλ=argminzRqλ(z).

Note that b=q(z)zR and c=argminzRq(z) since c is the solution to q (z)=0.

Theorem 1

The minimizer z λ of q λ is given by

zλ=STc,λb, 5

where the soft-thresholding operator is defined by

ST(y,λ)=yλify>λy+λify<λ0ifyλ

for yR and λ>0.

Univariate Sparse group lasso problem

Let

qλ1,λ2(z)=b2(zc)2+λ1z2+d+λ2zforzR, 6

where b>0, d≥0 and cR. If d=0, then the univariate sparse group lasso problem becomes the univariate lasso problem. Equivalently,

qλ1,λ2(z)=b2(zc)2+(λ1+λ2)zforzR

and we have

zλ1,λ2=STc,(λ1+λ2)/b.

Consider the univariate sparse group lasso problem with d>0. Let F s(z) be the form of the cdf of the logistic distribution with a scale parameter s>0, which is given by

Fs(z)=2exp(z/s)1+exp(z/s)1.

An approximation to qλ1,λ2 is

q~λ1,λ2(z)=b2(zc)2+λ1z2+d+λ2zFs(u)duforzℝ.

When s is sufficiently small, z~λ1,λ2=argminzRq~λ1,λ2(z) is close to

zλ1,λ2=argminzRqλ1,λ2(z).

Using the Newton-Raphson method, we can find z~λ1,λ2. Note

dq~λ1,λ2(z)dz=b(zc)+λ1zz2+d+λ2Fs(z)forzR

and

d2q~λ1,λ2(z)dz2=b+λ1d(z2+d)3+λ2ws(z)forzR

where

ws(z)=12sFs(z)1+Fs(z).

Starting from an initial value z (0), we iterate

z(t+1)=z(t)dq~λ1,λ2(z(t))/dzd2q~λ1,λ2(z(t))/dz2.

Implementation for the meta-analytic SVM

In order to estimate the solution of β (m), we approximate (3) to the univariate quadratic function, and then apply the Newton-Raphson method. To derive the quadratic form, we revisit the successive quadratics algorithm [48]. For each 1≤in (m) and 1≤mM, we have yi(m)2=1 and

1yi(m)fxi(m);β(m)+=1yi(m)fxi(m);β(m)2+yi(m)fxi(m);β(m)2 7

Assume β(m) is given, we consider the local quadratic approximation for the second term in (7):

yi(m)fxi(m);β(m)12yi(m)fxi(m);β(m)2yi(m)fxi(m);β(m)+12yi(m)fxi(m);β(m),

where β (m)∗ is an estimated coefficient vector at the current point. The quadratic form approximated to the entire objective function (3).

Given β~(m)=β~0(m),,β~p(m)Rp+1, the function Q~λ1,λ2β~0(m),,β~j1(m), βj(m),β~j+1(m),,β~p(m) is an univariate sparse group quadratic function of the form (6) with argument z=βj(m) with suitable b,c,d. We update βj(m) by the minimizer of Q~λ1,λ2β~0(m),,β~j1(m),βj(m),β~j+1(m),,β~p(m) for 0≤jp and 1≤mM. Let

X(m)=1x11(m)x1p(m)1xn(m)1(m)xn(m)p(m)Rn(m)×(p+1),y(m)=y1(m)yn(m)(m)Rn(m),
Z(m)=y1(m)y1(m)x11(m)y1(m)x1p(m)yn(m)yn(m)(m)xn(m)1(m)yn(m)(m)xn(m)p(m)Rn(m)×(p+1)

and

W(m)=diagw1(m),,wn(m)(m)=w1(m)wn(m)(m)Rn(m)×n(m),

where

wi(m)=yi(m)f(xi(m);β(m))1fori=1,,n(m).

Observe

i=1n(m)yi(m)f(xi(m);β(m))=1Z(m)β(m)for1=11Rn(m)

and

i=1nyi(m)f(xi(m);β(m))2yi(m)f(xi(m);β(m))=y(m)X(m)β(m)W(m)y(m)X(m)β(m)=y(m)W(m)y(m)2β(m)X(m)W(m)y(m)+β(m)X(m)W(m)X(m)β(m).

Combining these, we obtain

Q~λ1,λ2β(m)=12n(m)1Z(m)β(m)+14n(m)y(m)W(m)y(m)2β(m)X(m)W(m)y(m)+β(m)X(m)W(m)X(m)β(m)+λ1j=1pm=1Mβj(m)2+λ2m=1Mj=1pβj(m). 8

The gradient and the Hessian matrix of Q~λ1,λ2 are, respectively, given as

Q~λ1,λ2β(m)=12n(m)X(m)W(m)y(m)X(m)β(m)+Z(m)1+λ1B1+λ2B2, 9

and

2Q~λ1,λ2β(m)=12n(m)X(m)W(m)X(m)+λ1B1′′+λ2B2′′, 10

where

B1=0β1(m)β1(m)2+d1+εβp(m)βp(m)2+dp+ε,B1′′=0d1β1(m)2+d1+ε3dpβp(m)2+dp+ε3,
B2=0Fsβ1(m)Fsβp(m),B2′′=0wsβ1(m)wsβp(m),

dj=kjβk(m)2 and a sufficiently small positive constant ε for 1≤jp. We propose the following algorithm to solve the meta-analytic SVM via Newton’s method in a fashion of coordinate descent algorithm:

Table 4.

An algorithm for the meta-analytic SVM via Newton’s method

Step 1: For 1≤mM, set the initial value β(m)(0).
Step 2: Set t=0 and minimize Q~λ1,λ2βj(m) via Newton’s method:
βj(m)(t+1)βj(m)(t)Q~λ1,λ2β0(m)(t+1),,βj1(m)(t+1),βj(m)(t),,βp(m)(t)j+12Q~λ1,λ2β0(m)(t+1),,βj1(m)(t+1),βj(m)(t),,βp(m)(t)j+1,j+1
for 0≤jp and 1≤mM.
Step 3: Update t=t+1 and go to Step 2 until convergence.

Acknowledgements

The authors would like to thank the AE and reviewers.

Funding

The authors are supported by the Basic Science Research Program through the National Research Foundation of Korea (NRF) funded by the Ministry of Education, Science and Technology (NRF-2015R1D1A1A01057747 and 2016R1A6A3A01009142).

Availability of data and materials

All of data sets were publicly available at the GEO (http://www.ncbi.nlm.nih.gov/geo/;GSE47460, GSE10667 and GSE2052) and TCGA data portal (http://cancergenome.nih.gov; See Table 2 for details).

Authors’ contributions

SH and J-Y contributed to method development, study design, paper writing, implementing codes and interpretations. JJ and J-H contributed to data preparation and paper writing. All authors read and approved the final manuscript.

Competing interests

The authors declare that they have no competing interests.

Consent for publication

Not applicable.

Ethics approval and consent to participate

The results of the pan-cancer and interstitial pulmonary fibrosis (IPF) were based on microarray data downloaded from TCGA Research Network and Gene Expression Omnibus (GEO), which precluded the need for Institutional Review Board (IRB) approval and written informed consents.

Additional file

Additional file 1 (187.5KB, docx)

Table S1. The Meta-SVM’s coefficient of lung disease mRNA data. Table S2. The Meta-SVM’s coefficient of TCGA breast cancer multi-level omics data. Table S3. Gene-gene interaction analysis using 33 identified genes of IPF mRNA data. Figure S1. Gene networks that display the relationships among significant genes. The orange nodes are the selected linker genes out of 33 genes in Table 3. The blue nodes indicate linker genes not presented in the original input list, but are significantly connected to members of the input list. (DOCX 187 kb)

Contributor Information

SungHwan Kim, Email: swiss747@korea.ac.kr.

Jae-Hwan Jhong, Email: jjh0925@korea.ac.kr.

JungJun Lee, Email: ljjojchandler@gmail.com.

Ja-Yong Koo, Email: jykoo@korea.ac.kr.

References

  • 1.Bauer Y, Tedrow J, de Bernard S, Birker-Robaczewska M, Gibson K, et al. A novel genomic signature with translational significance for human idiopathic pulmonary fibrosis. Am J Respir Cell Mol Biol. 2015;52(2):217–31. doi: 10.1165/rcmb.2013-0310OC. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Begum F, Ghosh D, Tseng G, Feingold E. Comprehensive literature review and statistical considerations for gwas meta-analysis. 2012; 40(9):3777–84. [DOI] [PMC free article] [PubMed]
  • 3.Ben-Hur A, Ong C, Sonnenburg S, Schölkopf B, Rätsch G. Support vector machines and kernels for computational biology. PLoS Comput Biol. 2008;4(10):000173. doi: 10.1371/journal.pcbi.1000173. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4.Bhattacharya S, Mariani T. Array of hope: expression profiling identifies disease biomarkers and mechanism. Biochem Soc Trans. 2009;37(4):855–62. doi: 10.1042/BST0370855. [DOI] [PubMed] [Google Scholar]
  • 5.Brown M, Grundy W, Lin D, Christianini N, Sugnet C, et al.Support vector machine classification of microarray gene expression data. Technical-Report University of California, Santa Cruz. 1999.
  • 6.Cerami E, Demir E, Schultz N, Taylor B, Sander C. Automated network analysis identifies core pathways in glioblastoma. PLoS ONE. 2010;12:e8918. doi: 10.1371/journal.pone.0008918. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.ElHefnawi M, Soliman B, Abu-Shahba N, Amer M. An Integrative Meta-analysis of MicroRNAs in Hepatocellular Carcinoma. Genomics Proteomics Bioinformatics. 2013;11(6):354–67. doi: 10.1016/j.gpb.2013.05.007. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Fletcher J, Haber M, Henderson M, Norris M. ABC transporters in cancer: more than just drug efflux pumps. Nat Rev. 2010;10(2):147–56. doi: 10.1038/nrc2789. [DOI] [PubMed] [Google Scholar]
  • 9.Guyon I, Weston J, Barnhill S. Gene selection for cancer classification using support vector machines. Mach Learn. 2002;46:389–422. doi: 10.1023/A:1012487302797. [DOI] [Google Scholar]
  • 10.Hlavac V, Brynychova V, Vaclavikova R, Ehrlichova M, Vrana D, et al. The expression profile of ATP-binding cassette transporter genes in breast carcinoma. Pharmacogenomics. 2013;14(5):515–29. doi: 10.2217/pgs.13.26. [DOI] [PubMed] [Google Scholar]
  • 11.Joshi-Tope G, Gillespie M, Vastrik I, D’Eustachio P, Schmidt E, et al. Reactome: A knowledgebase of biological pathways. Nucleic Acids Res. 2005;33:428–32. doi: 10.1093/nar/gki072. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Kanehisa M, Goto S. Kyoto Encyclopedia of Genes and Genomes (KEGG) Nucleic Acids Res. 2000;28:27–30. doi: 10.1093/nar/28.1.27. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Keshava T, Goel R, Kandasamy K, Keerthikumar S, Kuar S, et al. Human protein reference database-2009 update. Nucleic Acids Res. 2009;37(Database issue):767–72. doi: 10.1093/nar/gkn892. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Kim S. MetaKTSP: a meta-analytic top scoring pair method for robust cross-study validation of omics prediction analysis. Bioinformatics. 2016;32(13):1966–73. doi: 10.1093/bioinformatics/btw115. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Kim S. Weighted K-means support vector machine for cancer prediction. Springerplus. 2016;5(1):1162. doi: 10.1186/s40064-016-2677-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Kim S, Oesterreich S, Kim S, Park Y, Tseng G. Integrative clustering of multi-level omics data for disease subtype discovery using sequential double regularization. Biostatistics. 2016. doi:10.1093/biostatistics/kxw039 [DOI] [PMC free article] [PubMed]
  • 17.Konishi K, Gibson K, Lindell K, Richards T, Zhang Y, et al. Gene expression profiles of acute exacerbations of idiopathic pulmonary fibrosis. Am J Respir Crit Care Med. 2009;180(2):167–75. doi: 10.1164/rccm.200810-1596OC. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18.Kwon MS, Kim Y, Lee S, Namkung J, Yun T, et al. Integrative analysis of multi-omics data for identifying multi-markers for diagnosing pancreatic cancer. BMC Genomics. 2015;16(Suppl 9):S4. doi: 10.1186/1471-2164-16-S9-S4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Leonard G, Fojo T, Bates S. The Role of ABC Transporters in Clinical Practice. The Oncologist. 2003;8:411–24. doi: 10.1634/theoncologist.8-5-411. [DOI] [PubMed] [Google Scholar]
  • 20.Lepparanta O, Sens C, Salmenkivi K, Kinnula V, Keski-Oja J, et al. Regulation of TGF-beta storage and activation in the human idiopathic pulmonary fibrosis lung. Cell Tissue Res. 2012;3:491–503. doi: 10.1007/s00441-012-1385-9. [DOI] [PubMed] [Google Scholar]
  • 21.Li J, Tseng G. An adaptively weighted statistic for detecting differential gene expression when combining multiple transcriptomic studies. Ann Appl Stat. 2011;5(2A):994–1019. doi: 10.1214/10-AOAS393. [DOI] [Google Scholar]
  • 22.Li Q, Wang S, Huang C, Yu M, Shao J. Meta-analysis based variable selection for gene expression data. Biometrics. 2014;70:872–80. doi: 10.1111/biom.12213. [DOI] [PubMed] [Google Scholar]
  • 23.Ma X, Wang Z, Ryan P, Isakoff S, Barmettler A, et al. A two-gene expression ratio predicts clinical outcome in breast cancer patients treated with tamoxifen. Cancer Cell. 2004;5:607–16. doi: 10.1016/j.ccr.2004.05.015. [DOI] [PubMed] [Google Scholar]
  • 24.Ma S, Sung J, Magis A, Wang Y, Geman D, et al. Measuring the effect of inter-study variability on estimating prediction error. PLoS ONE. 2014;9(10):110840. doi: 10.1371/journal.pone.0110840. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Madhavan S, Gusev Y, Natarajan T, Song L, Bhuvaneshwar K, et al. Genome-wide multi-omics profiling of colorectal cancer identifies immune determinants strongly associated with relapse. Front Genet. 2013;4:236. doi: 10.3389/fgene.2013.00236. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 26.MAQC Consortium The microarray quality control (maqc) project shows inter- and intraplatform reproducibility of gene expression measurements. Nat Biotechnol. 2006;24(9):1151–61. doi: 10.1038/nbt1239. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Marchionni L, Afsari B, Geman D, Leek J. A simple and reproducible breast cancer prognostic test. BioMed Central Genomics. 2013;14:336. doi: 10.1186/1471-2164-14-336. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28.Nakanishi T, Ross D. Breast cancer resistance protein (BCRP/ABCG2): its role in multidrug resistance and regulation of its gene expression. Chin J Cancer. 2012;31(2):73–99. doi: 10.5732/cjc.011.10320. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Noble W. Support vector machine applications in computational biology, Kernel Methods in Computational Biology. Cambridge: MIT Press; 2004. [Google Scholar]
  • 30.Paik S, Shak S, Tang G, Kim C, Baker J, et al. A multigene assay to predict recurrence of tamoxifen-treated, node-negative breast cancer. N Engl J Med. 2004;351(27):2817–26. doi: 10.1056/NEJMoa041588. [DOI] [PubMed] [Google Scholar]
  • 31.Pardo A, Smith K, Abrams J, Coffman R, Bustos M, et al. CCL18/DC-CK-1/PARC up-regulation in hypersensitivity pneumonitis. J Leukoc Biol. 2004;70:610–6. [PubMed] [Google Scholar]
  • 32.Pardo A. Selman M Role of matrix metaloproteases in idiopathic pulmonary fibrosis. Fibrogenesis Tissue Repair. 2012;5(Suppl 1):S9. doi: 10.1186/1755-1536-5-S1-S9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Prasse A, Pechkovsky D, Toews G, Jungraithmayr W, Kollert F, et al. A vicious circle of alveolar macrophages and fibroblasts perpetuates pulmonary fibrosis via CCL18. Am J Respir Crit Care Med. 2006;173:781–92. doi: 10.1164/rccm.200509-1518OC. [DOI] [PubMed] [Google Scholar]
  • 34.Prasse A, Pechkovsky D, Toews G, Schafer M, Eggeling S, et al. CCL18 as an indicator of pulmonary fibrotic activity in idiopathic interstitial pneumonias and systemic sclerosis. Arthristis & Rheumatism. 2007;56(5):1685–93. doi: 10.1002/art.22559. [DOI] [PubMed] [Google Scholar]
  • 35.Rajamani D, Bhasin M. Identification of key regulators of pancreatic cancer progression through multidimensional systems-level analysis. Genome Med. 2016;8:38. doi: 10.1186/s13073-016-0282-3. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36.Ramaswamy S, Tamayo P, Rifkin R, Mukherjee S, Yeang C, et al. Multiclass cancer diagnosis using tumor gene expression signatures. Proc Natl Acad Sci. 2001;98(26):15149–54. doi: 10.1073/pnas.211566398. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37.Rhodes D, Barrette T, Rubin M, Ghosh D, Chinnaiyan A. Meta-analysis of microarrays: Interstudy validation of gene expression profiles reveals pathway dysregulation in prostate cancer. Cancer Res. 2002;62:4427–33. [PubMed] [Google Scholar]
  • 38.Richardson S, Tseng G, Sun W. Statistical methods in integrative genomics. Annu Rev Stat Its Appl. 2016;3(1):181–209. doi: 10.1146/annurev-statistics-041715-033506. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39.Sanders Y, Ambalavanan N, Halloran B, Zhang X, Liu H, et al. Altered DNA Methylation Profile in Idiopathic Pulmonary. Fibrosis Am J Respir Crit Care Med. 2012;186(6):525–35. doi: 10.1164/rccm.201201-0077OC. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40.Schaefer C, Anthony K, Krupa S, Buchoff J, Day M, Hannay T, Buetow K. PID: The pathway interaction database. Nucleic Acids Res. 2009;37(Database issue):674–9. doi: 10.1093/nar/gkn653. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 41.Song C, Tseng G. Hypothesis setting and order statistic for robust genomic meta-analysis. Ann Appl Stat. 2014;8(2):777–800. doi: 10.1214/13-AOAS683. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42.Strieter R, Gomperts B, Keane M. The role of CXC chemokines in pulmonary fibrosis. J Clin Invest. 2007;117(3):549–56. doi: 10.1172/JCI30562. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 43.Veer L, Dai H, Vijver M, He Y, Hart A, et al. Gene expression profilng predicts clinical outcome of breast cance. Nature. 2002;415:530–6. doi: 10.1038/415530a. [DOI] [PubMed] [Google Scholar]
  • 44.Vij R, Noth I. Peripheral Blood Biomarkers in Idiopathic Pulmonary Fibrosis. Transl Res. 2012;159(4):218–27. doi: 10.1016/j.trsl.2012.01.012. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 45.Vijver M, He Y, Veer L, Dai H, Hart A, et al. A gene-expression signature as a predictor of survival in breast cancer. N Engl J Med. 2002;347(25):1999–2009. doi: 10.1056/NEJMoa021967. [DOI] [PubMed] [Google Scholar]
  • 46.Wang H, Zhou L, Gupta A, Vethanayagam R, Zhang Y, et al. Regulation of BCRP/ABCG2 expression by progesterone and beta-estradiol in human placental BeWo cells. Am J Physiol Endocrinol Metab. 2006;290(5):E798–807. doi: 10.1152/ajpendo.00397.2005. [DOI] [PubMed] [Google Scholar]
  • 47.Wang X, Lin Y, Song C, Sibille E, Tseng G. Detecting disease-associated genes with confounding variable adjustment and the impact on genomic meta-analysis: With application to major depressive disorder. BioMed Central Bioinformatics. 2012;13:52. doi: 10.1186/1471-2105-13-52. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48.Zhang H, Ahn J, Lin X, Park C. Gene selection using support vector machines with non-convex penalty. Bioinformatics. 2006;22(1):88–95. doi: 10.1093/bioinformatics/bti736. [DOI] [PubMed] [Google Scholar]
  • 49.Zhang Y, Schnabel C, Schroeder B, Jerevall P, Jankowitz R, et al. Breast cancer index identifies early-stage estrogen receptor–positive breast cancer patients at risk for early- and late-distant recurrence. Clin Cancer Res. 2013;19(15):4196–205. doi: 10.1158/1078-0432.CCR-13-0804. [DOI] [PubMed] [Google Scholar]
  • 50.Zuo F, Kaminski N, Eugui E, Allard J, Yakhini Z, et al. Gene expression analysis reveals matrilysin as a key regulator of pulmonary fibrosis in mice and humans. Proc Natl Acad Sci. 2002;99(9):6292–7. doi: 10.1073/pnas.092134099. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Data Availability Statement

All of data sets were publicly available at the GEO (http://www.ncbi.nlm.nih.gov/geo/;GSE47460, GSE10667 and GSE2052) and TCGA data portal (http://cancergenome.nih.gov; See Table 2 for details).


Articles from BioData Mining are provided here courtesy of BMC

RESOURCES