Skip to main content
BMC Bioinformatics logoLink to BMC Bioinformatics
. 2010 Dec 21;11:606. doi: 10.1186/1471-2105-11-606

Kernel based methods for accelerated failure time model with ultra-high dimensional data

Zhenqiu Liu 1,, Dechang Chen 2, Ming Tan 1, Feng Jiang 3, Ronald B Gartenhaus 1
PMCID: PMC3019227  PMID: 21176134

Abstract

Background

Most genomic data have ultra-high dimensions with more than 10,000 genes (probes). Regularization methods with L1 and Lp penalty have been extensively studied in survival analysis with high-dimensional genomic data. However, when the sample size n m (the number of genes), directly identifying a small subset of genes from ultra-high (m > 10, 000) dimensional data is time-consuming and not computationally efficient. In current microarray analysis, what people really do is select a couple of thousands (or hundreds) of genes using univariate analysis or statistical tests, and then apply the LASSO-type penalty to further reduce the number of disease associated genes. This two-step procedure may introduce bias and inaccuracy and lead us to miss biologically important genes.

Results

The accelerated failure time (AFT) model is a linear regression model and a useful alternative to the Cox model for survival analysis. In this paper, we propose a nonlinear kernel based AFT model and an efficient variable selection method with adaptive kernel ridge regression. Our proposed variable selection method is based on the kernel matrix and dual problem with a much smaller n × n matrix. It is very efficient when the number of unknown variables (genes) is much larger than the number of samples. Moreover, the primal variables are explicitly updated and the sparsity in the solution is exploited.

Conclusions

Our proposed methods can simultaneously identify survival associated prognostic factors and predict survival outcomes with ultra-high dimensional genomic data. We have demonstrated the performance of our methods with both simulation and real data. The proposed method performs superbly with limited computational studies.

Background

Survival prediction and prognostic factor identification play a very important role in medical research. Survival data normally include the censoring variable that indicates whether some outcome under observation (like death or recurrence of a disease) has occurred within some specific follow-up time. The modeling procedures must take into account such censoring. It is even more difficult to develop a proper statistical learning method for survival prediction.

Several models for survival predictions have been proposed in statistical literature. The most popular one is the Cox proportional hazards model [1-3], in which model parameters are estimated with partial log likelihood maximization. Another one is the accelerate failure time (AFT) model [4-6]. AFT is linear regression model in which the response variable is the logarithm or a known monotone transformation of a failure (death) time. There are mainly two approaches in literature for fitting a AFT model. One is the the Buckley-James estimator which adjusts censored observations using the Kaplan Meier estimator [7,8], and the other is a semiparametric estimation of AFT model with an unspecific error distribution [9-11]. However, the semi-parametric Bayesian approach based on complex MCMC procedures is computationally intensive and tends to have inaccurate results, and the Stute's weighted least squares (LS) estimator only implicitly accounts for the censored time. The model has not been widely used in practice due to the difficulties in computing the model parameters [12], and there is no nonlinear AFT model in the literature.

Kernel based methods such as support vector machines (SVM) have been extensively studied recently in the framework of classification and regression [13] in the area of pattern recognition and statistical learning. The concept of kernel formulated as an inner product in the feature space allows us to build nonlinear extensions of many linear models [14]. It would have been a potential alternative if it were not for the complexity of censoring. Moreover, LASSO type penalty and its generalized versions have been proposed for gene (variable) selection with high dimensional genomic profiles with censored survival outcomes [15-18]. However, since the sample size n m (the number of variables), methods based the primary formulation with a huge m (m > 40, 000) are not efficient. Consequently, in current microarray analysis, what people really do is select a couple of thousands (or hundreds) of genes using filter-based methods (such as T-test) and then apply the LASSO-type penalty to further reduce the number of disease associated genes. This two-step procedure will lead to missing biologically important genes and introducing bias. The dual solution with kernel proposed in this article attempts to resolve these inadequacies by solving a much smaller n × n matrix.

In this paper, we propose a nonlinear kernel ridge regression for censored survival outcome prediction under the framework of AFT model. We also develop an efficient dual solution with adaptive kernel ridge regression for ultra-high dimensional genomic data analysis.

Unlike the weighted least square method, our model explicitly accounts for censoring. The proposed models are evaluated with simulation and real data and the prediction error of the test data.

Results and Discussion

Simulation Data

Simulation studies are conducted to evaluate the performance of the proposed methods under different assumptions. The following describes a method to generate input data with censored survival outcomes that emulates the mechanisms presented by the actual data.

1. Sample 12 -dimensional input data x with 100 training and test samples respectively from a multivariate normal distribution with mean zero and variance-covariance matrix Σ. The pairwise correlation between the ith and the jth input variables in Σ is r|i-j| and different correlations (r = 0.2, 0.4, 0.6, and 0.8) will be chosen to assess the performance of the proposed method.

2. Choose the model parameters w = [1, 1, 1, 1, 1, 1, -1, -1, -1, -1, -1, -1]T, and generate the event time from log T = wt xk + ε, where ε ~ N(0, σ2) and σ is determined by the signal to noise ratio (SNR = μsurv). For instance, with the mean log survival time of 3, and SNR = 3 : 1, we have σ = 1. SNR = 3 : 1 is used in all of our simulations. Finally, k indicates the kth power of input variables, so the log survival time is associated with the input variables nonlinearly.

3. The censoring variables are generated as uniformly distributed and independent of the events. Letting di = (rand + C)Ti, the censoring status will be δi = Ti <di. Different Cs give a different portion of censored data. Roughly 40% - 60% censored data are produced in our simulations.

We analyze the simulation data with the proposed DKRR algorithm and build the model with training data, evaluate the performance of the model with the test data. The performance of the DKRR algorithm with different kernels and different correlation structures are shown in Figure 1. As shown in the upper panels of Figure 1, when the the survival data are simulated with k = 1 and the true model is linear, the linear model has the best performance with the the average relative root mean squared error (RRMSE) around 0.1. Models with the radial basis function (rbf) kernel have the second best performance with different correlation structures (r = 0.2 -0.8). Models with the third order polynomial have the worst performance with the mean RRMSE around 0.4. On the other hand, when the survival data are generated with a quadratic model with k = 2 as shown in the lower panels of Figure 1, Model with second order polynomial kernel and rbf kernel are the two top performers with the average test RRMSE around 0.2, and the linear model performs the worst with the largest average test RRMSE around 0.6. These results indicate that model specification is very important. A misspecified model may lead to inaccurate predictions. Finally, there are no statistical significant differences for input variables with different correlations (r = 02 -0.8).

Figure 1.

Figure 1

Test RRMSE with Different Correlation Structures. Test Relative Root Mean Squared Error (RRMSE) with Different Models and Different Correlation Structures: L - linear; p2 - second order polynomial kernel; p3 - third order polynomial kernel; and rbf - radial basis function kernel. The upper panels show the performance with the linear model (k = 1) and the lower panels show the performance with quadratic model(k = 2).

To evaluate the performance of AKRR method, the survival data are generated from linear model with r = 0.4, and different ws. The generated input data have the dimensions of 100, 1000, 10000, 50000, and 100000, but only 12 variables at the positions of 1, 11, 21, 31, ..., 101, 111 are nonzero with the values of [w1, w11, w21, ..., w101, w111]T = [1, 1, 1, 1, 1, 1, -1, -1, -1, -1, -1, -1]T , [0.2, 0.2, 0.2, 0.2, 0.2, 0.2, -0.2, -0.2, -0.2, -0.2, -0.2, -0.2]T, or [0.1, 0.1, 0.1, 0.1, 0.1, 0.1, -0.1, -0.1, -0.1, -0.1, -0.1, -0.1]T respectively. The rest coefficients are set to 0. The random noise and rest of the variables are generated from the distribution of N(0, σ2), and σ is determined by the mean survival time and the signal to noise ratio (SNR = 3:1). The test RRMSEs with different input dimensions are shown in Figure 2. Figure 2 shows that the test RRMSEs have not changed significantly when the input dimension increases from 100 to 100000, which indicates that AKRR method performs well even with a huge number of variables. The frequencies of first 12 component variables being selected out of 100 random simulations with different w are given in Table 1. Table 1 shows that AKRR can correctly identify the survival associated variables with high accuracy. AKRR identifies all 12 variables with over 88% ratios and identifies 10 out of 12 variables with over 96% ratios when |wi| = 1. Moreover, the performances are still very impressive when the associations between survival time and covariates are weak. AKRR identifies 10 out of 12 variables with over 95% and 94% ratios when |wi| = 0.2 and |wi| = 0.1 respectively. Table 2 gives more details about the average number of variables being selected and the ratios of correctly-detected, over-fitting, and under-fitting. The optimal parameters in the parenthesis are decided by 10-fold cross-validation with the training data only. p* is chosen from the values of 0.6, 0.7, 0.8, 0.9, 1, since our computational experiments show that AKRR seems to converge to the same solution when p ≥ 0.6 with different initializations for the same data set. λ* is chosen from 0:0.001:1. The average number of selected variables varies from 11.43-12.61 around the true number 12. AKRR identifies exactly the same 12 variables with the ratios of 75%, 54%, and 52% for |wi| = 1, 0.2, and 0.1 respectively. In all three cases, AKRR chooses the number of variables in the range of 11-13 with over 90% ratio.

Figure 2.

Figure 2

RRMSE with Different Input Dimensions. Test Relative Root Mean Squared Error (RRMSE) with Different Input Dimensions. The input dimensions vary from 100 to 100,000.

Table 1.

Frequencies of Correctly Identified variables with Different Parameters Out of 100 Simulations

Parameters |wi| = 1 |wi| = 0.2 |wi| = 0.1
w1 100 100 99
w11 100 98 99
w21 97 99 98
w31 98 99 99
w41 98 98 94
w51 88 77 81
w61 90 86 77
w71 98 95 99
w81 98 98 97
w91 96 96 95
w101 99 99 98
w111 99 100 100

Table 2.

Model performance with Simulation Data and Different Parameter Values

|wi|s (λ*, p*) Av. # of Vars Exactly-match Overfitting Underfitting
1 (0.01, 0.6) 12.61 75% 21% 4%
0.2 (0.002, 0.6) 11.52 54% 3% 43%
0.1 (0.001, 0.6) 11.43 52% 2% 46%

For comparison purposes, we also implement the primal version of LASSO for AFT model with Gauss-Seidel method to optimize w directly. The computational time for different input dimensions is listed in Table 3. Table 3 shows that AKRR is so computational efficient that it only takes 17.5 seconds for one run to identify variables from 100,000 candidate variables, while LASSO might take days. With 50000 variables, AKRR only needs 7.5 seconds on average to converge, while LASSO fails to converge after 2 hours. When the input dimension is large, AKRR is much more efficient. This is reasonable since the computational time of AKRR is mainly associated with the sample size and dual variables. This method will be fast even with ultra-high dimensional input as long as the sample size is small, which is common in genomic data analysis.

Table 3.

Computational Time (in Seconds): AKRR vs LASSO

Input Dimensions AKRR LASSO
100 0.4801 0.6378
1000 0.5844 6.4577
10000 1.7500 978.23
50000 7.5255 >7200
100000 17.4545 - -

Diffuse Large B-cell Lymphoma Data

We now consider one diffuse large B-cell lymphoma (DLBCL) data [19] evaluating gene expression profiles associated with the patient's survival. In this study, tumor-biopsy specimens and clinical data were obtained retrospectively from 240 patients with untreated diffuse large-B-cell lymphoma who had no previous history of lymphoma, according to a protocol approved by the National Cancer Institute institutional review board. The median follow-up time was 2.8 years overall (7.3 years for survivors), and 57 percent of patients died during this period. The median age of the patients was 63 years, and 56 percent were men. CDNA microarray data with 7,399 probes were collected. We divide the data into two equal parts with 120 training data and 120 test data. We utilize the two-fold cross validation scheme to choose the optimal λ and evaluate our method. We randomly split the data into two roughly equal-sized subsets and build the model with one subset and test it with the other. To avoid the bias arising from a particular partition, the procedure is repeated 100 times, each time we split the data randomly into two folds and do cross validation. The relevance count is utilized to count how many times a gene is selected in the cross validation. Clearly the maximum relevance count for a gene is 200 with the two-fold cross validation and 100 repeating. The optimal λ* is in the range of 0.26-0.3, and the optimal p* is set to 0.7 in all the experiments. The test RRMSE is 0.07 on average, which is better than the average test RRMSE (0.101) with LASSO based primal model. This is reasonable, since AKRR has one additional parameter p. Genes associated with survival time are shown in Table 4. We identify 23 probes with over 100 relevant counts. Those 23 probes are corresponding to 21 known genes. All of the selected genes play important roles in apoptotic processes and/or the development and progress of various cancers. 17 out of 21 genes are associated with different lymphoma according to PubMed. For example, BMP6 is the top gene in other category associated with poor outcome and HLA-C gene is from the major histocompatibility class (MHC) II family, both genes were also identified by Rosenwald et al. 2002. Moreover, CD86, CD79a, and CD19 are well known antigens and MHC II signatures associated with favorable survival outcomes. We then perform pathway analysis using DAVID (david.abcc.ncifcrf.gov) and identify 5 lymphoma associated pathways: NOD-like Receptor Signaling Pathway, Pathways in Cancer, Allograft Rejection, Focal Adhesion, and Graft-versus-host Disease. Four out 5 pathways (except for NOD-like Receptor Signaling Pathway) are known to be associated with DLBCL from PubMed.

Table 4.

Genes Associated with Survival Time for DLBCL Data

Count GenBank Symbal Description
200 X59618 RRM2 ribonucleotide reductase M2 polypeptide
200 X15187 HSP90B1 tumor rejection antigen (gp96) 1
200 M60315 BMP6 bone morphogenetic protein 6
176 U04343 CD86 CD86 antigen (CD28 antigen ligand 2, B7-2 antigen)
181 X07203 MS4A1 membrane-spanning 4-domains, subfamily A, member 2
198 S75217 CD79A CD79A antigen (immunoglobulin-associated alpha)
200 M28170 SD19 CD19 antigen
138 U45878 BIRC3 baculoviral IAP repeat-containing 3
146 U10485 LRMP lymphoid-restricted membrane protein
176 U07620 MAPK10 mitogen-activated protein kinase 10
179 LC_30727
153 M63438 HLA-C immunoglobulin kappa constant
164 U46767 CCL13 small inducible cytokine subfamily A (Cys-Cys), member 13
142 X14723 CLU clusterin
200 M27492 IL1R1 interleukin 1 receptor, type I
183 J05070 MMP9 matrix metalloproteinase 9
200 X61118 LMO2 LIM domain only 2 (rhombotin-like 1)
200 M81750 MNDA myeloid cell nuclear differentiation antigen
115 X57809 IGL@ heat shock 70 kD protein 1A
162 J03746 MGST1 microsomal glutathione S-transferase 1
200 D38535 ITIH4 inter-alpha (globulin) inhibitor H4
200 M21574 PDGFRA platelet-derived growth factor receptor, alpha polypeptide
187 ESTs ESTs

Follicular Lymphoma (FL) Data

Follicular lymphoma is a common type of Non-Hodgkin Lymphoma (NHL). It is a slow growing lymphoma that arises from B-cells, a type of white blood cell. It is also called an "indolent" or "low-grade" lymphoma for its slow nature, both in terms of its behavior and how it looks under the microscope. A study was conducted to predict the survival probability of patients with gene expression profiles of tumors at diagnosis [20]. Fresh-frozen tumor biopsy specimens and clinical data were obtained from 191 untreated patients who had received a diagnosis of follicular lymphoma between 1974 and 2001. The median age of patients at diagnosis was 51 years (range 23 - 81) and the median follow up time was 6.6 years (range less than 1.0 - 28.2). The median follow up time among patients alive was 8.1 years. Four records with missing survival information were excluded from the analysis. Affymetrix U133A abd U133B microarray genechips were used to measure gene expression levels from RNA samples. A log 2 transformation was applied to the Affymetrix measurement. Detailed experimental protocol can be found from the original paper. There are total of 42928 probes. It is time consuming to directly apply standard LASSO methods to this problem without an initial reduction of dimensions. Our method takes less than 10 seconds for one run. Similar two-fold cross validation scheme with 100 random partitions is utilized to this data. The optimal λ* is in the range of 0.1 - 0.12 with the optimal p* = 0.6. The test RRMSE is 0.09. The final results are shown in Table 5.

Table 5.

Genes Associated with Survival Time for FL Data

count ProbeID Symbal Description
200 231760_at C20orf51 chromosome 20 open reading frame 51
200 232932_at
200 235856_at C4A complement component 4A (Rodgers blood group)
187 224280_s_a LOC56181 family with sequence similarity 54, member B
200 201425_at ALDH2 aldehyde dehydrogenase 2 family (mitochondrial)
180 214694_at M-RIP Myosin phosphatase Rho-interacting protein
200 214713_at YLPM1 YLP motif containing 1
200 218477_at TMEM14A transmembrane protein 14A
200 220669_at HSHIN1 HIV-1 induced protein HIN-1
195 203970_s_a PEX3 peroxisomal biogenesis factor 3
200 208470_s_a HPR haptoglobin-related protein; haptoglobin
175 210920_x_a
200 215444_s_a TRIM31 tripartite motif-containing 31

Thirteen probes with over 100 relevance counts are identified. Those 13 probes are corresponding to 11 known genes associated with lymphoma and related diseases. For instance, gene C4A localizes to the major histocompatibility complex (MHC) class III region on chromosome 6. It plays a central role in the activation of the classical pathway of the complement system. C4A anaphylatoxin is a mediator of local inflammatory process. It induces the contraction of smooth muscle, increases vascular permeability, and causes histamine release from mast cells and basophilic leukocytes. C4A is on the pathway of Systemic Lupus Erythematosus (SLE). Patients with SLE can increase the risk of certain cancers, including non-Hodgkin's lymphoma. We find that C4A is negatively associated with survival time according the estimated coefficient of C4A. ALDH2 is another well studied gene which is significantly associated with acetaldehyde-induced micronuclei and alcohol-induced facial flushing. Defects in ALDH2 are a cause of acute alcohol sensitivity and alcohol induced cancers. There are accumulating evidences that ALDH2-deficient individuals are at much higher risk of esophageal cancer and malignant lymphoma. Our study indicates that the up-regulated ALDH2 is positively associated with patient survival outcomes. Six other genes are also associated with different cancers including follicular lymphoma.

Conclusions

We proposed kernel based methods for nonlinear AFT model and variable selection for ultra-high dimensional data. Our evaluations with simulation and real data illustrate that the proposed methods can effectively reduce the dimension of the covariates with sound prediction accuracy. In many studies, both clinical and genomic data are available. Due to the ultra-high dimension in genomic data, directly applying LASSO based methods to genomic data is usually not feasible. Our proposed method provides an efficient solution for it. Kernel based nonparametric methods have been well studied in statistical learning, but there are not many studies for survival analysis. In this paper, we provide a basis for further explorations in this field.

Methods

To formulate the model, consider a set of n independent observations {Ti,δi,xi}i=1n, where δi is the censoring indicator, Ti is the survival time (event time) if δi = 1 or censoring time if δi = 0, and xi = (xi1, xi2, ..., xim)t is the m-dimensional input vector of the ith sample. Letting w = (w1, w2, ..., wm)t be a vector of regression coefficients and ϕ(xi) is the nonlinear transform of xi in feature space, the AFT model is defined as

M(xi)=wtφ(xi),i=1,...,n, (1)

where M(xi) > log Ti if δi = 0 and M(xi) = log Ti if δi = 1. Because there are both equality and inequality constraints in the model, new methods need to be developed.

Kernel Ridge Regression (KRR)

The kernel ridge regression for right censored survival data is as follows:

 min12ni=1nξi2+λ2wtws.t. |wtφ(xi)logTi|<ξi,ifδi=1;wtφ(xi)>logTiξi,ifδi=0;ξi0, 1in. (2)

When ties in the event times are presented, variables associated with each tied time appear in the constraints independently. We can define an index function I(δi) = 1 if δi = 1, and for censored data with δi = 0, I(δi) is defined as I(δi) = 1 if log Ti wtϕ(xi) and 0 otherwise. Then equation (2) is equivalent to the following quadratic function:

J(w)=12ni=1nI(δi){wtφ(xi)logTi}2+λ2wtw, (3)

where λ ≥ 0. If we set the gradient of J(w) with respect to w to zero, then the solution for w is a linear combination of the vectors ϕ(xi):

w=1nλi=1nI(δi){wtφ(xi)logTi}φ(xi)=i=1naiφ(xi)=Φta, (4)

where Φ is the design matrix, whose ith row is given by ϕ(xi)t, and a = (a1, a2, ..., an)t are the dual variables, defined by

ai=I(δi)nλ{wtφ(xi)logTi} (5)

Substituting w = Φta into ai, we obtain

ai=I(δi)nλ{φt(xi)ΦtalogTi}=I(δi)nλ{K(xi,.)alogTi}, (6)

where K = (K(xi, xj))n × n = (ϕ(xi)tϕ(xj))n × n is a kernel matrix which can be defined explicitly and K(xi,.) = ϕ(xi)tΦt is the i-th row of the kernel matrix. Popular kernels include:

• Linear kernel:

K(xi,xj)=xitxj,

• Radial basis function (Gaussian) kernel:

K(xi,xj)=exp(|xixj|2σ2),

• Polynomial kernel:

K(xi,xj)=(xitxj+p2)p1,

• Sigmoid kernel:

K(xi,xj)=tanh(βxitxj).

Our kernel ridge regression algorithm based on the dual equation (DKRR) (6) is as follows:

The Dual Kernel Ridge Regression (DKRR) Algorithm

Given λ, training data {xi,logTi,δi}i=1n, test data {xk,logTk,δk}k=1nk, and a small ε.

Calculate the kernel matrices K=[K(xi,xj)]n×n and Kte=[K(xk,xi)]nk×n.

Center the kernels and the survival times: K=(In1n1n1nt)K(In1n1n1nt) and Kte=(Kte1n1nk1ntK)(In1n1n1nt), where 1n: a vector with n 1's. and In: an identity matrix, and logTk=logTkk=1nklogTknk. Let a0 = [0, ..., 0, 0]t, and j = 0

WHILE 1,

• FOR i = 1 to n,

            I(δi)={1if δi>0,1if δi=0,&K(xi,.)ajlogTi,0otherwise.

            aij+1=I(δi)nλ{K(xi,.)ajlogTi}

            aj+1=[a1j+1,...,aij+1,ai+1j...,anj]t

         END

j = j + 1

• IF |aj+1 - aj| <ε, BREAK.

aj = aj+1

END

This dual kernel ridge regression (DKRR)algorithm designed for a quadratic error function with linear constraints is a convex function with convex constraints. Theoretically this algorithm will always converge and global optimal solution is guaranteed irrelevant to initial value a0. In our computational experiments, the differences of the estimated parameters with different initial values are very small (less than 0.01 with the infinity norm).

Adaptive Kernel Ridge Regression

When the number of variables is greater than the sample size n, regularization is needed to obtain a stable estimator w. We propose a Lp=i=1n|wi|p(p<1) penalty for variable selection and estimation simultaneously. Unlike LASSO, Lp penalty and its different approximation schemes (i.e., adaptive LASSO) possess the oracle property [21,22]. Here the oracle property of a method means that it can correctly identify the nonzero coefficients with probability converging to one and that the estimators of nonzero coefficients are asymptotically normal with the same means and covariances as what they would have the zero coefficients be known in advance. We therefore propose the following penalized AFT model:

J(w)=12ni=1nI(δi){wtφ(xi)logTi}2+λ2i=1m|wi|p=12ni=1nI(δi){wtφ(xi)logTi}2+λ2i=1m|wi|2|wi|2p, (7)

where λ ≥ 0. With n m, linear kernel is more appropriate, since model with linear kernel has less over-fitting. We will take ϕ(xi) = xi, introduce an auxiliary (latent) variable vector u = [u1, u2, ..., um]t, and develop an adaptive procedure based on equation (7). Equation (7) can be rewritten as:

J(w,u)=12ni=1nI(δi){wtxilogTi}2+λ2i=1m|wi|2|ui|2p, (8)
and,u=w. (9)

With equation (8) and (9), we will find the first order derivative for w with a fixed u and then update u = w. After taking the first order derivative, we have the following equation:

w=1nλi=1nI(δi){wtxilogTi}(xi|u|2p)=i=1nai(xi|u|2p)=Xuta,   (10)

where ⊙ represents the componentwise product of two vectors and

Xu= (x1t(|u|2p)txnt(|u|2p)t),

and

ai=I(δi)nλ{wtxilogTi}. (11)

We substitute w=Xuta and define a new kernel function Ku=XXut. Then we have Ku(xi,.)=xitXut, which is the ith row of Ku. So,

ai=I(δi)nλ{xitXutalogTi}=I(δi)nλ{Ku(xi,.)alogTi}. (12)

The adaptive kernel ridge regression algorithm based on dual variables a with equation (10) and (12) is as follows:

Adaptive Kernel Ridge Regression (AKRR) Algorithm

Given a λ, p ∈ (0.1], training data {xi,logTi,δi}i=1n, and a small ε and η.

Initializing w = u = rand(m, 1), and a = [0, ..., 0]t

Setting u(ui == 0) = 10e - 5 and j = 1.

While |w - u| >ε

u = w,

Ku=XXut

• FOR i = 1 to n,

            I(δi)={1if δi>01if δi=0,&K(xi,.)ajlogTi,0otherwise.

            aij+1=I(δi)nλ{Ku(xi,.)ajlogTi}

            aj+1=[a1j+1,...,aij+1,ai+1j...,anj]t

         END

j = j + 1

w=Xuta.

END

w(w <η) = 0

Unlike other LASSO based methods which seek to find optimal w directly, AKRR algorithm updates the m-dimensional w through updating a much smaller n-dimensional dual variable a. This method is computationally highly efficient when n m, which is common in genomic data. Although the proposed method is based on the dual problem, the primal variable w is explicitly updated in the computation. Theoretically AKRR algorithm will always converge to global optimal solution when p = 1 irrelevant to initial values of w, u, and a, as the error function is convex under L1 penalty, but only local optimal solution is guaranteed when p < 1. However, in our computational experiments with simulation and real data, even though we may have different optimal solutions with different initializations only when p ≤ 0.5, most selected features are still the same in different runs. AKRR always reach the same optimal solution in all of our experiments when p ≥ 0.6. One possible explanation is that the error function may still be near convex or convex almost everywhere when p is large. Therefore it may be possible that we enjoy both the oracle property with less bias and the global optimal solution with larger p (0.6 ≤ p < 1). Theoretical study for the near convex error function, however, is out of the scope of this paper. To prevent the results stick to a local optimal solution when p ≤ 0.5, we run AKRR 30 times and the best solution is chosen from the run with smallest test error. Even though AKRR does choose different variables with different ps, a small subset (≥ 5) of most important genes are always selected in our experiments. The model performance can be evaluated with cross-validation and the relative root mean squared error (RRMSE=i((yiy^i)/yi)2n) of the test data. There are two parameters p and λ for the adaptive kernel ridge regression (AKRR) algorithm. One efficient way is to set p = 0.1, 0.2, ..., 1 alternatively, and then search for the best λ through cross-validation. The range of can be determined by the path of the optimal solution. λmin = 0 and λmax is set to be the smallest value with all zero estimated parameters by multiple trials. We search the optimal λ from λ ∈ (0, 1] in this paper. Usually we have a larger λmax for p = 1, and smaller λmax when p is smaller.

Authors' contributions

ZL conceptualized and designed method, developed the software, and wrote the manuscript. FJ and RG analyzed and interpreted the data on its biological contents. DC and MT helped in method design and manuscript writing and revised the manuscript critically. All authors read and approved the final manuscript.

Contributor Information

Zhenqiu Liu, Email: zliu@umm.edu.

Dechang Chen, Email: dchen@usuhs.mil.

Ming Tan, Email: mttan@som.umaryland.edu.

Feng Jiang, Email: fjiang@som.umaryland.edu.

Ronald B Gartenhaus, Email: rgartenhaus@som.umaryland.edu.

Acknowledgements

We thank the Associate Editor and the two anonymous referees for their constructive comments, which improve this manuscript significantly. This work was partially supported by the 1R03CA133899 grant from the National Cancer Institute and by the National Science Foundation CCF-0729080 grant.

References

  1. Cox D. Regression models and life-tables (with discussion) Journal of Royal Statistical Society, Series B. 1972;34:187–220. [Google Scholar]
  2. Gui J, Li H. Variable Selection via Non-concave Penalized Likelihood and its Oracle Properties. Journal of the American Statistical Association, Theory and Methods. 2001;96:456. [Google Scholar]
  3. Van Houwelingen H, Bruinsma T, Hart A, Van't Veer L, Wessels L. Cross-validated Cox regression on microarray gene expression data. Stat Med. 2006;25:3201–3216. doi: 10.1002/sim.2353. [DOI] [PubMed] [Google Scholar]
  4. Kalbfleisch J, Prentice R. The Statistical Analysis of Failure Time Data. New York: John Wiley; 1980. [Google Scholar]
  5. Wei L. The accelerated failure time model. a useful alternative to the Cox regression model in survival analysis. Statistics in Medicine. 1992;11:1871–1879. doi: 10.1002/sim.4780111409. [DOI] [PubMed] [Google Scholar]
  6. Ying Z. A large sample study of rank estimation for censored regression data. Annals of Statistics. 1993;21:76–99. doi: 10.1214/aos/1176349016. [DOI] [Google Scholar]
  7. Stute W, Wang J. The strong law under random censorship. Annals of Statistics. 1993;14:1351–1365. [Google Scholar]
  8. Stute W. Distributional convergence under random censorship when covariables are present. Scandinavia Journal of Statistics. 1996;23:461–471. [Google Scholar]
  9. Christensen R, Johnson W. Modelling accelerated failure time with a Dirichlet process. Biometrika. 1988;75:693–704. doi: 10.1093/biomet/75.4.693. [DOI] [Google Scholar]
  10. Kuo L, Mallick B. Bayesian semiparametric inference for the accelerated failure time model. Canadian J Stat. 1997;25:457–472. doi: 10.2307/3315341. [DOI] [Google Scholar]
  11. Bedrick E, Christensen R, Johnson W. Bayesian accelerated failure time analysis with application to veterinary epidemiology. Stat Med. 2000;19:221–237. doi: 10.1002/(SICI)1097-0258(20000130)19:2&#x0003c;221::AID-SIM328&#x0003e;3.0.CO;2-C. [DOI] [PubMed] [Google Scholar]
  12. Jin Z, Lin D, Wei L, Ying Z. Rank-based inference for the accelerated failure time model. Biometrika. 2003;90:341–353. doi: 10.1093/biomet/90.2.341. [DOI] [Google Scholar]
  13. Vapnik V. Statistical Learning Theory. New York: Wiley and Sons; 1998. [Google Scholar]
  14. Shawe-Taylor J, Cristianini N. Kernel Methods for Pattern Analysis. London: Cambridge University Press; 2004. [Google Scholar]
  15. Ma S, Huang J. Additive risk survival model with microarray data. BMC Bioinformatics. 2007;8:192. doi: 10.1186/1471-2105-8-192. [DOI] [PMC free article] [PubMed] [Google Scholar]
  16. Sha N, Tadesse M, Vannucci M. Bayesian variable selection for the analysis of microarray data with censored outcomes. Bioinformatics. 2006;22(18):2262–2268. doi: 10.1093/bioinformatics/btl362. [DOI] [PubMed] [Google Scholar]
  17. Liu Z, Gartenhaus R, Chen X, Howell C, Tan M. Survival Prediction and Gene Identification with Penalized Global AUC Maximization. Journal of Computational Biology. 2009;16(12):1661–1670. doi: 10.1089/cmb.2008.0188. [DOI] [PMC free article] [PubMed] [Google Scholar]
  18. Liu Z, Jiang F. Gene identification and survival prediction with Lp Cox regression and novel similarity measure. Int J Data Min Bioinform. 2009;3(4):398–408. doi: 10.1504/IJDMB.2009.029203. [DOI] [PubMed] [Google Scholar]
  19. Rosenwald A, Wright G, Chan W, Connors J, Campo E, Fisher R, Gascoyne R, Muller-Hermelink H, Smeland E, Giltnane J, Hurt E, Zhao H, Averett L, Yang L, Wilson W, Jaffe E, Simon R, Klausner R, Powell J, Duffey P, Longo D, Greiner T, Weisenburger DD. DBLJVJAJMELGAGTMTLM. Sanger WG, Ott G, Kvaloy S, Delabie J, Holte H, Krajci P, Stokke T, Staudt L. The use of molecular profiling to predict survival after themotheropy for diffuse large-B-cell lymphoma. The New England Journal of Medicine. 2002;346:1937–1947. doi: 10.1056/NEJMoa012914. [DOI] [PubMed] [Google Scholar]
  20. Dave S, Wright G, Tan B, Rosenwald A, Gascoyne R, Chan W, Fisher R, Braziel R, Rimsza L, Grogan T, Miller T, LeBlanc M, Greiner T, Weisenburger D, Lynch J, Vose J, Armitage J, Smeland E, Kvaloy S, Holte H, Delabie J, Connors J, Lansdorp P, Ouyang Q, Lister T, Davies A, Norton A, Muller-Hermelink H, Ott G, Campo E, Montserrat E, Wilson W, Jaffe E, Simon R, Yang L, Powell J, Zhao H, Goldschmidt N, Chiorazzi M, Staudt L. Prediction of survival in follicular lymphoma based on molecular features of tumor-in filtrating immune cells. N Engl J Med. 2004;351(21):2159–2169. doi: 10.1056/NEJMoa041869. [DOI] [PubMed] [Google Scholar]
  21. Knight K, Fu W. Asymptotics for Lasso-type estimators. Annals of Statistics. 2000;28:1356–1378. doi: 10.1214/aos/1015957397. [DOI] [Google Scholar]
  22. Fan J, Peng H. On Nonconcave Penalized Likelihood With Diverging Number of Parameters. The Annals of Statistics. 2004;32:928–961. doi: 10.1214/009053604000000256. [DOI] [Google Scholar]

Articles from BMC Bioinformatics are provided here courtesy of BMC

RESOURCES