Skip to main content

Gene differential coexpression analysis based on biweight correlation and maximum clique

Abstract

Differential coexpression analysis usually requires the definition of 'distance' or 'similarity' between measured datasets. Until now, the most common choice is Pearson correlation coefficient. However, Pearson correlation coefficient is sensitive to outliers. Biweight midcorrelation is considered to be a good alternative to Pearson correlation since it is more robust to outliers. In this paper, we introduce to use Biweight Midcorrelation to measure 'similarity' between gene expression profiles, and provide a new approach for gene differential coexpression analysis. Firstly, we calculate the biweight midcorrelation coefficients between all gene pairs. Then, we filter out non-informative correlation pairs using the 'half-thresholding' strategy and calculate the differential coexpression value of gene, The experimental results on simulated data show that the new approach performed better than three previously published differential coexpression analysis (DCEA) methods. Moreover, we use the maximum clique analysis to gene subset included genes identified by our approach and previously reported T2D-related genes, many additional discoveries can be found through our method.

Background

DNA Microarray has been widely used as measurement tools in gene expression data analysis [1–4]. Gene expression profiling data from DNA microarray can detect the expression levels of thousands of genes simultaneously. Which provide an effective way for mining disease-related genes nalysis of gene expression data can be divided into three levels: firstly, analysis the expression level of individual genes, and to determine its function based on gene expression level changes under different experimental conditions. For example, the tumor type specific genes are identified according to the significance of difference in gene expression using the statistical hypothesis testing analysis method. Secondly, study gene interaction and co-regulation through the combination of genes and grouping. Finally, attempt to deduce the potential gene regulatory networks mechanism and explain the observed gene expression data.

Among the microarray data analysis methods, gene differential expression analysis is one of the most widely used types of analysis for disease research. Gene differential expression analysis method selects differentially expressed genes according to expression change value of a single gene. Gene expression value change between normal samples and disease samples can be used to present the possibility of the relation between gene and disease. However, the traditional pathogenicity genes selection methods based on gene expression data treats each gene individually and the interaction between them is not considered. Actually, genes and their protein products do not perform their functions in isolation [5, 6], but in cooperation. Functional changes such as alteration in tumor cell growth process, energy metabolism and immune activity are accompanied with gene coexpression changes. Differentially expressed genes selection methods often focus only on the size of the single gene and disease relation, ignoring a plurality of pathogenic genes of the complex disease as a gene module with disease related, as well as within the module gene [7].

Differential coexpression analysis, as a more comprehensive technique to the differential expression analysis, was raised to research gene regulatory networks and biological pathways of phenotypic changes through measure gene correlation changes between disease and normal conditions. Differential coexpression genes are defined as genes whose correlated expression pattern differs between classes [8]. The gene coexpression changes between different conditions indicate gene regulatory pathways and networks associated with disease. In gene differential coexpression analysis, a pair of gene expression datasets under disease and normal conditions are transformed to a pair of coexpression matrix in which links represent transcriptionally correlated gene pairs, and then the differential coexpression score is calculated for each gene [9].

Until now, methods for differential coexpression analysis of gene expression data have been extensively researched, and multiple algorithms have been developed and tested [10–13]. Carter [10] mined the molecular characteristics of the cell state through gene coexpression topology method. Stuart et al. [14] and Bergmann et al. [15] separately constructed the gene coexpression network that connected genes whose expression profiles were similar across different organisms. They showed that functionally related genes are frequently coexpressed across organisms constituting conserved transcription modules [5]. Graeber [16] and Choi [5] both studied cancer from the perspective of differential coexpression. They found some genes were not be detected from the perspective of gene differential expression analysis. Butte [17] found gene coexpression modules based on a new gene expression similarity measure method, i.e., mutual information. Varadan [18] searched for disease-related gene differential coexpression modules from all gene subsets by entropy minimization and Boolean reduction methods (EMBP). Bansal [19], Della Gtta [20] and Lorenz [21] used linear regression method to excavate relation of gene transcription and regulation separately. In those gene differential coexpression analysis methods, the most common choice of similarity measurement is Pearson correlation coefficients [5, 11, 12, 22]. However, Pearson correlation is sensitive to outliers. Biweight midcorrelation (bicor) is considered to be a good alternative to Pearson correlation since it is more robust to outliers [23].

Graph theoretical concepts are useful for description and analysis of interaction and relationships in biological systems. The maximum clique problem (MCP) is a classical combinatorial optimization problem in graph theory. In 1957, Harary and Ross first proposed the deterministic algorithm to solve the maximum clique problem [24]. Since then many researchers have presented a variety of algorithms to solve this problem. The maximum clique problem is widely used in different areas, such as signal transmission, computer vision, and biological research etc. In this paper, we will use the concept of maximum clique to further investigate the identified gene set to gain insight into coexpression relationship between genes. For the sake of convenience, we use the terms graph and network interchangeably, the former stressing the mathematical concept, the latter the application. A graph consists of a set of nodes and a set of edges that connect the nodes. For a graph G = (V, E), the graph G is specified by the set of nodes V which also means genes in gene coexpression network, and the set of edges E which also represents gene coexpression relationships in gene network. A maximum clique means a clique which is a subset of the nodes in V that every pair of nodes in the subset is joined by an edge and is not a proper subset of any other clique.

However, the requirement of complete connectivity for gene maximum clique is restrictive. For real biological data network, its data size is large and has very complex relationships between the network nodes. When dealing with imperfect systems or with experimental data, we may need to consider more general notions of cohesive subgroups [25]. Our description here follows that of [26], they consider different notions of cohesive subgroups that include n-clique, k-plexes. In the analysis of gene expression data, genes closely linked functional module is not the strict sense of maximum clique due to the lack of certain section. We use density to measure approximation degree of functional module with maximum clique, making it more biological significance. In our study, we used the maximum clique concept to mine disease-related differential coexpression gene cluster.

In this paper, we propose a new approach for gene differential coexpression analysis based on Biweight Midcorrelation and half-threshoding strategy. Biweight midcorrelation is used to measure coefficients between the all gene pairs in normal condition and disease condition separately. The two gene correlation datasets are encoded into a pair correlations matrix over all gene pairs. We then filter out non-informative correlation pairs using the half-thresholding strategy and calculate the differential coexpression value of gene. We apply the new approach to a simulate dataset and a pair of type 2 diabetes(T2D) in rats datasets. Moreover, the maximum clique analysis are used to analyse the gene subset identified by our new approach and previously reported T2D-related genes in the dataset. In the light of this observation, we are confident that our method has a high potential for generating relevant hypotheses in biological and clinical research.

Methods

Biweight midcorrelation

Differential coexpression analysis usually requires the definition of 'distance' or 'similarity' between measured datasets, and the most common choice is Pearson correlation coefficient. However, Pearson correlation coefficient is sensitive to outliers. Biweight midcorrelation is considered to be a good alternative to Pearson correlation since it is more robust to outliers [23].

In Figure 1, for each sample Z, we measure the expression levels of p genes, let X ij denotes the expression level of the j th gene in the Z i sample, where j = 1,...p. The xth column vector of matrix represents the expression profile of the gene X. In order to define the biweight midcorrelation(bicor) [23] of two numeric vectors x = ( x 1 , . . . , x m ) and y = ( y 1 , . . . , y m ) , we first defines u i , v i with i = 1,...,m:

Figure 1
figure 1

Example of a gene expression matrix.

u i = x i - m e d ( x ) 9 m a d ( x )
(1)
v i = y i - m e d ( y ) 9 m a d ( y )
(2)

Where med(x) is the median of x, mad(x) is the median absolute deviation of x, mad(x) is the median of new numeric vector which each number is absolute difference between original vector value and med(x), this lead us to the definition of mad(x) and weight w i for x i , which are,

m a d ( x ) = m e d ( x i - m e d ( X ) )
(3)
w i ( x ) = ( 1 - u i 2 ) 2 I ( 1 - u i )
(4)

Where the indicator I ( 1 - u i ) takes 1 if 1 - u i > 0 and 0 otherwise. Thus, the weight w i ( x ) is close to 1 if x i is close to m e d ( x ) , approaches 0 when x i differs from by nearly 9 m a d ( x ) , and is 0 if x i differs from m e d ( x ) by more than 9 m a d ( x ) . An analogous weight w i ( x ) can be defined for y i . Given the weights, we can define biweight midcorrelation of x and y as:

b i c o r ( x , y ) = ∑ i = 1 m ( x i - m e d ( x ) ) w i ( x ) ( y i - m e d ( y ) ) w i ( y ) ∑ j = 1 m [ ( x j - m e d ( x ) ) w j ( x ) ] 2 ∑ k = 1 m [ ( y k - m e d ( y ) ) w k ( y ) ] 2
(5)

It should be noted that the equations of biweight midcorrelation does not invole an explicit identification of outliers, and all elements whose weight w i = 0 can be considered outliers. The user can also set up the maximum allowed proportion of outliers using the argument "maxPOutliers", the "max POutliers" is interpreted as the maximum proportion of low and high outliers separately. The value of bicor ranges from -1 to 1. Where -1 represents the maximum negative correlation and 1 represents the maximum positive correlation. Zero represents irrelevant.

'Half-thresholding' strategy in constructing gene coexpression networks

Gene expression data has the characteristic of small samples and large number of genes, and contains noise and unrelated genes. Therefore need to use the appropriate strategy to extract disease-related genes. There are currently two accepted strategies, namely hard-thresholding and soft-thresholding, for inferring gene coexpression network from original gene coexpression values. Those strategies can remove noise and irrelevant genes effectively. However, hard-thresholding ignores continuous nature of the coexpression information and encodes gene connections in a binary fashion, dichotomizing the continuous correlation values to be coexpression and non-coexpression. It is sensitive to the choice of the threshold and may be result in the loss of co-expression information.

The soft-thresholding keeps all possible coexpression relationships and uses the power β (i.e. soft-threshold) to emphasize the original high coexpression values and reduce the original low coexpression values simultaneously. Although soft-threshold overcomes the disadvantages of the hard-threshold, it keeps noisy variations and unrelated gene information in its calculation. These interference information lower the accuracy of gene differential coexpression analysis, especially when soft-threshold strategy uses a low value as the powerβ. During our gene differential coexpression analysis, pair of gene expression datasets under disease and normal conditions are transformed to a pair of coexpression matrix. We calculate bicor coefficients over all gene pairs in each dataset. We use m i j to denote bicor coefficient between gene i and gene j under normal condition, and n i j to denote bicor coefficient under disease condition. The 'half-thresholding' strategy [17] keep coexpression value in both coexpression matrix if at least one of the two coexpression values exceeds the threshold. For example, we keep m 12 and n 12 if they both exceed threshold value 0.4. In this way, we ignore 'non-informative relationship' whose correlation values in both networks are below the threshold and filer the gene pair, but thoroughly examine the possibly meaningful coexpression changes of values remaining in the two coexpression matrix.

The 'biweight midcorrelation and half-thresholding' method (BMHT)

In our method, for each dataset, we calculate the biweight midcorrelation coefficients between the expression profiles of all gene pairs in normal condition and disease condition separately. The biweight midcorrelation coefficients matrix represents the original correlation structure in each condition. After calculated biweight midcorrelation coefficients of all gene pairs, the two datasets are encoded into a pair correlations matrix over all gene pairs. We then filter out non-informative correlation pairs using the half-thresholding strategy. This results in a new coexpression networks of gene set.

In gene expression data, for gene i , the biweight midcorrelation coefficients between it and its N neighbors in the filtered set can be calculated from two vectors, i.e., X=(xi1,xi2,...,xin) and Y=(yi1,yi2,...,yin) for the two conditions. We calculate the differential coexpression value of gene i using the following equation.

d c i ( B M H T ) = ( x i 1 - y i 1 ) 2 + ( x i 2 - y i 2 ) 2 + . . . + ( x i n - y i n ) 2 n
(6)

This calculates the average coexpression change between a gene and its informative coexpression genes. Then we can use the dc values to rank genes. Naturally, the question arises, i.e., whether our findings are artifacts of the high dimensionality and low sample of the data? To assess this question, we apply permutation test to evaluate the statistical significance of gene differential coexpression value. Under the null hypothesis, we assume that all genes are mutually independent in both conditions. During the permutation test, we firstly randomly permute the disease and normal conditions of the samples M times, then calculate new Biweight Midcorrelation coefficents using 'half-thresholding' strategy based on the new values, finally calculate the dc statistics. For gene set c, the permutation p-value is:

∑ m = 1 M I d c p c T 1 m , p c T 2 m ≥ d c ( p c T 1 , p c T 2 / M
(7)

Here I(*) is an indicator function. If the absolute value of the dc of the permuted experimental matrices is larger than that of the original dc, I = 1. Otherwise, I = 0. The T 1 m and T 2 m denote samples derived from the m-th permuted dataset. An estimated FDR is obtained by converting the p-values to q-values using Benjamini-Hochberg method [29]. The p-value for each gene can then be calculated. In our study, we considered M = 1000. As this method is based on the Biweight Midcorrelation and Half-thresholding, it is denoted as BMHT in this paper.

The maximum clique analysis

More and more researchers realized that gene module is high related with disease, but not individual gene. In gene expression network, gene is only related with other genes. Based on the characteristic of no self-loop, the graph of gene coexpression network is a simple undirected graph, and the diagonal elements of gene coexpression matrix are all 0. The gene coexpression matrix is a square and symmetric matrix whose rows and columns correspond to the genes and whose element Aij denotes the coexpression relationship between genes. The graph of maximum clique network is a complete graph that every pair of nodes is joined by edge, and the adjacency matrix elements of the complete graph are all 1 except the diagonal elements. For a simple undirected graph G containing N nodes, its adjacency matrix A = ( a i j ) N × N contains only 1 and 0. It is a square and symmetric matrix obviously. a i j = 1 represents that gene i and j is coexpressed, a i j = 0 means that gene i and j is not connected.

We set two thresholds T1 for adjacency matrix A1 in normal condition and T2 for adjacency matric A2 in disease condition. A1(i,j) set to 1 if the value of A1 (i,j) greater than or equal to T1, otherwise, A1(i,j) set to 0. A2(i,j) set to 1 if value of A2(i,j) less than or equal to T2, otherwise, A2(i,j) set to 0.We integrated A1 and A2 into a matrix A after we had intersection the corresponding elements of A1 and A2. A (i,j) = 1 means coexpression value of gene i and gene j in A1 greater than or equal to T1, and coexpression value of gene i and j in A2 less than or equal to T2. Equation 6 summarized the process. We excavated cliques which have biological significance from A adjacency matrix to further investigate gene regulatory networks.

i f A 1 ( i , j ) ≥ T 1 , t h e n A 1 ( i , j ) = 1 , e l s e A 1 ( i , j ) = 0 i f A 2 ( i , j ) ≤ T 2 , t h e n A 2 ( i , j ) = 1 , e l s e A 2 ( i , j ) = 0 A ( i , j ) = A 1 ( i , j ) & A 2 ( i , j )
(8)

Results and discussion

Experiment result on simulate datasets

In this experiment, we analyzed a pair of simulated datasets used in a published study [27], which were generated based on two yeast signaling networks using SynTReN [28]. The simulate datasets consists of 20 genes, 50 samples in normal and disease conditions. MBP1_SWI6, PHO2, CLB5, TRP4, CLB6, FLO1, FLO10 were identified as differential coexpression genes. We evaluated BMHT method in terms of its capability to discover the differential coexpression genes from the simulated datasets, and compared it with methods, i.e., 'Log Ratio of Connection'(LRC), 'Average Specific Connection'(ASC), and 'Weighted Gene Coexpression Network Analysis'(WGCNA). We adopted the signed version of WGCNA and set the parameter β = 12[22]. The results are listed in Table 1. From Table 1 it can be seen that, the BMHT method can detected all seven differential coexpression genes and ranked them at top, while the other three methods cannot detect them accurate. Bold shown genes refers to the seven differential coexpression genes in the simulate datasets. We arranged the gene in accordance with the BMHT value.

Table 1 The twenty yeast genes involved in simulated dataset pair and the ranking of them by DCEA methods, signed WGCNA, ASC, and LRC separately.

Analyzing a Type 2 Diabetes (T2D) in rats

In this section, we apply the BMHT method to a pair of type 2 diabetes(T2D) in rats datasets (dataset pair T), which has been published in study [22]. Dataset pair T from dataset GSE3068 of Gene Expression Omnibus (GEO) database, which had been preprocessed by Hui Yu et.al[22]. Dataset pair T includes 4765 genes in 10 disease samples and 10 normal samples. After applied BMHT method to dataset pair T, we obtained 334 differential coexpression genes of 4765 genes, p-values cut-off 0.05, FDR<0.6% (see Additional file 1). Based on the good performance of p-values of most genes, we selected 7% as the differential coexpression genes. The false discovery rate (FDR) is estimated from the p-value of biweight midcorrelation using Benjamini-Hochberg method [29]. In the differential coexpression genes, Rapgef4 [30] and Notch2 [31] are reported T2D-related genes. We listed all 20 differential coexpression genes with T2D relevance in table 2. Some reported relevance in table 2 are obtained from Kyoto Encyclopedia of Genes and Genomes (KEGG) database, it is a bioinformatics resource for linking genomes to life and the environment. Although the rest genes are not be previously reported to be related with T2D, they should also deserve more attention. It is helpful for researchers to excavate gene modules and disease genes, establish a disease-related gene clusters, and further explore the pathogenesis of the disease and the biological function of the related-gene.

Table 2 Differential coexpression genes with existing evidence of T2D-relevance.

The maximum clique analysis of real gene expression data

In applications, the node and edge sets of the graphs we need to consider are that we interested. In section 3.2, we selected 334 differential coexpression genes (DCGs) based on BMHT method. The type 2 diabetes data contains some previously reported TD2-related genes. DCGs and T2D-related genes in GSE3068 dataset form a total of 595 gene subset K. Gene subset K1 represents the gene expression value in normal condition and gene subset K2 represents the gene expression value in disease condition. We got two 595 × 595 symmetric bicor coefficient matrix K1 and K2 after we had computed bicor values of every pair gene of gene subset with half-thresholding strategy. K1(i,j) means bicor value of i gene and j gene in normal sample and K2(i,j) represents bicor value of i gene and j gene in disease sample. In this study, we searched gene modules which have high bicor value in normal samples and low bicor value in disease samples for exploring the impact of disease on the gene coexpression. We set two thresholds T1 = 0.76 for K1 and T2 = 0.2 for K2. K1(i,j) set to 1 if absolute value of K1(i,j) greater than or equal to T1, otherwise, K1(i,j) set to 0. K2(i,j) set to 1 if absolute value of K2 (i,j) less than or equal to T2, otherwise, K2(i,j) set to 0. We integrated K1 and K2 into a matrix K. The K(i,j) set to 1if the values of K1(i,j) and K2(i,j) both equal to 1, otherwise, K(i,j) is 0. K is a square and symmetric adjacency matrix with only two different class elements, i.e., 0 and 1.

We analyzed the matrix as the adjacency matrix of graph. Each gene corresponds to one node of graph. K (i,j) = 1 also means node i and j node are connected by edge in correspond graph. We excavate cliques which have biological significance from the K adjacency matrix. and calculate the sum of each row or column of the K matrix. Which represents the number of edges that a gene connected to other genes. In order to improve the efficiency of search, we delete those isolated points whose numbers are 0 and set the minimum number of clique genes as 4. We mined 7 cliques all include 4 genes. The 7 cliques are combined into a gene module which includes 8 genes and 19 edges. The complete graph edge number of the gene function module is c 8 2 , and the density is 0.68. We listed the genes of each clique in table 3. The result is shown in Figure 2. Bold shown genes refers to the four DCG selected in the GSE3068 dataset based on BMHT method. The other genes refer to DCG. Figure 2 is the gene module. Rpl9, Polr2f, Pxmp3 and Ctsd are DCGs. Smarca4, Sirt2 and Prkaca are T2D-related genes. Tsc2 is DCG and T2D-related gene.

Table 3 Genes of each clique.
Figure 2
figure 2

Black spots refer to DCGs from GSE3068 dataset based on BMHT method. Gray spots refer to T2D-related genes. White spot refer both DCG and T2D-related gene.

However, it is not easy to determine the optimal threshold for each specific study. Too large T1 or too small T2 will lead to small number edges and low density of the adjacency matrix K, which corresponding to a graph, and fail to find clique which meet the requirements. On the contrary, too small T1 or too large T2 will lead to overlapping cliques. These two cases have no sense for the analysis of biological process. So further investigation on optimizing thresholds procedure is necessary. In fact, the threshold can be determined based on the proportion of isolated points or density of the graph. The density is defined as the ratio of number of edges to the maximum number of edges. The maximum number of edges is the edge number of complete graph.

Conclusion

In this paper, we proposed a new approach for differential coexpression analysis, which combine Biweight Midcorrelation and half-thresholding strategy and also applied maximum clique analysis to the specific gene set to further investigate gene regulatory networks. Biweight Midcorrelation is more robust for outliers and half-thresholding is an effective preprocess step of the proposed method. Experimental results on simulate datasets show that our method had better performance than three previsouly proposed methods. We also applied the proposed BMHT method to real dataset designed for T2D study, and 334 differential coexpression genes were selected, which may be a useful resource for T2D study and explore the biological function of the related-gene. In the future, we will focus on how to introduce new measure to scale the similarity of gene pairs.

References

  1. Allison DB, Cui XQ, Page GP, Sabripour M: Microarray data analysis: from disarray to consolidation and consensus. Nature Reviews Genetics. 2006, 7: 55-65. 10.1038/nrg1749.

    Article  CAS  PubMed  Google Scholar 

  2. Huang DS, Zheng CH: Independent component analysis based penalized discriminant method for tumor classification using gene expression data. Bioinformatics. 2006, 22 (15): 1855-1862. 10.1093/bioinformatics/btl190.

    Article  CAS  PubMed  Google Scholar 

  3. Zheng CH, Zhang L, Lin D, Ng TY, Shiu CK, Huang DS: Molecular pattern discovery based on penalized matrix decomposition. IEEE/ACM Transactions on Computational Biology and Bioinformatics. 2011, 8 (6): 1592-1603.

    Article  PubMed  Google Scholar 

  4. Sturn A, Quackenbush J, Trajanoski Z: Genesis: cluster analysis of microarray data. Bioinformatics. 2002, 18 (1): 207-208. 10.1093/bioinformatics/18.1.207.

    Article  CAS  PubMed  Google Scholar 

  5. Choi JK, Yu U, Yoo OJ, Kim S: Differential coexpression analysis using microarray data and its application to human cancer. Bioinformatics. 2005, 21 (24): 4348-4355. 10.1093/bioinformatics/bti722.

    Article  CAS  PubMed  Google Scholar 

  6. Rachlin J, Cohen DD, Cantor C, Kasif S: Biological context networks: a mosaic view of the interactome. Mol Syst Biol. 2006, 2: 66-

    Article  PubMed Central  PubMed  Google Scholar 

  7. Lee HK, Hsu AK, Sajdak J, Qin J, Pavlidis P: Coexpression analysis of human genes across many microarray data sets. Genome Res. 2004, 14 (6): 1085-1094. 10.1101/gr.1910904.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Reverter A, Ingham A, Lehnert SA, Tan SH, Wang Y, Ratnakumar A, Dalrymple BP: Simultaneous identification of differential gene expression and connectivity in inflammation, adipogenesis and cancer. Bioinformatics. 2006, 22 (19): 239-2404.

    Article  Google Scholar 

  9. Choi JK, Yu U, Yoo OJ, Kim S: Differential coexpression analysis using microarray data and its application to human cancer. Bioinformatics. 2005, 21 (24): 4348-4355. 10.1093/bioinformatics/bti722.

    Article  CAS  PubMed  Google Scholar 

  10. Carter SL, Brechbuhler CM, Griffin M, Bond AT: Gene co-expression network topology provides a framework for molecular characterization of cellular state. Bioinformatics. 2004, 20 (14): 2242-2250. 10.1093/bioinformatics/bth234.

    Article  CAS  PubMed  Google Scholar 

  11. Mason MJ, Fan G, Plath K, Zhou Q, Horvath S: Signed weighted gene co-expression network analysis of transcriptional regulation in murine embryonic stem cells. BMC Genomics. 2009, 10: 327-10.1186/1471-2164-10-327.

    Article  PubMed Central  PubMed  Google Scholar 

  12. Fuller TF, Ghazalpour A, Aten JE, Drake TA, Lusis AJ, Horvath S: Weighted gene coexpression network analysis strategies applied to mouse weight. Mammalian Genome. 2007, 18 (6-7): 463-472. 10.1007/s00335-007-9043-3.

    Article  PubMed Central  PubMed  Google Scholar 

  13. Freudenberg JM, Sivaganesan S, Wagner M, Medvedovic M: A semi-parametric Bayesian model for unsupervised differential coexpression analysis. Bmc Bioinformatics. 2010, 11: 234-10.1186/1471-2105-11-234.

    Article  PubMed Central  PubMed  Google Scholar 

  14. Stuart JM, Segal E, Koller D, Kim SK: A gene-coexpression network for global discovery of conserved genetic modules. Science. 2003, 302: 249-255. 10.1126/science.1087447.

    Article  CAS  PubMed  Google Scholar 

  15. Bergmann S, Lhmels J, Barkai N: Similarities and differences in genome-wide expression data of six organisms. PLoS Biol. 2004, 2: E9-10.1371/journal.pbio.0020009.

    Article  PubMed Central  PubMed  Google Scholar 

  16. Graeber TG, Eisenberg D: Bioinformatic identification fo potential autocrine signaling loops in cancers from gene expression profiles. Nat Genet. 2001, 29: 295-300. 10.1038/ng755.

    Article  CAS  PubMed  Google Scholar 

  17. Butte AJ, Kohane IS: Mutual information relevance networks: functional genomic clustering using pairwise entropy measurements. Pac Symp Biocomput. 2000, 5: 415-426.

    Google Scholar 

  18. Varadan V, Anastassiou D: Inference of disease-related molecular logic from system-based microarray analysis. PLoS ComputBiol. 2006, 2 (6): e68-

    Article  Google Scholar 

  19. Bansal M, Gatta GD, DiBernardo D: Inference of gene regulatory networks and compound mode of action from time course gene expression profiles. Bioinformatics. 2006, 22 (7): 815-822. 10.1093/bioinformatics/btl003.

    Article  CAS  PubMed  Google Scholar 

  20. Gatta GD, Bansal M, Impiombato AA, Antonini D, Missero C, Bernardo DD: Direct targets of the TRP63 transcription factor revealed by a combination of gene expression profiling and reverse engineering. Genome Res. 2008, 18: 939-948. 10.1101/gr.073601.107.

    Article  PubMed Central  PubMed  Google Scholar 

  21. Lorenz DR, Cantor CR, Collins JJ: A network biology approach to aging in yeast. Proc Natl Acad Sci. 2009, 106 (4): 1145-1150. 10.1073/pnas.0812551106.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Yu H, Liu BH, Li YY: Link-based quantitative methods to identify differentially coexpressed genes and gene Pairs. BMC Bioinformatics. 2011, 12: 315-10.1186/1471-2105-12-315.

    Article  PubMed Central  PubMed  Google Scholar 

  23. Wilcox R: Introduction to Robust Estimation and Hypothesis Testing. 1997, Academic Press, San Diego

    Google Scholar 

  24. Ross IC, Harary F: On the determination of redundancies in sociometric chains. Psychometrika. 1952, 17 (2): 195-208. 10.1007/BF02288782.

    Article  Google Scholar 

  25. Huber W, Carey VJ, Long Li, Falcon S, Gentleman R: Graphs in molecular biology. BMC Bioinformatics. 8 (Suppl 6): S8-2007.

  26. Wasserman S, Faust K: Social Network Analysis, Methods and Applications Cambridge. 1994, Cambridge University Press

    Chapter  Google Scholar 

  27. Zhang B, Li H, Riggins RB, Zhan M, Xuan J, Zhang Z, Hoffman EP, Clarke R, Wang Y: Differential dependency network analysis to identify condition specific topological changes in biological networks. Bioinformatics. 2009, 25 (4): 526-532. 10.1093/bioinformatics/btn660.

    Article  PubMed Central  PubMed  Google Scholar 

  28. Bulcke VT, Leemput VK, Naudts B, Remortel P, Ma H, Verschoren A, Moor DB, Marchal K: SynTReN: a generator of synthetic gene expression data for design and analysis of structure learning algorithms. BMC Bioinformatics. 2006, 7: 43-10.1186/1471-2105-7-43.

    Article  PubMed Central  PubMed  Google Scholar 

  29. Benjamini Y, Hochberg Y: Controlling the false discovery rate: a practical and powerful approach to multiple testing. Journal of the Royal Statistical Society Series B. 1995, 57: 289-300.

    Google Scholar 

  30. Scott : A genome-wide association study of type 2 diabetes in Finns detects multiple susceptibility variants. Science. 2007, 316 (5829): 1341-1345. 10.1126/science.1142382.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  31. Zeggini : Meta-analysis of genome-wide association data and large-scale replication identifies additional susceptibility loci for type 2 diabetes. Nature Genetics. 2008, 40: 638-645. 10.1038/ng.120.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

Download references

Declarations section

Publication charges for this article have been funded by the National Science Foundation of China under Grant Nos. 61272339 & 61271098 & 61370109 and the Key Project of Anhui Educational Committee, under Grant No. KJ2012A005.

This article has been published as part of BMC Bioinformatics Volume 15 Supplement 15, 2014: Proceedings of the 2013 International Conference on Intelligent Computing (ICIC 2013). The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/15/S15.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Zhan-Li Sun.

Additional information

Competing interests

The authors declare that they have no competing interests.

Electronic supplementary material

Rights and permissions

Open Access  This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made.

The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder.

To view a copy of this licence, visit https://creativecommons.org/licenses/by/4.0/.

The Creative Commons Public Domain Dedication waiver (https://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Zheng, CH., Yuan, L., Sha, W. et al. Gene differential coexpression analysis based on biweight correlation and maximum clique. BMC Bioinformatics 15 (Suppl 15), S3 (2014). https://doi.org/10.1186/1471-2105-15-S15-S3

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-15-S15-S3

Keywords