Skip to main content
Computational and Mathematical Methods in Medicine logoLink to Computational and Mathematical Methods in Medicine
. 2016 Oct 24;2016:3456153. doi: 10.1155/2016/3456153

Efficient Regularized Regression with L 0 Penalty for Variable Selection and Network Construction

Zhenqiu Liu 1,*, Gang Li 2
PMCID: PMC5098106  PMID: 27843486

Abstract

Variable selections for regression with high-dimensional big data have found many applications in bioinformatics and computational biology. One appealing approach is the L 0 regularized regression which penalizes the number of nonzero features in the model directly. However, it is well known that L 0 optimization is NP-hard and computationally challenging. In this paper, we propose efficient EM (L 0EM) and dual L 0EM (DL 0EM) algorithms that directly approximate the L 0 optimization problem. While L 0EM is efficient with large sample size, DL 0EM is efficient with high-dimensional (nm) data. They also provide a natural solution to all L p   p ∈ [0,2] problems, including lasso with p = 1 and elastic net with p ∈ [1,2]. The regularized parameter λ can be determined through cross validation or AIC and BIC. We demonstrate our methods through simulation and high-dimensional genomic data. The results indicate that L 0 has better performance than lasso, SCAD, and MC+, and L 0 with AIC or BIC has similar performance as computationally intensive cross validation. The proposed algorithms are efficient in identifying the nonzero variables with less bias and constructing biologically important networks with high-dimensional big data.

1. Introduction

Variable selection with regularized regression has been one of the hot topics in machine learning and statistics. Regularized regressions identify outcome associated features and estimate nonzero parameters simultaneously and are particularly useful for high-dimensional big data with small sample sizes. Big data are datasets with either huge sample size or very high dimensions or both. In many real applications, such as bioinformatics, image and signal processing, and engineering, a large number of features are measured, but only a small number of features are associated with the dependent variables. Including irrelevant variables in the model will lead to overfitting and deteriorate the prediction performance. Therefore, different regularized regression methods have been proposed for variable selection and model construction. L 0 regularized regressions, which directly penalize the number of nonzero parameters, are the most essential sparsity measure. Several popular information criteria, including Akaike information criterion (AIC) [1], Bayesian information criterion (BIC) [2], and risk inflation criteria (RIC) [3], are based on L 0 penalty and have been used extensively for variable selections. However, solving a general L 0 regularized optimization is NP-hard and computationally challenging. Exhaustive search with AIC or BIC over all possible combinations of features is computationally infeasible with high-dimensional big data.

Different alternatives have been proposed for the regularized regression problem. One common approach is to replace L 0 by L 1. L 1 is known as the best convex relaxation of L 0. L 1 regularized regression [4] is convex and can be solved by an efficient gradient decent algorithm. It has found many applications in statistical genetics, bioinformatics, and medicine [5, 6]. Minimizing L 1 is equivalent to minimizing L 0 under certain conditions. However, the estimates of L 1 regularized regression are asymptotically biased, and lasso may not always choose the true model consistently [7]. Experimental results by Mancera and Portilla [8] also posed additional doubt about the equivalence of minimizing L 1 and L 0. Moreover, there were theoretical results [9] showing that while L 1 regularized regression never outperforms L 0 by a constant, in some cases L 1 regularized regression performs infinitely worse than L 0. Lin et al. [9] also showed that the optimal L 1 solutions are often inferior to L 0 solutions found using greedy classic stepwise regression, although solutions with L 1 penalty can be found effectively. More recent approaches aimed to reduce bias and overcome discontinuity include SCAD [10], L p   p ∈ (0,1] regularization [11, 12], and MC+ [13]. However, multiple free parameters (λ and p) must be tuned in those approaches, which is computationally intensive. They are not suitable for big data mining. Even though there are some effects for solving L 0 regularized optimization problems [14, 15], L 0 was either approximated by a different continuous smooth function or transformed into a much larger ranking optimization problem. To the best of our knowledge, currently, there is no efficient method directly approximating L 0 for big data problem.

In this paper, we propose efficient EM algorithms that directly approximate L 0 regularized regression problem. Our proposed approaches effectively deal with L 0 optimization by solving a sequence of convex L 2 optimizations and are efficient for high-dimensional data. They also provide a natural solution to all L p   p ∈ [0,2] problems, including lasso with p = 1, elastic net with p ∈ [1,2] [16], and the combination of L 1 and L 0 with p ∈ (0,1] [17]. Similar to lasso, the regular parameter λ can be determined by the generalized information criterion [18]; optimal λ with L 0 regularized regression can also be predetermined with different model selection criteria such as AIC, BIC, and RIC. L 0 local graphical model with either AIC or BIC is faster than L 1 with cross validation. We demonstrate our methods through simulation and high-dimensional genomic data. The proposed methods identify the nonzero variables with less bias and outperform lasso, SCAD, and MC+ by a large margin. They can also choose the important genes and construct biological networks effectively.

2. Methods

Given an n × 1 dependent variable y and an n × m feature matrix X, a linear model is defined as

y=Xθ+ε, (1)

where n is the number of samples and m is the number of variables and nm, θ = [θ 1,…, θ m]t are m parameters to be estimated, and ε ~ N(0, σ 2 I n) are the random errors with mean 0 and variance σ 2. Assume that only a small subset of {x j}j=1 m has nonzero θ js. Let R⊆{1,…, m} be the subset index of relevant variables with θ j ≠ 0, and let O⊆{1,…, m} be the index of irrelevant features with 0 coefficients; we have RO = {1,2,…, m}, X RX O = X, and θ Rθ O = θ, where θ O = 0. The error function for L 0 regularized regression is

E12yXθ2+λ2θ0=12i=1nyij=1mθjxij2+λ2j=1mIθj0, (2)

where ‖θ0 = ∑j=1 m I(θ j ≠ 0) = |R| counts the number of nonzero parameters. One observation is that (2) is equivalent to (3) when reaching the optimal solution.

E12yXθ2+λ2θ0=12yXθ2+λ2jR1=12yXθ2+λ2R. (3)

Our L 0EM methods will be derived from (3). We can rewrite (3) as the following two equations:

E=12yXθ2+λ2jRθj2ηj2, (4)
η=θ. (5)

Given η j, (4) is a convex quadratic function and can be optimized by taking the first-order derivative:

E=λθRηR2XRtyXθ=0, (6)

where ⊘ indicates element-wise division. Rewriting (6), we have

λθRηR2XRtyXθ=0. (7)

In addition,

λθOηO2XOtyXθ=0,λ>0, (8)

since θ O = η 0 = 0, where ⊙ is element-wise multiplication, η R 2X R t = [η R 2x 1R t,…, η R 2x nR t], and η O 2X O t = [η O 2x 1O t,…, η O 2x nO t] = 0. Let D = diag⁡(η 1 2,…, η m 2) be a diagonal matrix with η j 2s on the diagonal and combine (7) and (8) together; we have

η2EλθDXtyXθ=λθDXty+DXtXθ=0. (9)

Solving (9) leads to following explicit solution:

θ=DXtX+λI1DXty, (10)
η=θ, (11)

where (10) can be considered as the M-step of the EM algorithm maximizing negative cost function −E and (11) can be regarded as the E-step with E(η) = θ. Equations (10) and (11) together can also be treated as a fixed point iteration method in nonlinear optimization. It is guaranteed to have optimal solutions under certain conditions as shown in Theorem 1.

Theorem 1 . —

Given an input matrix X, output matrix y, and initialized solution θ 0, the nonlinear system determined by (10) and (11) will converge to an optimal solution, when λ(DXtX+λI)-2DXty<1/2.

Proof —

Equations (10) and (11) are the same as

θDXtX+λI1DXty=θ2XtX+λI1θ2Xty. (12)

First, G(θ) = (θ 2X t X + λI)−1(θ 2X t)y is Lipschitz continuous for θR m, and

Gθ=DXtX+λI2·θ2XtX+λI2θXty2θXtXθ2Xty=θ2XtX+λI22λθXty=2λDXtX+λI2DXty. (13)

Because λ(DXtX+λI)-2DXty<1/2, it is clear from (13) that there is a Lipschitz constant

γGθ=2λ2DXtX+λI2DXty2λDXtX+λI2DXty<2·12=1. (14)

So the derivative for every θ j is less than 1. Now, given the initial value for (10) and (11) η = θ 0R m, the sequence {θ r} remains bounded because, ∀i = 1,…, r,

θi+1θiGθiGθi1=Gξθiθi1Gξθiθi1whereξθi1,θiγθiθi1γiθ1θ0. (15)

And therefore

θrθ0i=0r1θi+1θiθ1θ0i=0r1γiθ1θ01γ. (16)

Now, ∀r, k ≥ 0,

θr+kθrGθr+k1Gθr1γθr+k1θr1γGθr+k2Gθr2γ2θr+k2θr2γrθkθ0γrθ1θ01γ. (17)

Hence,

limr,kθr+kθr=0, (18)

and therefore {θ r} is a Cauchy sequence that has a limit solution θ .

Note that G(θ) is not a convex function; multiple local optimal solutions may exist. However, given initial θ 0, our algorithm always reaches the same optimal solution closest to θ 0. Assuming that there were two solutions θ and θ ,

θθ=GθGθγθθ. (19)

Since γ < 1, (19) can only hold, if ‖θ θ = 0. That is, θ = θ , so the optimal solution of the EM algorithm is always the same.

Finally, the EM algorithm will be closer to the optimal solution at each step, because

θr+1θ=GθrGθγθrθ. (20)

Theorem 1 indicates that both the regularized parameter λ and initial values of the parameter θ are important. Given an initial value θ 0, the method converges to an optimal solution as long as λ(DXtX+λI)-2DXty<1/2.

Lemma 2 . —

When λ < ‖DX t X and DXtX>1/2DXty, the algorithm will find a nontrivial optimal solution for θ. More specifically, it will converge to an optimal solution, when λ < (1/4)‖(X t X)−1diag2(X t y)‖ and ‖θ > (1/2)‖X t X −1X t y for λ and θ, respectively, where diag⁡(x) is a diagonal matrix with x i on the diagonal.

Proof —

Since λ(DXtX+λI)-2DXty<1/2, we have

12λDXtX+λI2DXty2λDXtX+λI2DXty2λDXtX+λ2DXty=2λDXtX+λDXtyDXtX+λ. (21)

Inequality (21) is satisfied, if

2λDXtX+λ<1,DXtyDXtX+λ<1λDXtX,DXtX>12DXty. (22)

In addition, we have

DXtX=diagθdiagθtXtX=diagDXtX+λI1DXty·diagytXDDXtX+λI1XtX2XtX1diag2Xty2XtX1XtX=14XtX1diag2Xty, (23)

and let

DXtXDXtX>12DXty12DXty. (24)

Therefore, if we take

λ<14XtX1diag2XtyDXtX,θ=D>12XtX1Xty, (25)

the algorithm will find a nontrivial optimal solution. In particular, when X t X = I, we have

λ<14diag2Xty=14maxxjty2j=1m,θ>12Xty. (26)

Both Theorem 1 and Lemma 2 provide some useful guidance for implementing the method and choosing appropriate λ and θ 0. They show that the EM algorithm always converges to an optimal solution, given certain λ and initial solution θ 0, and the estimated value is closer to the true solution after each EM iteration. Note that there is a trivial solution θ j = 0, ∀j = 1,…, m, for (10) and (11); therefore, nonzero initial θ 0 is critical for finding a nontrivial solution. Our experiences with this method indicate that initializing θ with the estimates from L 2 penalized ridge regression will lead to quick convergence and super performance. The algorithm with such initialization usually converges under one hundred iterations and the performance is substantially better than lasso as shown in Section 3. The EM algorithm is as shown in Algorithm 1.

To deal with big data problem with nm, we also propose an efficient algorithm by solving the much smaller (n × n) matrix inverse problem similar to [19]. The algorithm is based on the following fact:

DXtX+λIm1DXt=DXtXDXt+λIn1. (27)

So θ has the analytical solution:

θ=DXtXDXt+λIn1y. (28)

The dual L 0EM (DL 0EM) algorithm dealing with nm problem with (28) is as shown in Algorithm 2.

Apparently, while L 0EM algorithm is efficient for solving the large n big data problem, DL 0EM can handle nm problem more efficiently.

Algorithm 1.

Algorithm 1

L 0EM algorithm.

Algorithm 2.

Algorithm 2

DL 0EM algorithm.

Lemma 3 . —

Given appropriate initial θ 0, the final solution of L 0EM and DL 0EM algorithm is an optimal solution for L 0 approximation problem that minimizes E = (1/2)‖y2 + (λ/2) | R| in (3).

Proof —

First, we show that the proposed algorithm is L 0 approximation. Given a high-dimensional matrix X n×m(nm) and a threshold γ for the coefficient estimates, L 0 rejects all the coefficient estimates below γ to 0 and keeps the large coefficients unchanged. This is the same as defining a binary vector S = [0,…, 1,…, 1]t, with the value of 0 or 1 for each feature, where S j = 1, if the coefficient estimate for that feature is above the threshold γ and 0 otherwise. Let S = diag⁡(S) be a diagonal matrix with S on its diagonal; we have the selected feature matrix X S = XS. We can build the standard models with the matrix X S, if we know S in advance. For instance, we can estimate the coefficients of a ridge regression given X S and y with

θXStXS+λI1XSty=XStX+λI1XtSy=SXtX+λI1SXty, (29)

where X S t X S = SX t XS = SX t X because of the special structure of matrix S. It is guaranteed that the estimate for feature j is 0 with S j = 0. However, in reality, we do not know S. Estimating both S and θ is NP-hard problem, since we need to solve a mixed-integer optimization problem. Comparing (29) with the M-step of the primal algorithm, θ = (DX t X + λI m)−1 DX t y, where D = diag⁡(η 1 2,…, η m 2); it is clear that S is replaced by D and binary S j is approximated by continuous η j 2 in the proposed algorithm. Therefore, The proposed algorithm is a direct L 0 approximation.

Next, we show that the proposed algorithm leads to a sparse solution. Note that the penalties for L 0 regularized regression in (4) are inversely proportional to the squared magnitude of the parameters. That is,

λj=λ2ηj2ifηj0ifηj=0, (30)

and η = θ, when L 0EM or DL 0EM algorithm converges. Equation (30) shows that when the true parameter θ j = 0, the penalty λ j goes to infinity, so θ^j must be 0 with the proposed algorithms. In addition, when the true parameters θ j ≠ 0,

E=12yXθ2+λ2jRθj2ηj2=12yXθ2+λ2R, (31)

because η j = θ j, when the algorithm converges. Therefore, Lemma 3 holds. Note that our proposed methods will find a sparse solution with a large number of iterations and small ε, even though the solution of L 2 regularized regression is not sparse. Small parameters (θ js) become smaller at each iteration and will eventually go to zero (below the machine epsilon). We can also set a parameter to 0 if it is below predefined ε = 10e − 6 to speed up the convergence of the algorithm.

The proposed algorithms are similar to the iteratively reweighted least square approach for L p/L q optimization in the literature [20, 21]. However, instead of solving L p optimization problem directly, they added a small value ε in θ j 2/(η j 2−p + ε) to handle the undefined 0/0 problem when θ j = 0, leading to approximation and bias estimations. In our proposed algorithm, 0s are multiplied into the feature matrix X (X D = XD). There is no undefined 0/0 problem in the proposed algorithm. Finally, similar procedures can be extended to general L p; p ∈ [0,2] without much difficulty. L p based EM algorithm L pEM and the statistical properties of L 0 penalized regression are reported in the Appendix in Supplementary Material available online at http://dx.doi.org/10.1155/2016/3456153. The proposed L pEM algorithm is similar to adaptive lasso [7] in that both use a weighted penalty. However, the weights in adaptive lasso are predetermined by ordinary least estimates when n > m and univariate regression coefficients when n < m, which may lead to inaccurate estimate. In contrary, our proposed L pEM updates the weights with an analytical solution at each iteration and automatically finds the optimal weights and estimates.

L 0 Based Local Graphical Model. One important application of L 0 regularized regression is to detect high-order correlation structures, which have numerous real-world applications including gene network analysis. Given matrix X, let x j be the jth variable, and let X j be the remaining variables; we have P(x jX j) ~ N(X j θ, σ 2), where the coefficients θ measure the partial correlations between x j and the rest of variables. Therefore, we will minimize

argminθEθ=argminθxjXjθ2+λθ0. (32)

The high-order structure of X has been determined via a series of L 0 regularized regressions for each x j with the remaining variables X j. The collected regression nonzero coefficients are the edges on the graph. L 0 local graphical model without cross validation is much efficient computationally than L 1 local graphical model. L 1 local graphical model is computationally intensive, because the regularized parameter λ for L 1 has to be determined through cross validation [22, 23]. For instance, given a matrix X with 100 variables, to find the optimal λ opt from 100 candidate λ's with 5-fold cross validation, 500 models need to be evaluated for each variable x j. Therefore a total of 500 × 100 = 50000 models have to be estimated to detect the dependency among X with lasso. It usually takes hours to solve this problem. However, only 100 models are required to identify the same correlation structure with L 0 regularized regression and AIC or BIC, which only takes less than one minute to solve a similar problem. Notice that negative correlations between genes are difficult to confirm and seemingly less biologically relevant [24]. Most national databases are constructed with similarity (dependency) measures. It is straightforward to study only the positive dependency by simply setting θ  (θ < 0) = 0 in the EM algorithm.

Determination of λ. Regularized λ determines the sparsity of the model. The standard approach for choosing λ is cross validation and optimal λ is determined by the minimal mean squared error (MSE) of the test data (MSE=(yi-yi^)2/n). One could also adapt the stability selection (SS) approach for λ determination [25, 26]. It chooses smallest λ that minimizes the inconsistencies in number of nonzero parameters with cross validation. We first calculate the mean and standard deviation (SD) of the number of nonzero parameters for each λ and then find smallest λ with SD = 0, where SD = 0 indicates that all models in k-fold cross validation have the same number of nonzero estimates. Our experiences indicate that larger λ chosen from both minimal MSE and stability selection (λ = max⁡{λ MSE, λ SS}) has the best performance. Choosing optimal λ from cross validation is computationally intensive and time-consuming. Fortunately, unlike lasso, identifying optimal λ for L 0 does not require using cross validation. Optimal λ opt can be determined by variable selection criteria. Optimal λ opt can be directly picked using AIC, BIC, or RIC criteria with λ opt = 2, log⁡n, or 2log⁡m, respectively. Each of these criteria is known to be optimal under certain conditions. This is a huge advantage of L 0, especially for big data problems. In general, we recommend to use BIC as information criteria for high-dimensional problem (np) and to use AIC when n > p.

3. Results

3.1. Simulation Study Application

To evaluate the performance of L 0 and L 1 regulation, we assume a linear model y = + ε, where the input matrix X is from Gaussian distribution with mean μ = 0 and different covariance structures Σ, where Σ(i, j) = r |ij| with r = 0,0.3,0.6,0.8, respectively. The true model is y = 2x 1 − 3x 2 + 4x 5 + ε with ε ~ N(0,1). Therefore, only three features are associated with output y, and the rest of θ i's are zero. In our first simulation, we first compare L 0 and L 1 regularized regressions with a relatively small number of features m = 50 and a sample size of n = 100. Fivefold cross validation is used to determine optimal λ and compare the models performances. We seek to fit the regularized regression models over a range of regularization parameters λ. Each λ is chosen from λ min = 1e − 4 to λ max with 100 equally log-spaced intervals, where λ max = max⁡{X t y} for L 1 and max⁡{(x j t y)2/4x j t x j} for L 0. Lasso function in the statistics toolbox of MATLAB (http://www.mathworks.com/) is used for comparison. Cross validation with MSE is implemented nicely in the toolbox. The computational results are reported in Table 1. Table 1 shows that L 0 outperforms lasso in all categories by a substantial margin, when using the popular test MSE measure for model selection. In particular, the number of variables selected by L 0 are close to 3, the true number of nonzero variables, while lasso selected more than 11 features on average with different correlation structures (r = 0,0.3,0.6,0.8). The test MSEs and bias both increase with the growth of correlation among features for both L 0 and lasso, but the test MSE and bias of L 0 are substantially lower than these of lasso. The maximal MSE of L 0 is 1.06, while the smallest MSE of L 1 is 1.19, and the largest bias of L 0 is 0.28, while the smallest bias of lasso is 0.38. In addition (results are not shown in Table 1), L 0 correctly identifies the true model 81, 74, 81, and 82 times for r = 0,0.3,0.6 and 0.8, respectively, over 100 simulations, while lasso never chooses the correct model. Therefore, compared to L 0 regularized regression, lasso selects more features than necessary and has larger bias in parameter estimation. Even though it is possible to get a correct model with lasso using larger λ, the estimated parameters will have a bigger bias and worse predicted MSE.

Table 1.

Performance measures for L 0 and L 1 regularized regression over 100 simulations, where values in the parentheses are the standard deviations. # SF: number of average selected features; MSE: average mean squared error; θ^-θ: average absolute bias when comparing true and estimated parameters.

r L 0 L 1
# SF MSE θ^-θ # SF MSE θ^-θ
0 3.39 (±1.1) 1.01 (±0.14) 0.206 (±0.12) 14.5 (±3.45) 1.19 (±0.19) 0.38 (±0.1)
0.3 3.37 (±0.9) 1.02 (±0.16) 0.23 (±0.12) 14.5 (±2.91) 1.21 (±0.19) 0.41 (±0.19)
0.6 3.49 (±1.7) 1.02 (±0.23) 0.23 (±0.16) 13.5 (±3.0) 1.26 (±0.2) 0.54 (±0.15)
0.8 3.32 (±0.9) 1.06 (±0.15) 0.28 (±0.21) 11.7 (±2.69) 1.3 (±0.21) 0.89 (±0.25)

The same parameter setting is used for our second simulation, but the regularized parameter λ is determined by larger λ from both minimal MSE and stability selection (λ = max⁡{λ MSE, λ SS}). The computational results are reported in Table 2. Table 2 shows that the average number of associated features is much closer to 3 with slightly larger test MSEs. The maximal average number of features is 3.1 with r = 0.6, reduced from 3.49 with the test MSE only. In fact, with this combined model selection criteria and 100 simulations, L 0EM identified the true model with three nonzero parameters 95, 95, 95, and 97 times, respectively (not shown in the table), while lasso did not choose any correct models. The average bias of the estimates with L 0EM is also reduced. These indicate that the combination of test MSE and stability selection in cross validation leads to better model selection results than MSE alone with L 0EM. However, the computational results did not improve much with lasso. Over 13 features on average were selected under different correlation structures, suggesting that lasso inclines to select more spurious features than necessary. A much more conservative criterion with larger λ is required to select the right number of features, which will induce larger MSE and bias and deteriorate the prediction performance.

Table 2.

Performance measures for L 0 and L 1 regularized regression with λ = max⁡{λ MSE, λ SS} over 100 simulations, where values in the parenthesis are the standard deviations. # SF: number of average selected features; MSE: average mean squared error; θ^-θ: average absolute bias when comparing true and estimated parameters.

r L 0 L 1
# SF MSE θ^-θ #SF MSE θ^-θ
0 3.09 (±0.53) 1.04 (±0.15) 0.18 (±0.11) 13.3 (±4.56) 1.21 (±0.17) 0.39 (±0.1)
0.3 3.08 (±0.54) 1.04 (±0.15) 0.17 (±0.07) 14.5 (±4.20) 1.22 (±0.17) 0.42 (±0.19)
0.6 3.10 (±0.46) 1.07 (±0.17) 0.21 (±0.10) 13.8 (±5.4) 1.27 (±0.47) 0.57 (±0.25)
0.8 3.02 (±0.14) 1.04 (±0.14) 0.26 (±0.13) 13.4 (±4.91) 1.25 (±0.21) 0.74 (±0.25)

Simulation with High-Dimensional Data. Our third simulation deals with high-dimensional data with the number of samples n = 100 and the number of features m = 1000. The correlation structure is set to r = 0,0.3,0.6, and the same model y = 2x 1 − 3x 2 + 4x 5 + ε was used for evaluating model performance. Besides L 1, L 0 was also compared with two other cutting-edge regulations including SCAD and MC+, implemented in SparseReg package [27]. The simulation was repeated 100 times. The computational results are reported in Table 3. Table 3 shows that L 0 outperforms lasso by a large margin when correlations among features are low. When there is no correlation among features, 100 out of 100 simulations identify the true model with L 0, and 78 out of 100 simulations choose the correct model when r = 0.3, while lasso, SCAD, and MC+ choose more features than necessary and no true model was found under any correlation setting. However, when correlations among features are large with r = 0.6, the results are mixed. L 0 can still identify 23 out of 100 correct models, but the test MSE and bias of the parameter estimate of L 0 are slightly large than those of lasso, MC+, and SCAD. MC+ has the second best performance with less bias and smaller test MSE but chooses more features than necessary. In addition, we notice that L 0 is a more sparse model when correlation increases, indicating that L 0 tends to choose independent features. One reason for selecting more features with SCAD and MC+ may be that we only tuned the parameter λ and fixed γ = 3.7 and γ = 1 for SCAD and MC+, respectively. A regularization path of L 0 regression is shown in Figure 1. As shown in Figure 1(a), the three associated features first increase their values when λ goes larger and then go to zero when λ becomes extremely big, while the rest of the irrelevant features all go to zero when λ increases. Unlike lasso, which shrinks all parameters uniformly, L 0 will only force the estimates of irrelevant features to go to zero, while keeping the estimates of relevant features to their true value. This is the well-known oracle property of L 0. The oracle property means that the penalized estimator is asymptotically equivalent to the oracle estimator obtained only with signal variables without penalization. For this specific simulation, the three parameters [θ1^,θ2^,θ5^]=[1.85,-2.94,4.0], very close to their true values [2, −3,4]. Figures 1(b) and 1(c) are the test MSE and the standard deviation of the number of nonzero variables. Optimal λ is chosen from larger λ with minimal test MSE and stability selection as shown in the vertical lines of Figure 1.

Table 3.

Performance measures for L 0, L 1, SCAD, and MC+ regularized regressions with cross validation and λ = Max⁡⁡{λ MSE, λ SS} over 100 simulations and the sample size of n = 100, and m = 1000, where values in the parenthesis are the standard deviations. # SF: number of average selected features; MSE: average mean squared error; θ^-θ: average absolute bias when comparing true and estimated parameters.

Measures r = 0 r = 0.3 r = 0.6
L 0 # SF 3 (±0) 2.9 (±0.47) 2 (±0.73)
θ^-θ 0.14 (±0.09) 0.39 (±0.63) 1.69 (±1.25)
Test MSE 1.14 (±0.34) 1.59 (±1.3) 2.8 (±1.72)
# true model 100/100 78/100 23/100

L 1 # SF 24 (±18.4) 31.3 (±20.7) 36.7 (±16.5)
θ^-θ 0.57 (±0.11) 0.73 (±0.13) 1.14 (±0.25)
Test MSE 1.50 (±0.25) 1.63 (±0.29) 1.92 (±0.41)
# true model 0/100 0/100 0/100

SCAD # SF 106.8 (±110.6) 73 (±111) 56.2 (±62.4)
θ^-θ 0.62 (±0.13) 0.72 (±0.14) 1.13 (±0.26)
Test MSE 1.32 (±0.27) 1.54 (±0.27) 2.04 (±0.51)
# true model 0/100 0/100 0/100

MC+ # SF 60.3 (±38.6) 70.5 (±26.0) 78.73 (±16.5)
θ^-θ 0.56 (±0.14) 0.66 (±0.12) 0.78 (±0.17)
Test MSE 1.25 (±0.21) 1.31 (±0.27) 1.46 (±0.27)
# true model 0/100 0/100 0/100

Figure 1.

Figure 1

Regularized path for L 0 penalized regression with n = 100, m = 1000, and r = 0.3.

L 0 Regularized Regression without Cross Validation. Choosing the optimal parameter λ opt with cross validation is time-consuming, especially with big data. As we mentioned previously, optimal λ can be picked from theory instead of cross validation. Since we are dealing with nm big data problem, RIC with λ opt = 2log⁡m tends to penalize the parameters too much. So computational results with AIC and BIC without cross validation are reported in Table 4. Table 4 shows that L 0 regularized regression with AIC and BIC performs very well when compared with the results from computationally intensive cross validation in Table 3. Without correlation, BIC identifies the true model (100%), which is the same as cross validation in Table 3 and better than AIC's 78%. The bias of BIC (0.16) is only slightly higher than that of cross validation (0.14) but lower than that of AIC (0.19). Even though MSE's with AIC and BIC are in-sample mean squared errors, which are not comparable to the test MSE with cross validation, larger MSE with BIC indicates that BIC is a more stringent criterion than AIC and selects less variables. With mild correlation (r = 0.3) and some sacrifices in bias and MSE, BIC performs better than AIC in variable selection, since the average number of features selected is exactly 3 and 94% of the simulations recognize the true model, while AIC chooses more features (3.72) than necessary and only 73% of the simulations are right on targets. Cross validation is the most tight measure with 2.9 features on average and 75% of the simulations finding the correct model. When the correlations among the variables are high (r = 0.6), the results are mixed. Both BIC and AIC correctly identify more than half of the true models, while cross validation only recognizes 25% (5/20) of the model correctly. Therefore, compared with the computationally intensive cross validation, both BIC and AIC perform reasonably well. The performance of BIC is similar to cross validation with less computational time. In addition, we have suggested to use the result of ridge regression as the initial value for the proposed algorithms. However, the proposed algorithm is quite stable with different initializations. With n = 100, p = 200, r = 0.3, and 100 times of randomized initializations, the estimates of three nonzero parameters are [β 1, β 2, β 5] = [2.05 ± 0.08, −2.89 ± 0.08,4.01 ± 0.09] with BIC criteria.

Table 4.

Performance measures for L 0 regularized regression with AIC and BIC over 100 simulations with n = 100, and m = 1000, where values in the parenthesis are the standard deviations. # SF: number of average selected features; MSE: in-sample average mean squared error; θ^-θ: average absolute bias when comparing true and estimated parameters.

Measures r = 0 r = 0.3 r = 0.6
AIC # SF 3.26 (±0.54) 3.72 (±1.94) 4.8 (±2.77)
θ^-θ 0.19 (±0.09) 0.36 (±0.58) 1.02 (±1.2)
MSE 0.96 (±0.14) 1.02 (±0.31) 1.27 (±0.51)
# true model 78/100 73/100 59/100

BIC # SF 3.0 (±0.0) 3.0 (±0.38) 2.89 (±0.80)
θ^-θ 0.16 (±0.08) 0.45 (±0.69) 1.80 (±1.20)
MSE 0.97 (±0.15) 1.29 (±0.81) 2.48 (±1.17)
# true model 100/100 94/100 53/100

Simulations for Graphical Models. We simulate two network structures similar to those in Zhang and Mallick [28]: (i) band 1 network, where Σ is a covariance matrix with σ ij = 0.6|ij|, so A = Σ−1 has a band 1 network structure, and (ii) a more difficult problem for a band 2 network with weaker correlations, where A = −Σ−1 with

aij=0.25ifij=10.4ifij=20otherwise. (33)

The sample sizes are n = 50, 100, and 200, respectively, and the number of variables is m = 100. L 0 regularized regression with AIC and BIC is used to detect the network (correlation) structure. The consistency between the true and predicted structures is measured by the area under the ROC curve (AUC), false discovery (positive) rate (FDR/FPR), and false negative rate (FNR) of edges. The computational results are shown in Table 5. Table 5 shows that both AIC and BIC performed well. Both achieved at least 0.90 AUC for band 1 network and 0.8 AUC for band 2 network with different sample sizes. AIC performed slightly better than BIC, especially for band 2 network with weak correlations and small sample sizes. This is reasonable because BIC is a heavier penalty and forces most of the weaker correlations with a ij = 0.25 to 0. In addition, BIC has slightly larger AUCs for band 1 network with strong correlation r = 0.6 and larger sample size (n = 100, 200). One interesting observation is that FDRs of both AIC and BIC are well controlled. Maximal FDRs of AIC for bands 1 and 2 networks are 0.29% and 0.2%, while maximal FDRs of BIC are only 0.1%, and 0.03%, respectively. Controlling false discovery rates is crucial for identifying true associations with high-dimensional data in bioinformatics. In general, AUC increases and both FDR and FNR decrease, as the sample sizes become larger, except for band 2 network with BIC. The performance of BIC is not necessarily better with a larger sample size, since the penalty λ increases with the sample size. L 1 graphical model was also used for comparison purpose [29, 30]. L 1 graphical model performed equally well as AIC and BIC with band 1 network but was the worst with the more difficult band 2 network. More interestingly, L 1 had the largest FDR, indicating that it selects more features than necessary.

Table 5.

Performance measures for L 0 regularized regression for graphical structure detection over 100 simulations, where values in the parenthesis are the standard deviations.

Band 1 Band 2
AIC AUC FDR (%) FNR (%) AUC FDR (%) FNR (%)
n = 50 .95 (±.01) .29 (±.08) 9.4 (±2.6) .82 (±.01) .10 (±.05) 36.7 (±1.5)
100 .99 (±.005) .20 (±.06) 1.2 (±1.1) .84 (±.01) .11 (±.04) 32.7 (±1.9)
200 .999 (±.0003) .20 (±.05) 0 (±0) .93 (±.01) .11 (±.04) 14.2 (±2.4)

BIC AUC FPR (%) FNR (%) AUC FPR (%) FNR (%)

n = 50 .90 (±.02) .10 (±.05) 20 (±3.6) .803 (±.008) .02 (±.02) 39.3 (±1.5)
100 .991 (±.007) .03 (±.03) 1.8 (±1.3) .83 (±.01) .03 (±.02) 34.9 (±1.6)
200 .9999 (±.0005) .01 (±.01) .01 (±.10) .82 (±.01) .03 (±.02) 36.7 (±1.8)

L 1 AUC FPR (%) FNR (%) AUC FPR (%) FNR (%)

n = 50 .91 (±.03) 3.5 (±.05) 11 (±3.6) 0.77 (±.01) 5.3 (±.07) 40.9 (±.62)
100 .99 (±.003) 1.52 (±.22) .33 (±.67) 0.78 (±.007) 7.1 (±1.4) 36.3 (±1.1)
200 .99 (±.003) 1.21 (±.07) .45 (±.53) 0.79 (±.01) 8.1 (±.57) 34.0 (±1.4)

3.2. Application to Real Ovarian Cancer Data

The purpose of this application is to identify subnetworks and study the biological mechanisms of potential prognostic biomarkers for ovarian cancer with multisource gene expression data. The ovarian cancer data was downloaded from the KMplot website (http://www.kmplot.com/ovar/) [31]. They originally got the data from searching Gene Expression Omnibus (GEO; http://www.ncbi.nlm.nih.gov/geo/) and The Cancer Genome Atlas (TCGA; http://cancergenome.nih.gov/) with multiple platforms. All collected datasets have raw gene expression data, survival information, and at least 20 patients available. They merged the datasets across different platforms carefully. The final data has 1287 patients samples and 22277 probe sets representing 13435 common genes. We identified 112 top genes that are associated with patient survival times using univariate Cox regression. We constructed a coexpression network from the 112 genes with L 0 regularized regression and identified biologically meaningful subnetworks (modules) associated with patient survival. Network is constructed with positive correlation only and BIC. The computational time for constructing such network is less than 2 seconds. One survival associated subnetwork we identified is given in Figure 2. The 22 genes on the subnetwork were then uploaded onto STRING (http://string-db.org/). STRING is an online database for exploring known and predicted protein-protein interactions (PPI). The interactions include direct (physical) and indirect (functional) associations. The predicted methods for PPI implemented in STRING include text mining, national databases, experiments, coexpression, cooccurrence, gene fusion, and neighborhood on the chromosome. The PPI networks for the 22 genes are presented in Figure 3. Comparing Figures 3 and 2, we conclude that the 22 identified genes on the subnetwork of Figure 2 are functioning together and have enriched important biological interactions and associations. Nineteen out of 22 genes on the survival associated subnetwork also have interactions on the known and predicted PPI network, except for genes LRRC15, ADAM12, and NKX3-2. Even though they are not completely identical, many interactions on our subnetwork can also be verified on the PPI interaction network of Figure 3. For instance, collagen COL5A2 is the most important gene with the largest number of degrees (7) on our subnetwork. Six out of 7 genes that link to COL5A2 also have direct edges on the PPI network. Those direct connected genes (proteins) include FAP, CTSK, VCAN, COL1A1, COL5A1, and COL11A1. The remaining gene SNAI2 was indirectly linked to COL5A2 through FBN1 on the PPI network. In addition, one of the other important genes with the degree of the node (6) is Decorin (DCN). Four out of 6 genes directly connected to DCN on our subnetwork were confirmed on the PPI network, including FBN1, CTSK, LUM, and THBS2. The remaining two genes (SNAI2 and COLEC11) are indirectly connected to DCN on the PPI network. As indicated on Figure 2, the remaining 5 important genes with degree of node 4 are POSTN, CTSK, COL1A1, COL5A1, and COL10A1, and 8 genes with degree of node 3 are FBN1, LUM, LRRC15, COL11A1, THBS2, SPARC, COL1A2, and FAP, respectively. Furthermore, those 22 genes are involved in the biological process of GO terms, including extracellular matrix organization and disassembly and collagen catabolic, fibril, and metabolic processes. They are also involved in several important KEGG pathways including ECM-receptor interaction, protein digestion and absorption, amoebiasis, focal adhesion, and TGF-β signaling pathways. Finally, a large proportion of the 22 genes are known to be associated with poor overall survival (OS) in ovarian cancer. For instance, VCAN and POSTN were demonstrated in vitro to be involved in ovarian cancer invasion induced by TGF-β signaling [32], and COL11A1 was shown to increase continuously during ovarian cancer progression and to be highly overexpressed in recurrent metastases. Knockdown of COL11A1 reduces migration, invasion, and tumor progression in mice [33]. Other genes such as FAP, CTSK, FBN1, THBS2, SPARC, and COL1A1 are also known to be ovarian cancer associated [3439]. Those genes contribute to cell migration and the progression of tumors and may be potential therapeutic targets for ovarian cancer, indicating that the proposed method can be used to construct biologically important networks efficiently.

Figure 2.

Figure 2

Subnetwork constructed with L 0 penalized regression, multisource gene expression profiling, and BIC.

Figure 3.

Figure 3

Known and predicted protein-protein interactions with the 22 genes on the subnetwork of Figure 2, where nodes represent proteins (genes) and edges indicate the direct (physical) and indirect (functional) associations. Stronger associations are represented by thicker lines.

4. Discussion

We proposed efficient EM algorithms for variable selection with L 0 regularized regression. The proposed algorithms find the optimal solutions of L 0 through solving a sequence of L 2 based ridge regressions. Given an initial solution, the algorithm will be guaranteed to converge to a unique solution under mild conditions, and the EM algorithm will be closer to the optimal solution after each iteration. Asymptotic properties, namely, consistency and oracle properties for exact L 0, are established under mild conditions. Our method applies to fixed, diverging, and ultra-high-dimensional problems with ten or hundred thousands of features. We compare the performance of L 0 regularized regression and lasso with simulated low- and high-dimensional data. L 0 regularized regression outperforms lasso, SCAD, and MC+ by a substantial margin under different correlation structures. Unlike lasso, which selects more features than necessary, L 0 regularized regression chooses the true model with high accuracy, less bias, and smaller test MSE, especially when the correlation is weak. Cross validation with the computation of the entire regularization path is computationally intensive and time-consuming. Fortunately L 0 regularized regression does not require it. Optimal λ opt can be directly determined from AIC, BIC, and RIC. Those criteria are optimal under appropriate conditions. We demonstrate that both AIC and BIC performed well when compared to cross validation. Therefore, there is a big computational advantage of L 0, especially with big data. In addition, we demonstrate that L 0 regularized regression controls the false discovery (positive) rate (FDR) well with both AIC and BIC with the simulation of graphical models. The FDR is very low under different sample sizes with both AIC and BIC. Controlling FDR is crucial for biomarker discovery and computational biology, because further verifying the candidate biomarkers is time-consuming and costly. We applied our proposed method to construct a network for ovarian cancer from multisource gene expression data and identified a subnetwork that is important both biologically and clinically. We demonstrated that we can identify biologically important genes and pathways efficiently. Even though we demonstrated our method with gene expression data, the proposed method can be used for RNA-seq and metagenomic data, given that the data are appropriately normalized. Finally, because of the nonconvexity of L 0 regularized regression, there are multiple local optimal solutions for θ j including a trivial solution θ j = 0, ∀j = 1,…, m, as shown in (28). However, the nontrivial solution can be found efficiently as long as all parameters were initialized with nonzero values. We recommend the solution of ridge regression as an initial solution for the proposed algorithms.

Supplementary Material

LpEM Algorthm and Statistical Properties.

3456153.f1.pdf (66.3KB, pdf)

Competing Interests

The authors declare that they have no competing interests.

References

  • 1.Akaike H. A new look at the statistical model identification. IEEE Transactions on Automatic Control. 1974;19:716–723. [Google Scholar]
  • 2.Schwarz G. Estimating the dimension of a model. The Annals of Statistics. 1978;6(2):461–464. doi: 10.1214/aos/1176344136. [DOI] [Google Scholar]
  • 3.Foster D. P., George E. I. The risk inflation criterion for multiple regression. The Annals of Statistics. 1994;22(4):1947–1975. doi: 10.1214/aos/1176325766. [DOI] [Google Scholar]
  • 4.Tibshirani R. Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society, Series B: Methodological. 1996;58(1):267–288. [Google Scholar]
  • 5.Li J. J., Jiang C.-R., Brown J. B., Huang H., Bickel P. J. Sparse linear modeling of next-generation mRNA sequencing (RNA-Seq) data for isoform discovery and abundance estimation. Proceedings of the National Academy of Sciences of the United States of America. 2011;108(50):19867–19872. doi: 10.1073/pnas.1113972108. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Li Y., Liang M., Zhang Z. Regression analysis of combined gene expression regulation in acute myeloid leukemia. PLoS Computational Biology. 2014;10(10) doi: 10.1371/journal.pcbi.1003908.e1003908 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Zou H. The adaptive lasso and its oracle properties. Journal of the American Statistical Association. 2006;101(476):1418–1429. doi: 10.1198/016214506000000735. [DOI] [Google Scholar]
  • 8.Mancera L., Portilla J. L 0 norm based sparse representation through alternative projections. Proceedings of the International Conference on Image Processing (ICIP '06); 2006. [Google Scholar]
  • 9.Lin D., Foster D. P., Ungar L. H. Philadelphia, Pa, USA: University of Pennsylvania; 2010. A risk ratio comparison of L 0 and L 1 penalized regressions. [Google Scholar]
  • 10.Fan J., Li R. Variable selection via nonconcave penalized likelihood and its oracle properties. Journal of the American Statistical Association. 2001;96(456):1348–1360. doi: 10.1198/016214501753382273. [DOI] [Google Scholar]
  • 11.Liu Z., Lin S., Tan M. Sparse support vector machines with L p penalty for biomarker identification. IEEE/ACM Transactions on Computational Biology and Bioinformatics. 2010;7(1):100–107. doi: 10.1109/tcbb.2008.17. [DOI] [PubMed] [Google Scholar]
  • 12.Mazumder R., Friedman J. H., Hastie T. SparseNet: coordinate descent with nonconvex penalties. Journal of the American Statistical Association. 2011;106(495):1125–1138. doi: 10.1198/jasa.2011.tm09738. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Zhang C.-H. Nearly unbiased variable selection under minimax concave penalty. The Annals of Statistics. 2010;38(2):894–942. doi: 10.1214/09-AOS729. [DOI] [Google Scholar]
  • 14.Dicker L., Huang B., Lin X. Variable selection and estimation with the seamless-L 0 penalty. Statistica Sinica. 2013;23:929–962. doi: 10.5705/ss.2011.074. [DOI] [Google Scholar]
  • 15.Lu Z., Zhang Y. Sparse approximation via penalty decomposition methods. SIAM Journal on Optimization. 2013;23(4):2448–2478. doi: 10.1137/100808071. [DOI] [Google Scholar]
  • 16.Zou H., Zhang H. H. On the adaptive elastic-net with a diverging number of parameters. The Annals of Statistics. 2009;37(4):1733–1751. doi: 10.1214/08-AOS625. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17.Liu Y., Wu Y. Variable selection via a combination of the L0 and L1 penalties. Journal of Computational and Graphical Statistics. 2007;16(4):782–798. doi: 10.1198/106186007x255676. [DOI] [Google Scholar]
  • 18.Fan Y., Tang C. Y. Tuning parameter selection in high dimensional penalized likelihood. Journal of the Royal Statistical Society—Series B: Statistical Methodology. 2013;75(3):531–552. doi: 10.1111/rssb.12001. [DOI] [Google Scholar]
  • 19.Liu Z., Sun F., Braun J., McGovern D. P. B., Piantadosi S. Multilevel regularized regression for simultaneous taxa selection and network construction with metagenomic count data. Bioinformatics. 2015;31(7):1067–1074. doi: 10.1093/bioinformatics/btu778. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20.Lai M. J., Xu Y. Y., Yin W. T. Improved iteratively reweighted least squares for unconstrained smoothed ℓ q minimization. SIAM Journal on Numerical Analysis. 2013;51(2):927–957. doi: 10.1137/110840364. [DOI] [Google Scholar]
  • 21.Daubechies I., DeVore R., Fornasier M., Güntürk C. S. Iteratively re-weighted least squares minimization for sparse recovery. Communications on Pure and Applied Mathematics. 2010;63(1):1–38. doi: 10.1002/cpa.20303. [DOI] [Google Scholar]
  • 22.Peng J., Wang P., Zhou N., Zhu J. Partial correlation estimation by joint sparse regression models. Journal of the American Statistical Association. 2009;104(486):735–746. doi: 10.1198/jasa.2009.0126. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Liu Q., Ihler A. Learning scale free networks by reweighted L1 regularization. Proceedings of the 14th International Conference on Artificial Intelligence and Statistics (AISTATS '11); 2011; Fort Lauderdale, Fla, USA. [Google Scholar]
  • 24.Lee H. K., Hsu A. K., Sajdak J., Qin J., Pavlidis P. Coexpression analysis of human genes across many microarray data sets. Genome Research. 2004;14(6):1085–1094. doi: 10.1101/gr.1910904. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Liu H., Roeder K., Wasserman L. Advances in Neural Information Processing Systems. MIT Press; 2010. Stability approach to regularization selection for high dimensional graphical models. [PMC free article] [PubMed] [Google Scholar]
  • 26.Meinshausen N., Bhlmann P. Stability selection. Journal of the Royal Statistical Society: Series B (Statistical Methodology) 2010;72(4):417–473. doi: 10.1111/j.1467-9868.2010.00740.x. [DOI] [Google Scholar]
  • 27.Zhou H., Wu Y. A generic path algorithm for regularized statistical estimation. Journal of the American Statistical Association. 2014;109(506):686–699. doi: 10.1080/01621459.2013.864166. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28.Zhang L., Mallick B. K. Inferring gene networks from discrete expression data. Biostatistics. 2013;14(4):708–722. doi: 10.1093/biostatistics/kxt021. [DOI] [PubMed] [Google Scholar]
  • 29.Liu Z., Lin S., Piantadosi S. Network construction and structure detection with metagenomic count data. BioData Mining. 2015;8, article 40 doi: 10.1186/s13040-015-0072-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Liu Z., Lin S., Deng N., McGovern D., Piantadosi S. Sparse inverse covariance estimation with L0 penalty for network construction with omics data. Journal of Computational Biology. 2016;23(3):192–202. doi: 10.1089/cmb.2015.0102. [DOI] [PubMed] [Google Scholar]
  • 31.Gyorffy B., Lánczky A., Szállási Z. Implementing an online tool for genomewide validation of survival-associated biomarkers in ovarian-cancer using microarray data from 1287 patients. Endocrine-Related Cancer. 2012;19(2):197–208. doi: 10.1530/erc-11-0329. [DOI] [PubMed] [Google Scholar]
  • 32.Yeung T.-L., Leung C. S., Wong K.-K., et al. TGF-β Modulates ovarian cancer invasion by upregulating CAF-Derived versican in the tumor microenvironment. Cancer Research. 2013;73(16):5016–5028. doi: 10.1158/0008-5472.can-13-0023. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Cheon D.-J., Tong Y., Sim M.-S., et al. A collagen-remodeling gene signature regulated by TGF-β signaling is associated with metastasis and poor survival in serous ovarian cancer. Clinical Cancer Research. 2014;20(3):711–723. doi: 10.1158/1078-0432.ccr-13-1256. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Riester M., Wei W., Waldron L., et al. Risk prediction for late-stage ovarian cancer by meta-analysis of 1525 patient samples. Journal of the National Cancer Institute. 2014;106(5) doi: 10.1093/jnci/dju048.dju048 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Zhao G., Chen J., Deng Y., et al. Identification of NDRG1-regulated genes associated with invasive potential in cervical and ovarian cancer cells. Biochemical and Biophysical Research Communications. 2011;408(1):154–159. doi: 10.1016/j.bbrc.2011.03.140. [DOI] [PubMed] [Google Scholar]
  • 36.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]
  • 37.Gardi N. L., Deshpande T. U., Kamble S. C., Budhe S. R., Bapat S. A. Discrete molecular classes of ovarian cancer suggestive of unique mechanisms of transformation and metastases. Clinical Cancer Research. 2014;20(1):87–99. doi: 10.1158/1078-0432.CCR-13-2063. [DOI] [PubMed] [Google Scholar]
  • 38.Tang L., Feng J. SPARC in tumor pathophysiology and as a potential therapeutic target. Current Pharmaceutical Design. 2014;20(39):6182–6190. doi: 10.2174/1381612820666140619123255. [DOI] [PubMed] [Google Scholar]
  • 39.Yu P.-N., Yan M.-D., Lai H.-C., et al. Downregulation of miR-29 contributes to cisplatin resistance of ovarian cancer cells. International Journal of Cancer. 2014;134(3):542–551. doi: 10.1002/ijc.28399. [DOI] [PubMed] [Google Scholar]

Associated Data

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

Supplementary Materials

LpEM Algorthm and Statistical Properties.

3456153.f1.pdf (66.3KB, pdf)

Articles from Computational and Mathematical Methods in Medicine are provided here courtesy of Wiley

RESOURCES