Skip to main content
  • Methodology article
  • Open access
  • Published:

GScluster: network-weighted gene-set clustering analysis

Abstract

Background

Gene-set analysis (GSA) has been commonly used to identify significantly altered pathways or functions from omics data. However, GSA often yields a long list of gene-sets, necessitating efficient post-processing for improved interpretation. Existing methods cluster the gene-sets based on the extent of their overlap to summarize the GSA results without considering interactions between gene-sets.

Results

Here, we presented a novel network-weighted gene-set clustering that incorporates both the gene-set overlap and protein-protein interaction (PPI) networks. Three examples were demonstrated for microarray gene expression, GWAS summary, and RNA-sequencing data to which different GSA methods were applied. These examples as well as a global analysis show that the proposed method increases PPI densities and functional relevance of the resulting clusters. Additionally, distinct properties of gene-set distance measures were compared. The methods are implemented as an R/Shiny package GScluster that provides gene-set clustering and diverse functions for visualization of gene-sets and PPI networks.

Conclusions

Network-weighted gene-set clustering provides functionally more relevant gene-set clusters and related network analysis.

Background

Gene-set analysis (GSA) covers a broad category of methods used to identify relevant biological pathways or functions from omics data such as microarray or high throughput sequencing data [1,2,3,4]. In many cases, GSA yields tens to hundreds of significant gene-sets without indicating how they interact with each other, rendering it difficult to identify core pathways or functional groups. Annotation databases such as Gene Ontology and KEGG [5, 6] partially address this issue by providing parent-offspring relations between annotation terms when used for GSA. Other gene-set collections obtained from independent and heterogeneous sources (e.g., gene signatures in MSigDB [7]) even lack such partial relations. Gene-set clustering, which helps identify the organization of gene-sets and their biological themes, has been used for improved interpretation of gene-sets. For example, DAVID web server uses Cohen’s kappa distance, and Enrichment map uses Meet/Min distance to cluster gene-sets into a number of subgroups [8,9,10,11]. However, these distance measures are only based on gene counts in each gene-set category (e.g., overlap between two gene-sets) and may not fully reflect the underlying biological relations such as protein-protein interactions (PPIs) between gene-sets.

Once significant gene-sets are identified, these GSA results can be further considered for a mechanistic study. PPI networks related to these gene-sets can provide useful information for this purpose. However, most GSA tools provide only the list of significant gene-sets [1] or their own networks [12, 13] without visualizing PPI networks between gene-sets. In this study, we propose to use a network-weighted distance for clustering gene-sets and present an R/Shiny package, GScluster (https://github.com/unistbig/GScluster), for clustering and network analysis of GSA results. The network-weighted clustering was better able to capture functionally relevant gene-set clusters compared with existing gene-count-based methods in simulated and real data analyses. GScluster accepts any GSA results from external programs if a list of gene-sets and their member genes (with or without gene-set scores) are provided.

A main goal of our analysis is to identify functionally relevant gene-set clusters from a long list of gene-sets; thus, the networks between genes (or proteins) in our analysis can be any kind of functional interaction such as gene co-expression, co-occurrence in the literature, evolutionary distance, physical contact, or their combinations, which were all simply denoted as PPI in this article. In GScluster, we adopted the STRING networks that integrated seven different functional interaction sources [14]. These networks also provide the widest coverage of species and genes among currently available network data (e.g., over 18,000 human genes). GScluster also provides analysis based on HIPPIE 2.0 networks [15] for human and customized network data.

To our knowledge, GScluster is the first attempt to incorporate both overlapping genes and PPI networks when clustering gene-sets. DAVID and Enrichment Map neither consider PPI networks during clustering gene-sets nor visualize PPI networks for the clustered gene-sets. Because both tools deploy different clustering strategies and DAVID only uses its own pathway gene-sets, a direct comparison between gene-set clustering results is not possible. Therefore, in our comparative analysis, we applied the same clustering strategy (fuzzy clustering) and compared the clustering results for three different distance measures: The Meet/Min distance of Enrichment Map (denoted as MM), Cohen’s kappa distance used in DAVID (denoted as KAPPA), and the PPI-weighted MM distance of GScluster (denoted as pMM). We also note that fuzzy clustering method allows a gene-set to belong to multiple clusters and excludes isolated gene-sets.

Results

GScluster R package and GSAseq web server

We present two independent software tools: GScluster (https://github.com/unistbig/GScluster) and GSAseq (http://gsaseq.appex.kr). GSAseq is a web server for gene-set enrichment analysis (GSEA) of RNA-sequencing (RNA-seq) and microarray gene expression data [7] and is described in Supplementary Material (Additional file 1) in detail. GScluster is an R/Shiny package for clustering and network analysis of gene-sets. We place a major emphasis on GScluster for its novelty and useful functions. GSEA and differential gene expression results obtained from GSAseq can be directly used for GScluster. Both software tools support analysis for ten species including human, mouse, rat, fly, zebra fish, rice, A. thaliana, worm, yeast, and E. coli. We note that GSA result from our own tool for GWAS summary data is also directly accepted by GScluster [16].

An overview of GScluster is shown in Fig. 1. The user can also use a GSA result (and gene list) obtained from other software tools for GScluster. The main input data should have the columns of gene-set name, member genes, gene-set score (e.g. FDR q-value), and optionally the direction of each gene-set indicating up- or down-regulation. GScluster additionally accepts data for gene scores (e.g. differentially expressed (DE) genes) for more focused analysis. GScluster implements the fuzzy clustering [8] for the three set-distance measures (pMM, MM, and KAPPA). GScluster is mainly built based on Shiny and Cytoscape related R package (cyjShiny); thus it provides interactive visualization of both gene-set and PPI networks. Networks are visualized after gene-set clustering is done. All the network figures and gene-set clustering result table are downloadable as SVG and CSV format, respectively. Detailed functions for network visualization are described in Supplementary Material (Additional file 1). GScluster clusters gene-sets and visualizes networks in seconds to minutes, depending on the size of input gene-set data (Fig. S1). The three example datasets (GSA results) analyzed in this article are available in the GScluster package.

Fig. 1
figure 1

GScluster overview. Interactive network analysis is provided for both gene (protein) and gene-set networks

Network-weighted distance yields gene-set clusters with denser network connections

Gene-set clustering aims at identifying groups of functionally close gene-sets that can be characterized by substantial overlap and dense PPIs between gene-sets. Here, we cluster the 3859 MSigDB C2 pathway sets [7, 17] with sizes 10–200 using pMM, MM, and KAPPA distances, respectively, and compare the PPI densities of resulting clusters. For each of the three distances, the same upper 0.154% threshold (MM ≤ 0.5, pMM ≤ 0.384, and KAPPA ≤ 0.727) was applied. Then, gene-set clusters with similar sizes (number of genes included) are compared between different methods. Because the sizes of resulting clusters are not exactly matched between methods, the trend lines between the cluster size and average PPI score (STRING edge scores are normalized to unit interval) in each cluster were compared (Fig. 2). Here, gene pairs with no PPI received zero scores in calculating the cluster averages, and a few outlier clusters with more than 1000 genes were excluded (2, 3, and 1 clusters for MM, pMM, and KAPPA, respectively). As expected, the average PPI scores tended to decrease as the cluster size increases for all the three methods. Indeed, the clusters obtained using pMM exhibited considerably increased average PPI scores than those observed using existing methods. For the clusters with less than 100 genes (39.8, 30.3, and 36.8% of pMM, MM, and KAPPA clusters, respectively), the average PPI score of pMM clusters (0.30) was 20 and 50% higher than those of MM (0.25) and KAPPA (0.20) clusters, respectively. For the clusters containing 100–200 genes (36.4, 41.6, and 31.6% of pMM, MM, and KAPPA clusters, respectively), even higher rates of increase were observed (average PPI scores using pMM: 0.17, MM: 0.12, and KAPPA: 0.05). These results illustrate the effects of incorporating PPI-networks in gene-set clustering, which can be controlled by the balancing factor α. Simulation tests were demonstrated in the next section to further compare the features of different distance measures.

Fig. 2
figure 2

Comparison of average PPI scores within clusters generated using each of three distance scores. All of the MSigDB C2 pathways satisfying a set size criterion 10–200 were clustered using each of pMM, MM, and KAPPA distances. The average PPI scores (STRING) within each cluster were plotted for the numbers of proteins in clusters. For each method, the 1st order trend lines are represented (MM: black triangle, pMM: red cross. KAPPA: blue X)

Gene-set clustering simulation

We designed three gene-set clusters as demonstrated in Fig. 3a to compare the effects of different gene-set distances on gene-set clustering. ‘n’ represents the number of genes in a gene-set. The properties of each cluster were described as follows:

  1. 1.

    Case 1: Ten gene-sets are largely classified into two functionally distinct subgroups (left and right parts), each composed of five gene-sets. The two subgroups share a substantial number of genes; however, PPIs are assigned only within each subgroup.

  2. 2.

    Case 2: Similar as Case 1 except that the two subgroups share fewer genes and PPIs are assigned only between the subgroups.

  3. 3.

    Case 3: A large gene-set (n = 200) includes five small gene-sets (n = 10–15) that overlap with each other.

Fig. 3
figure 3

Simulation of gene-set clustering. a Three models for gene-set clusters. Dots represent genes and circles represent gene-sets. First model (Case 1) assumes that two subgroups (orange and sky-blue) are merged using MM distance but contain dense PPIs within each subgroup. Second model (Case 2) represents two subgroups having insufficient overlap to be merged using MM score, but containing dense PPIs across the subgroups. In the first and second models, only three gene-sets (instead of five) were represented in each subgroup to simplify the figures. In third model (Case 3), a large gene-set contains multiple small gene-sets having overlaps. Black and gray dots represent genes included in gene-set and background, respectively. Lines represent PPIs between genes. Clustering results for (b) Case 1 and (c) Case 2 are shown. Ratios in the y axes indicate the successful detection ratios. Results for Case 3 was not shown because all trials showed the same result for each distance measure (See the text). d Rank distributions of gene-set sizes of unclustered gene-sets in the imperfectly merged instances in Case 2. e A simulation for KAPPA where set A (n = 10) is contained in another set B (n = 10–200). KAPPA is strongly affected by the set-size

Each case was simulated 500 times. The number of total genes was fixed as 10,000. In Case 1 and 2, each gene-set (n = 15–40) was sampled from either of two pools of genes (denoted pool 1 and 2, respectively), each with n = 60. These pools shared 20 genes. In Case 1, five gene-sets for the first subgroup were sampled from pool 1, and the other five for the second subgroup from pool 2. Each gene-set in a subgroup has a counterpart gene-set in the other subgroup and these gene-set pairs have 45–50% of common genes. In Case 2, the gene-set pairs had a lower proportion of overlap of (40–45%). PPIs with scores of 0.15–0.99 were assigned to 40% of gene (protein) pairs within each subgroup (Case 1), or across the subgroups (Case 2). PPI scores were randomly sampled from STRING networks and the resulting average PPI score for all gene pairs was 0.11. In Case 3, small gene-sets were sampled from a common pool of 50 genes to generate overlap among them. In all cases, the clustering cutoff of MM = 0.5 was used, and those for the other two distances were determined based on the corresponding percentile values in each dataset.

In Case 1, the two subgroups were merged into one 113 times out of 500 trials using MM. Among these, the two subgroups were mostly separated when pMM was used (89/113 times, 78.8%). In contrast, when KAPPA was used, the two subgroups were separated only 11 times (9.7%) and still merged 77 times (68.2%); in the remaining 25 cases (22.1%), ten gene-sets were imperfectly merged (Fig. 3b) which means some of the gene-sets were not clustered. In Case 2, the two groups were separated 156 times out of 500 trials using MM. Among them, pMM mostly merged the two subgroups (92/156 times, 59.0%) and separated them only 23/156 times (14.7%). In the remaining 41 cases (26.3%), the two subgroups were imperfectly merged because the missing gene-sets had relatively less number of PPIs with the clusters (average PPI score within merged gene-sets: 0.355; average PPI score between merged and not merged gene-sets: 0.249). KAPPA merged or separated the two groups 30 (19.2%) and 82 times (52.6%), respectively, and imperfect merging was observed 44 times (28.2%) (Fig. 3c). These simulation results demonstrate that pMM is capable of discriminating functionally distinct gene-set subgroups as represented by PPI networks. Small gene-sets were often missed from the merged cluster when KAPPA was used, whereas pMM did not show such a tendency (Fig. 3d).

Case 3 highlights the difference between KAPPA and MM/pMM distances. KAPPA excluded the large superset (n = 200) and detected only the cluster of five small gene-sets, whereas MM and pMM included the large superset into a single large cluster as well. Given two gene-sets, MM/pMM distances focused on the smaller gene-set and assumed their distance was zero if one gene-set was completely included by the other, irrespective of the size of the latter gene-set. By contrast, KAPPA tended to cluster gene-sets with similar sizes. To demonstrate the set-size dependence of KAPPA, a simple simulation was devised. Suppose a set A has ten members that are all contained in another set B. Then, KAPPA between A and B was measured for varying sizes of B (10–200). The size of B strongly affected the kappa distance (Fig. 3e), whereas MM distance was 0 irrespective of the size of B.

Gene-set clustering/network analysis of real data

Complex diseases are caused by aberrant modulation of multiple pathways. Thus, gene-set analysis of a complex disease often yields a long list of significant pathways, making it difficult to identify core themes and overall relations among the pathways. Here, we demonstrate the network analysis of gene-sets using GScluster for three datasets of complex diseases: Colorectal cancer (CRC), type 2 diabetes (T2D), and acute myeloid leukemia (AML). These datasets have different data types (gene expression microarray, GWAS summary, and RNA-seq) and were analyzed using different GSA methods (GSEA, empirical self-contained GSA, and adaptive Gene Ontology (GO) analysis). In each example, clustering results based on pMM, MM, and KAPPA were compared, and PPI networks in gene-set clusters were analyzed. Only gene-sets with between 10 and 200 genes were analyzed.

GSEA of gene expression microarray data (colorectal cancer)

Microarray gene expression data (GSE4107) comprising 12 early onset CRC samples and 10 healthy controls were analyzed [18]. Differential expression analysis was performed using limma R package [19], and gene-permuting GSEA (gene score: log fold-change) was performed using GSAseq and MSigDB curated gene-sets (C2 category) [7]. The analysis results were then input into GScluster. In total, 484 enriched gene-sets (false discovery rate (FDR) < 0.01) and 1071 DE genes (FDR < 0.01) were used for network analysis. Figure 4a shows the gene-set clusters and networks generated using pMM. Each cluster contained gene-sets related to cancer such as cellular respiration (TCA cycle; electron transport chain pathways) [20, 21], fatty acid metabolism [22], immune response [23], cell cycle and apoptosis [24, 25], growth factor [26], and hypoxia [27, 28].

Fig. 4
figure 4

Gene-set network analysis of early-onset colorectal cancer data. a Gene-set networks/clusters obtained using pMM (GSEA FDR < 0.01). Pink and green nodes represent up- or down-regulation of gene-sets, respectively. Overlapping clusters were represented by dashed circles. The cluster labels were manually written by the authors. The sizes of node and gene-set name are adjustable on the web. b Gene-set clusters of fatty acid metabolism derived from pMM, MM, and KAPPA, respectively. In the pMM cluster, nodes bordered by orange and blue boxes indicate gene-sets that were not included in the MM and KAPPA cluster, respectively. c PPI network (score ≥ 0.5) of significant genes (FDR < 0.01) in cellular respiration cluster. SDHB was the hub (degree = 25). d PPI networks connected with SDHB in cellular respiration cluster. Met represents Metabolism

Fuzzy clustering of the 484 significant gene-sets generated 11, 10, and 14 clusters using MM, pMM, and KAPPA, respectively (Additional file 2: Supplementary Table S1). Overall, the three distances resulted in similar clusters; however, some clusters revealed distinctive features of each distance, as demonstrated in the simulation test. For example, ‘fatty acid metabolism’ cluster included six related terms using MM (e.g., KEGG fatty acid metabolism and Reactome mitochondrial fatty acid beta oxidation). pMM extended this cluster with three additional terms related to short chain fatty acids (KEGG propanoate metabolism and KEGG butanoate metabolism) and vascular fatty acid transport (Reactome branched chain amino acid catabolism). Their additions were ascribed to the PPI weights; the average PPI score between the six and the additional three pathways was 0.106 which was 7.54 times higher than that of background genes (0.014) as calculated from all the 484 significant gene-sets. Compared with the pMM results, KAPPA removed the largest pathway (Reactome fatty acid triacylglycerol and ketone body metabolism, n = 145) and its small subset (Sanderson PPARa targets, n = 15) possibly because of the set-size differences.

‘Immune response’ cluster showed a similar pattern. It contained 15 gene-sets related to lymphocyte activation using MM (e.g., Biocarta TCR pathway, Biocarta T-helper pathway, Reactome CXCR4 pathway). pMM included three additional relevant pathways (‘Biocarta T cytotoxic pathway’, ‘Lee differentiating T lymphocyte’, and ‘Vilimas Notch1 targets up’) in this cluster. The average PPI score between the 15 MM pathways and three additional pathways were 0.041 which was 2.93 times higher than that of the background. Among the 18 gene-sets in the pMM immune cluster, KAPPA was only able to cluster eight small immune response gene-sets (n = 11–25).

We then analyzed an extended list of 1147 gene-sets obtained from a larger threshold FDR < 0.1. Clustering using pMM yielded a large cluster related to ‘cell survival, proliferation, and differentiation’ (N = 67; N represents the number of gene-sets in a cluster, see in Additional file 1: Figure S2a ). In this cluster was found an important pathway in cancer, ‘Reactome activation of the AP1 family of transcription factors’. This pathway was the most highly connected (degree = 29) among the entire list of gene-sets in the pMM gene-set networks. This result is very relevant, because AP-1 is a well-known key transcriptional regulator for cell survival, proliferation, and differentiation in cancer [29, 30], and its activation pathway is connected to many related cell signaling pathways. In contrast, using MM or KAPPA, this gene-set was not detected as a hub and was connected to only a small number of gene-sets (MM: seven sets, KAPPA: three sets, see in Additional file 1: Figure S2b). We note that the gene-set clustering results for different distance measures have similar numbers of edges between gene-sets (pMM: 1242; MM: 1112; KAPPA: 1252) because the same percentile cutoff values were applied. Therefore, this example reveals a critical difference in the network structures with or without PPI weights.

GScluster enables to explore the PPI networks within each cluster, and easily identify the hub genes and their neighbors. For example, a cluster of ‘cellular respiration’ contained 11 gene-sets related to TCA cycle and oxidative phosphorylation. These gene-sets were down-regulated in colorectal cancer because of the Warburg effect that cancer cells exploit aerobic glycolysis rather than oxidative phosphorylation to produce energy [31]. The PPI network of this cluster contained 66 genes (PPI score ≥ 0.5). Among them, succinate dehydrogenase B (SDHB), participating in both citric acid cycle and respiratory chain [32], was the hub having connections with 25 genes. Deficiency of this gene increases cancer cell migration and invasion by activating the transforming growth factor (TGF) beta signaling pathway [33, 34]. Figure 4c, d represent the PPI networks of SDHB in this cluster.

Self-contained GSA of GWAS summary data (type 2 diabetes mellitus)

Next, stage 1 GWAS summary statistic data provided from the DIAGRAM consortium were analyzed [35]. This dataset was obtained from a meta-analysis comparing genotypes of 12,171 patients with T2D and 56,862 controls collected from 12 GWAS European populations. For this dataset, a recently developed empirical self-contained GSA method, called sARTP was applied using ARTP2 R package [36]. In addition, gene p-values were calculated using VEGAS2 tool [37]. sARTP method detected 193 significant gene-sets out of 1264 MSigDB C2 canonical pathways (FDR < 0.25). Fuzzy clustering summarized these sets into 12, 10, and 16 clusters using pMM, MM, and KAPPA, respectively (Additional file 2: Supplementary Table S2). Many clusters included gene-sets that were closely related to T2D such as beta cell regulation [38], unfolded protein response [39], Notch/Wnt/PS1 signaling [40], cell cycle [41, 42], signal transduction [43, 44], cancer [45], voltage-gated potassium channel [46, 47], immune response [48], and lipid metabolism [49]. The gene-set networks generated using pMM are shown in Fig. 5a.

Fig. 5
figure 5

Gene-set network analysis of Type 2 Diabetes. a Gene-set networks/clusters obtained using pMM (sARTP FDR < 0.25). Overlapping clusters are represented using dashed circles. The cluster labels are manually written by the authors. UPR means unfolded protein response. b Clusters of lipid metabolism derived by MM (left) and KAPPA (right). Whereas pMM separated triglyceride (fat) and phospholipid metabolism pathways, MM and KAPPA distance combined them into one cluster. Also, KAPPA added another gene-set in the cluster. Green and pink border represent the gene-sets related to phospholipid and fat metabolism, respectively. TG means Triglyceride. c PPI network (PPI score ≥ 0.5) of significant genes (FDR < 0.01) in the immune cluster. NFKB1, NFKB2, TNF, and TP53 were fully connected to each other

Some of the clusters clearly revealed specific features of each distance measure as observed in the simulation test. For example, ‘lipid metabolism’ cluster corresponded to Case 1 and 3 in the simulation. Among the MM clustering results, a cluster included two distinct functions, phospholipid and triglyceride related terms (N = 11). It was ascribed to the overlap of a triglyceride term (Reactome triglyceride biosynthesis) with three phospholipid terms (Reactome synthesis of PA, Reactome glycerophospholipid biosynthesis, and Reactome phospholipid metabolism) (MM = 0.48–0.5). The 14 overlapping genes were general synthesis related genes (e.g., AGPAT/GPAT family, GPAM, and GPD1) that are involved in both triglyceride and phospholipid biosynthesis [50]. In contrast, pMM yielded two separate clusters of ‘phospholipid’ (N = 5) and ‘triglyceride metabolism’ (N = 6). Such different cluster structures were clearly caused by the PPI distribution; the average PPI score between the two clusters was even lower than that of the background (0.016, odds ratio = 0.496), whereas the average PPI scores within each cluster were much higher (phospholipid: 0.21, odds ratio = 8.39; triglyceride: 0.099, odds ratio = 3.46). This separation of clusters is also biologically reasonable because they represent clearly distinct functions; phospholipids are structural constituent of cell membranes, whereas triglycerides are used for energy storage [50].

Figure 5c shows the PPI network of ‘innate immune response’ cluster containing 31 gene-sets. It exhibited dense connections among ten well-known immune related genes (gene p-value < 0.01). In particular, four hub genes (NFKB1, NFKB2, TNF, and TP53) were completely connected to each other. The roles of these genes in T2D have been well-studied. Expressions of these pro-inflammatory genes are usually elevated in T2D. These are activated under obesity or high-fat diet conditions and cause an inflammatory response that leads to insulin resistance [51,52,53]. Besides, TP53 was also detected as a hub in another cluster related to cancer/cell cycle and cell signaling pathways. This cluster included many gene-sets altered in both cancer and diabetes such as cell cycle, Akt pathway, and MAPK pathway. It was reported that a dysregulated isoform of TP53 (Δ40p53) causes cell cycle arrest in beta cells and insulin resistance [54].

GO analysis of RNA-seq data (acute myeloid lymphoma)

Lastly, GO analysis was performed for RNA-seq data composed of induced pluripotent stem cells derived from three patients with AML and three healthy controls [55]. In total, 5307 DE genes were identified out of 21,441 genes (FDR < 0.01 and two or larger fold change) using DESeq2 [56]. GO analysis was performed for these genes using GOseq R package [57]. GOseq is specifically designed for GO analysis of RNA-seq data to address the read count bias (or gene length bias) in DE analysis of RNA-seq data [58, 59]. Among 5136 MSigDB C5 gene-sets, GOseq yielded 86 significant gene-sets (FDR < 0.01).

Fuzzy clustering of these gene-sets yielded 15, 11, and 19 clusters using pMM, MM, and KAPPA, respectively (Additional file 2: Supplementary Table S3). These clusters summarized the characteristic pathways of AML, such as immune response [60, 61], synapse [62], anchored component of membrane (e.g., CD48, CD56) [63, 64], neuropeptide [65, 66], tyrosine kinase [67], developmental [68, 69], blood pressure regulation [70, 71], cyclic nucleotide [72, 73], voltage-gated ion channels [74, 75] and phospholipase C [76] (Fig. 6a).

Fig. 6
figure 6

Gene-set network analysis of acute myeloid leukemia. a Gene-set networks/clusters obtained using pMM (GOseq FDR < 0.01). In this case, the nodes are colored in blue because GOseq results do not give the information of up- or down-regulation. The labels of clusters were manually added by the author. b An example KAPPA gene-set cluster. This cluster combined ‘voltage-gated ion channel’ and ‘blood pressure regulation’ clusters with connecting gene-sets (denoted by arrows)

Among the eleven clusters produced using MM, only one was different from those generated using pMM. It contained 94 gene-sets and the majority (77%) of them were related to the development of kidney, cartilage, cardiovascular system, and nervous system. Other sets were related to leukocyte chemotaxis and migration (LCM), protein tyrosine kinase (TK), phospholipase C (PC), and phosphatidylinositol (PI) regulation. When pMM was applied, these distinct sets were separated from the large cluster. The average PPI within each separated cluster was much higher than that of combined one (Average PPI: combined = 0.036, LCM = 0.073, TK = 0.113, PC = 0.132, PI = 0.149).

Clusters produced using KAPPA were quite different from those obtained using MM and pMM. For example, MM and pMM produced two distinct clusters of blood pressure regulation (N = 12) and voltage-gated ion channel (N = 18). Using KAPPA these clusters were combined into one with additional three gene-sets which worked as ‘mediators’ between the two clusters (Fig. 6b). The gene-set ‘heart process’ (n = 85) had no connection with the gene-sets in the voltage-gated ion channel cluster using MM or pMM. However, KAPPA connected it with three sets in this cluster (‘multicellular organismal signaling’ (n = 123), ‘cardiac conduction’ (n = 82) and ‘action potential’ (n = 94)) because of the similar gene-set sizes. Also, it was connected to ‘regulation of muscle contraction’ (n = 147) which was linked to a gene-set in the blood pressure cluster (‘positive regulation of blood circulation’ (n = 93)) only by KAPPA. In the large combined cluster, a small pathway ‘vasodilation’ (n = 26) was removed because it lost the link with its superset ‘vascular process in circulatory system’ (n = 163) using KAPPA because of the size difference.

Discussion

Gene-set analysis often yields a long list of gene-sets. DAVID [8] or Enrichment Map [11] cluster those gene-sets to summarize the results and identify core themes regarding the phenotype of interest. However, these methods only consider ‘overlap’ based distances in clustering gene-sets, whereas functionally related gene-sets usually share a number of PPIs as well as some genes.

In the present study, we introduced a PPI-weighted gene-set distance (pMM) that incorporates both the overlapping genes and PPIs between two gene-sets. pMM was compared with existing distance measures, Meet/Min (MM) and kappa distance, in clustering a large collection of gene-sets (MSigDB C2), where pMM clusters, as expected, exhibited systematically higher PPI densities than those obtained using MM or KAPPA distances. pMM enabled to capture biologically more meaningful clusters as shown in three analysis examples. We also presented GScluster tool for clustering and network analysis of gene-sets. It accepts any kind of GSA results and helps to identify core biological themes from a long list of gene-sets.

Additionally, the unique properties of each distance measure were demonstrated from simulation and real data analysis. In particular, kappa distance used in DAVID was highly sensitive to gene-set size difference and tended to cluster gene-sets of similar sizes. This property of kappa distance should be taken into account when clustering the hierarchically organized gene-sets in GO and KEGG, because kappa distance may not cluster a large general pathway and its small sub-pathways.

In the colon cancer example, only the pMM-based clustering identified the well-known oncogenic complex, AP1 family pathway as hub gene-set. In the T2D example, two unrelated pathway groups (phospholipid and triglyceride synthesis) were clustered into one when the overlap-based distance (MM) was used, because they shared general synthesis-related genes. However, these two pathways have distinct functions and should not be taken together just because they share some non-specific genes. pMM reflected the relatively dense PPI scores within each group and successfully separated them into two distinct pathway groups.

These examples as well as the simulation results indicate that PPIs should be taken into account for gene-set clustering and network analysis. Whereas the default network weighting of α = 1 worked well for STRING networks in all the three examples in this paper, this factor could be reduced if the network data are of low quality or less reliable. By incorporating PPI networks, GScluster provided functionally more relevant gene-set clusters as well as corresponding PPI networks. Because gene-set clusters can be regarded as ‘extended’ pathways, PPIs in each cluster can provide useful insights for further study. In particular, GScluster showed that some proteins are hubs in multiple clusters, suggesting their multifaceted roles in diseases.

In clustering gene-sets, we implemented fuzzy clustering in GScluster package. This method has several advantages in summarizing a long list of gene-sets. First, it generates compact type clusters. Spectral clustering [77], for example, focuses more on the connectivity between nodes; thus, some pairs of nodes in a cluster can have very large distances. Second, the number of clusters is adaptively determined from the gene-set distance cutoff. Spectral clustering and k-medoids require a predetermined number of clusters which is not known to the user. Lastly, fuzzy clustering allows a gene-set to belong to two or more clusters. This flexibility is important because some gene-sets have important roles in multiple pathways. In contrast, many other clustering methods simply partition the gene-sets.

In addition to gene-set clustering, we expect that the PPI-weighted set distance (pMM) can also be used to design an enrichment analysis method (or GO analysis). Enrichment analysis typically evaluates enrichment of a test gene-set (e.g., DE genes from an experiment) in each pre-defined gene-set based on their overlap, whereas recent ‘network enrichment’ analysis methods consider enrichment of networks between gene-sets. pMM suggests a way to combine overlap and networks in enrichment analysis.

Conclusions

Gene-set clustering has been widely used to summarized a long list of gene-sets. Here, we demonstrated that our PPI-network weighted gene-set distance yields biologically more relevant gene-set clusters by simulated and real data analysis. We also provided GScluster R/Shiny package for PPI-weighted gene-set clustering and network visualization.

Methods

Gene-set clustering and distance measures

The distance matrix between gene-sets are calculated using Meet/Min, PPI-weighted Meet/Min or Cohen’s kappa distance, and the fuzzy clustering algorithm used in DAVID was implemented in GScluster [8]. The distance measures used are described as follows:

  1. (1)

    Meet/Min distance (MM) for two gene-sets A and B:

    $$ \mathrm{MM}\left(\mathrm{A},\mathrm{B}\right)=1-\frac{\left|A\bigcap B\right|}{\min \left(\left|A\right|,\left|B\right|\right)} $$

    where |A| is size of A.

  2. (2)

    PPI-weighted Meet/Min (pMM) distance: For two gene-sets A and B,

    $$ \mathrm{pMM}\left(\mathrm{A}\to \mathrm{B}\right)=1-\frac{\left|A\bigcap B\right|}{\min \left(\left|A\right|,\left|B\right|\right)} $$
    $$ -\frac{\alpha }{\min \left(\left|A\right|,\left|B\right|\right)}\sum \limits_{x\in A-B}\frac{w{\sum}_{y\in A\cap B}P\left(x,y\right)+{\sum}_{y\in B-A}P\left(x,y\right)}{\max (P)\bullet \left(w\left|A\cap B\right|+\left|B-A\right|\right)} $$
    (1)

    where P is the PPI score matrix, P(x, y) is the PPI score of two genes x and y, α ∈ [0, 1] is the balancing factor (default α = 1) used to control the network weighting based on quality or importance of the network data, and \( \mathrm{w}=\left\{\begin{array}{c}\frac{\mid A\mid }{\left|A\right|+\mid B\mid }, if\ \left|A\right|\le \mid B\mid \\ {}\frac{\mid B\mid }{\left|A\right|+\mid B\mid }, otherwise\ \end{array}\right. \); and pMM(B → A) is symmetrically defined. Then, the distance between A and B is defined as

    $$ \mathrm{pMM}\left(\mathrm{A},\mathrm{B}\right)=\min \left(\mathrm{pMM}\left(\mathrm{A}\to \mathrm{B}\right),\mathrm{pMM}\left(\mathrm{B}\to \mathrm{A}\right)\right). $$

The last term in (1) represents the overall PPI score between genes x ∈ A − B and y ∈ B. This term is designed as follows: if x ∈ A − B is fully connected with all the members in B with the maximum PPI score, this gene is regarded as one more overlap between A and B from the perspective of MM score. If y ∈ A ∩ B, the interaction score is down-weighted by w because the interaction in this case can be ambiguously regarded as that either within A or between A and B. This weight is determined by the probability that y belongs to the opposite set. For example, if |A| ≤  ∣ B∣, y is assumed to more likely belong to A; therefore the probability of y to belong to B becomes \( \frac{1/\mid B\mid }{1/\left|A\right|+1/\mid B\mid }=\frac{\mid A\mid }{\left|A\right|+\mid B\mid } \). Although the PPI weighting has substantial effects on gene-set clustering, it also implies that effects of ‘hub’ genes with many strong connections with the opposite set are reasonably controlled. In general, pMM is less than or equal to MM, and they have the same value if there are no PPIs between two gene-sets. Because gene-set cluster structures are determined by the relative distances between gene-sets, some clusters can be dramatically changed by incorporating the PPI-weighted distance. Figure 7 illustrates how to calculate pMM between two gene-sets.

  1. (3)

    kappa distance (KAPPA): Cohen’s kappa distance considers the background genes (A ∪ B)C as well and is defined as:

Fig. 7
figure 7

PPI-weighted gene-set distance. Two gene-sets A and B contain 10 and 20 genes, respectively, and share six genes. Red lines indicate PPIs between A-B and B-A, and blue lines, PPIs between A-B and A ∩ B. Here, all the PPI scores are simply assumed to be 1. Right table shows how to calculate pMM distance, and compares with MM distance value

$$ KAPPA\left(A,B\right)=1-\frac{O-E}{1-E} $$

where \( \mathrm{O}=\frac{\left|A\cap B\right|+\mid {\left(A\cup B\right)}^c\mid }{\mid U\mid } \) and \( \mathrm{E}=\frac{\left|A\right|\bullet \left|B\right|+\mid {A}^c\mid \bullet \mid {B}^c\mid }{{\left|U\right|}^2} \) are the observed and expected agreement rates of two gene-sets, respectively, and U is the set of all genes.

Abbreviations

DE:

Differentially expressed

FDR:

False discovery rate

GO:

Gene Ontology

GSA:

Gene-set analysis

GSEA:

Gene-set enrichment analysis

KAPPA:

Cohen’s kappa distance

KEGG:

Kyoto Encyclopedia of Genes and Genomes

MM distance:

Meet/Min distance

pMM:

PPI-weighted MM distance

PPI:

Protein-protein interaction

References

  1. Huang d W, Sherman BT, Lempicki RA. Bioinformatics enrichment tools: paths toward the comprehensive functional analysis of large gene lists. Nucleic Acids Res. 2009;37(1):1–13.

    Article  CAS  Google Scholar 

  2. Nam D, Kim SY. Gene-set approach for expression pattern analysis. Brief Bioinform. 2008;9(3):189–97.

    Article  PubMed  Google Scholar 

  3. Ramanan VK, Shen L, Moore JH, Saykin AJ. Pathway analysis of genomic data: concepts, methods, and prospects for future development. Trends Genet. 2012;28(7):323–32.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Creixell P, Reimand J, Haider S, Wu G, Shibata T, Vazquez M, Mustonen V, Gonzalez-Perez A, Pearson J, Sander C, et al. Pathway and network analysis of cancer genomes. Nat Methods. 2015;12(7):615–21.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Gene Ontology C. Gene Ontology consortium: going forward. Nucleic Acids Res. 2015;43(Database issue):D1049–56.

    Article  CAS  Google Scholar 

  6. Kanehisa M, Sato Y, Kawashima M, Furumichi M, Tanabe M. KEGG as a reference resource for gene and protein annotation. Nucleic Acids Res. 2016;44(D1):D457–62.

    Article  CAS  PubMed  Google Scholar 

  7. Subramanian A, Tamayo P, Mootha VK, Mukherjee S, Ebert BL, Gillette MA, Paulovich A, Pomeroy SL, Golub TR, Lander ES, et al. Gene set enrichment analysis: a knowledge-based approach for interpreting genome-wide expression profiles. Proc Natl Acad Sci U S A. 2005;102(43):15545–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Huang DW, Sherman BT, Tan Q, Collins JR, Alvord WG, Roayaei J, Stephens R, Baseler MW, Lane HC, Lempicki RA. The DAVID Gene functional classification tool: a novel biological module-centric algorithm to functionally analyze large gene lists. Genome Biol. 2007;8(9):R183.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  9. Huang DW, Sherman BT, Lempicki RA. Systematic and integrative analysis of large gene lists using DAVID bioinformatics resources. Nat Protoc. 2009;4(1):44–57.

    Article  CAS  Google Scholar 

  10. Isserlin R, Merico D, Voisin V, Bader GD. Enrichment map - a Cytoscape app to visualize and explore OMICs pathway enrichment results. F1000Res. 2014;3:141.

    Article  PubMed  PubMed Central  Google Scholar 

  11. Merico D, Isserlin R, Stueker O, Emili A, Bader GD. Enrichment map: a network-based method for gene-set enrichment visualization and interpretation. PLoS One. 2010;5(11):e13984.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  12. Maere S, Heymans K, Kuiper M. BiNGO: a Cytoscape plugin to assess overrepresentation of gene ontology categories in biological networks. Bioinformatics. 2005;21(16):3448–9.

    Article  CAS  PubMed  Google Scholar 

  13. Bindea G, Mlecnik B, Hackl H, Charoentong P, Tosolini M, Kirilovsky A, Fridman WH, Pages F, Trajanoski Z, Galon J. ClueGO: a Cytoscape plug-in to decipher functionally grouped gene ontology and pathway annotation networks. Bioinformatics. 2009;25(8):1091–3.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. Szklarczyk D, Morris JH, Cook H, Kuhn M, Wyder S, Simonovic M, Santos A, Doncheva NT, Roth A, Bork P, et al. The STRING database in 2017: quality-controlled protein-protein association networks, made broadly accessible. Nucleic Acids Res. 2017;45(D1):D362–8.

    Article  CAS  PubMed  Google Scholar 

  15. Alanis-Lobato G, Andrade-Navarro MA, Schaefer MH. HIPPIE v2.0: enhancing meaningfulness and reliability of protein-protein interaction networks. Nucleic Acids Res. 2017;45(D1):D408–d414.

    Article  CAS  PubMed  Google Scholar 

  16. Yoon S, Nguyen HCT, Yoo YJ, Kim J, Baik B, Kim S, Kim J, Kim S, Nam D. Efficient pathway enrichment and network analysis of GWAS summary data using GSA-SNP2. Nucleic Acids Res. 2018;46(10):e60.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  17. Liberzon A, Subramanian A, Pinchback R, Thorvaldsdottir H, Tamayo P, Mesirov JP. Molecular signatures database (MSigDB) 3.0. Bioinformatics. 2011;27(12):1739–40.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Hong Y, Ho KS, Eu KW, Cheah PY. A susceptibility gene set for early onset colorectal cancer that integrates diverse signaling pathways: implication for tumorigenesis. Clin Cancer Res. 2007;13(4):1107–14.

    Article  CAS  PubMed  Google Scholar 

  19. Ritchie ME, Phipson B, Wu D, Hu Y, Law CW, Shi W, Smyth GK. Limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res. 2015;43(7):e47.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  20. Warburg O. On the origin of cancer cells. Science. 1956;123(3191):309–14.

    Article  CAS  PubMed  Google Scholar 

  21. Vazquez A, Liu J, Zhou Y, Oltvai ZN. Catabolic efficiency of aerobic glycolysis: the Warburg effect revisited. BMC Syst Biol. 2010;4:58.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  22. Currie E, Schulze A, Zechner R, Walther TC, Farese RV, Jr.: Cellular fatty acid metabolism and cancer. Cell Metab 2013, 18(2):153–161.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  23. Adam JK, Odhav B, Bhoola KD. Immune responses in cancer. Pharmacol Ther. 2003;99(1):113–32.

    Article  CAS  PubMed  Google Scholar 

  24. Collins K, Jacks T, Pavletich NP. The cell cycle and cancer. Proc Natl Acad Sci U S A. 1997;94(7):2776–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Sherr CJ. Cancer cell cycles. Science. 1996;274(5293):1672–7.

    Article  CAS  PubMed  Google Scholar 

  26. Goustin AS, Leof EB, Shipley GD, Moses HL. Growth factors and cancer. Cancer Res. 1986;46(3):1015–29.

    CAS  PubMed  Google Scholar 

  27. Masson N, Ratcliffe PJ. Hypoxia signaling pathways in cancer metabolism: the importance of co-selecting interconnected physiological pathways. Cancer Metab. 2014;2(1):3.

    Article  PubMed  PubMed Central  Google Scholar 

  28. Vaupel P, Mayer A. Hypoxia in cancer: significance and impact on clinical outcome. Cancer Metastasis Rev. 2007;26(2):225–39.

    Article  CAS  PubMed  Google Scholar 

  29. Shaulian E, Karin M. AP-1 in cell proliferation and survival. Oncogene. 2001;20(19):2390–400.

    Article  CAS  PubMed  Google Scholar 

  30. Jochum W, Passegue E, Wagner EF. AP-1 in mouse development and tumorigenesis. Oncogene. 2001;20(19):2401–12.

    Article  CAS  PubMed  Google Scholar 

  31. Vander Heiden MG, Cantley LC, Thompson CB. Understanding the Warburg effect: the metabolic requirements of cell proliferation. Science. 2009;324(5930):1029–33.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  32. Rutter J, Winge DR, Schiffman JD. Succinate dehydrogenase - assembly, regulation and role in human disease. Mitochondrion. 2010;10(4):393–401.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  33. Zhang D, Wang W, Xiang B, Li N, Huang S, Zhou W, Sun Y, Wang X, Ma J, Li G, et al. Reduced succinate dehydrogenase B expression is associated with growth and de-differentiation of colorectal cancer cells. Tumour Biol. 2013;34(4):2337–47.

    Article  PubMed  CAS  Google Scholar 

  34. Wang H, Chen Y, Wu G. SDHB deficiency promotes TGFbeta-mediated invasion and metastasis of colorectal cancer through transcriptional repression complex SNAIL1-SMAD3/4. Transl Oncol. 2016;9(6):512–20.

    Article  PubMed  PubMed Central  Google Scholar 

  35. Morris AP, Voight BF, Teslovich TM, Ferreira T, Segre AV, Steinthorsdottir V, Strawbridge RJ, Khan H, Grallert H, Mahajan A, et al. Large-scale association analysis provides insights into the genetic architecture and pathophysiology of type 2 diabetes. Nat Genet. 2012;44(9):981–+.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  36. Zhang H, Wheeler W, Hyland PL, Yang YF, Shi JX, Chatterjee N, Yu K. A powerful procedure for pathway-based meta-analysis using summary statistics identifies 43 pathways associated with type II diabetes in European populations. PLoS Genet. 2016;12(6).

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  37. Mishra A, Macgregor S. VEGAS2: software for more flexible Gene-based testing. Twin Research and Human Genetics. 2015;18(1):86–91.

    Article  PubMed  Google Scholar 

  38. Kahn SE. The relative contributions of insulin resistance and beta-cell dysfunction to the pathophysiology of type 2 diabetes. Diabetologia. 2003;46(1):3–19.

    Article  CAS  PubMed  Google Scholar 

  39. Iwawaki T, Oikawa D. The role of the unfolded protein response in diabetes mellitus. Semin Immunopathol. 2013;35(3):333–50.

    Article  CAS  PubMed  Google Scholar 

  40. Kim W, Shin YK, Kim BJ, Egan JM. Notch signaling in pancreatic endocrine cell and diabetes. Biochem Biophys Res Commun. 2010;392(3):247–51.

    Article  CAS  PubMed  Google Scholar 

  41. Wolf G. Cell cycle regulation in diabetic nephropathy. Kidney Int Suppl. 2000;77:S59–66.

    Article  CAS  PubMed  Google Scholar 

  42. Keller MP, Choi Y, Wang P, Davis DB, Rabaglia ME, Oler AT, Stapleton DS, Argmann C, Schueler KL, Edwards S, et al. A gene expression network model of type 2 diabetes links cell cycle regulation in islets with diabetes susceptibility. Genome Res. 2008;18(5):706–16.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  43. Bordonaro M. Role of Wnt signaling in the development of type 2 diabetes. Vitam Horm. 2009;80:563–81.

    Article  CAS  PubMed  Google Scholar 

  44. Hepp KD. Adenylate cyclase and insulin action. Effect of insulin, nonsuppressible insulin-like material, and diabetes on adenylate-cyclase activity in mouse liver. Eur J Biochem. 1972;31(2):266–76.

    Article  CAS  PubMed  Google Scholar 

  45. Vigneri P, Frasca F, Sciacca L, Pandini G, Vigneri R. Diabetes and cancer. Endocr Relat Cancer. 2009;16(4):1103–23.

    Article  CAS  PubMed  Google Scholar 

  46. Yan L, Figueroa DJ, Austin CP, Liu Y, Bugianesi RM, Slaughter RS, Kaczorowski GJ, Kohler MG. Expression of voltage-gated potassium channels in human and rhesus pancreatic islets. Diabetes. 2004;53(3):597–607.

    Article  CAS  PubMed  Google Scholar 

  47. Jensen MV, Haldeman JM, Zhang H, Lu D, Huising MO, Vale WW, Hohmeier HE, Rosenberg P, Newgard CB. Control of voltage-gated potassium channel Kv2.2 expression by pyruvate-isocitrate cycling regulates glucose-stimulated insulin secretion. J Biol Chem. 2013;288(32):23128–40.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  48. Geerlings SE, Hoepelman AI. Immune dysfunction in patients with diabetes mellitus (DM). FEMS Immunol Med Microbiol. 1999;26(3–4):259–65.

    Article  CAS  PubMed  Google Scholar 

  49. Hodge AM, English DR, O'Dea K, Sinclair AJ, Makrides M, Gibson RA, Giles GG. Plasma phospholipid and dietary fatty acids as predictors of type 2 diabetes: interpreting the role of linoleic acid. Am J Clin Nutr. 2007;86(1):189–97.

    Article  CAS  PubMed  Google Scholar 

  50. Lehninger AL, Nelson DL, Cox MM. Lehninger principles of biochemistry, 5th edn. New York: W.H. Freeman; 2008.

    Google Scholar 

  51. Patel S, Santani D. Role of NF-kappa B in the pathogenesis of diabetes and its associated complications. Pharmacol Rep. 2009;61(4):595–603.

    Article  CAS  PubMed  Google Scholar 

  52. Swaroop JJ, Rajarajeswari D, Naidu JN. Association of TNF-alpha with insulin resistance in type 2 diabetes mellitus. Indian J Med Res. 2012;135(1):127–30.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  53. Minamino T, Orimo M, Shimizu I, Kunieda T, Yokoyama M, Ito T, Nojima A, Nabetani A, Oike Y, Matsubara H, et al. A crucial role for adipose tissue p53 in the regulation of insulin resistance. Nat Med. 2009;15(9):1082–7.

    Article  CAS  PubMed  Google Scholar 

  54. Hinault C, Kawamori D, Liew CW, Maier B, Hu J, Keller SR, Mirmira RG, Scrable H, Kulkarni RN. Delta40 isoform of p53 controls beta-cell proliferation and glucose homeostasis in mice. Diabetes. 2011;60(4):1210–22.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  55. Kotini AG, Chang CJ, Chow A, Yuan H, Ho TC, Wang T, Vora S, Solovyov A, Husser C, Olszewska M, et al. Stage-specific human induced pluripotent stem cells map the progression of myeloid transformation to transplantable leukemia. Cell Stem Cell. 2017;20(3):315–328 e317.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  56. Love MI, Huber W, Anders S. Moderated estimation of fold change and dispersion for RNA-seq data with DESeq2. Genome Biol. 2014;15(12):550.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  57. Young MD, Wakefield MJ, Smyth GK, Oshlack A. Gene ontology analysis for RNA-seq: accounting for selection bias. Genome Biol. 2010;11(2):R14.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  58. Oshlack A, Wakefield MJ. Transcript length bias in RNA-seq data confounds systems biology. Biol Direct. 2009;4:14.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  59. Yoon S, Nam D. Gene dispersion is the key determinant of the read count bias in differential expression analysis of RNA-seq data. BMC Genomics. 2017;18(1):408.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  60. Rollig C, Ehninger G. How I treat hyperleukocytosis in acute myeloid leukemia. Blood. 2015;125(21):3246–52.

    Article  PubMed  CAS  Google Scholar 

  61. Mauro MJ: Hyperleukocytosis in acute myeloid leukemia. N Engl J Med 2003, 349(8):767–767.

    Article  PubMed  Google Scholar 

  62. Khaznadar Z, Henry G, Setterblad N, Agaugue S, Raffoux E, Boissel N, Dombret H, Toubert A, Dulphy N. Acute myeloid leukemia impairs natural killer cells through the formation of a deficient cytotoxic immunological synapse. Eur J Immunol. 2014;44(10):3068–80.

    Article  CAS  PubMed  Google Scholar 

  63. Raspadori D, Damiani D, Lenoci M, Rondelli F, Testoni N, Nardi G, Sestigiani C, Mariotti C, Birtolo S, Tozzi M, et al. CD56 antigenic expression in acute myeloid leukemia identifies patients with poor clinical prognosis. Leukemia. 2001;15(8):1161–4.

    Article  CAS  PubMed  Google Scholar 

  64. Elias S, Yamin R, Golomb L, Tsukerman P, Stanietsky-Kaynan N, Ben-Yehuda D, Mandelboim O. Immune evasion by oncogenic proteins of acute myeloid leukemia. Blood. 2014;123(10):1535–43.

    Article  CAS  PubMed  Google Scholar 

  65. Zhao M, Wang TF, Liu Q, Cummins S. Copy number alteration of neuropeptides and receptors in multiple cancers. Sci Rep. 2017;7.

  66. Oomen SPMA, Lichtenauer-Kaligis EGR, Verplanke N, Hofland J, Lamberts SWJ, Lowenberg B, Touw IP. Somatostatin induces migration of acute myeloid leukemia cells via activation of somatostatin receptor subtype 2. Leukemia. 2001;15(4):621–7.

    Article  CAS  PubMed  Google Scholar 

  67. Kentsis A, Reed C, Rice KL, Sanda T, Rodig SJ, Tholouli E, Christie A, Valk PJM, Delwel R, Ngo V, et al. Autocrine activation of the MET receptor tyrosine kinase in acute myeloid leukemia. Nat Med. 2012;18(7):1118.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  68. Grcevic D, Marusic A, Grahovac B, Jaksic B, Kusec R. Expression of bone morphogenetic proteins in acute promyelocytic leukemia before and after combined all trans-retinoic acid and cytotoxic treatment. Leuk Res. 2003;27(8):731–8.

    Article  CAS  PubMed  Google Scholar 

  69. Duda J, Zoger S. Presentation of M4 acute myeloid leukemia in anuric renal failure with hyperuricemia and enlarged kidneys. Journal of Pediatric Hematology Oncology. 2002;24(1):55–8.

    Article  PubMed  Google Scholar 

  70. Mihaila RG, Olteanu A, Dragomir I, Morar S. Pulmonary arterial hypertension emerged in a patient with acute myeloid leukemia. The role of transfusions. Biomedical Research-India. 2015;26(4):785–8.

    CAS  Google Scholar 

  71. Louis CU, Butani L. High blood pressure and hypertension in children with newly diagnosed acute leukemia and lymphoma. Pediatr Nephrol. 2008;23(4):603–9.

    Article  PubMed  Google Scholar 

  72. Peracchi M, Lombardi L, Maiolo AT, Bamonti-Catena F, Toschi V, Chiorboli O, Mozzana R, Polli EE. Plasma and urine cyclic nucleotide levels in patients with acute and chronic leukemia. Blood. 1983;61(3):429–34.

    CAS  PubMed  Google Scholar 

  73. Koeffler HP, Golde DW. Humoral modulation of human acute myelogenous leukemia cell growth in vitro. Cancer Res. 1980;40(6):1858–62.

    CAS  PubMed  Google Scholar 

  74. Arcangeli A, Pillozzi S, Becchetti A. Targeting ion channels in leukemias: a new challenge for treatment. Curr Med Chem. 2012;19(5):683–96.

    Article  CAS  PubMed  Google Scholar 

  75. Huang X, Jan LY. Targeting potassium channels in cancer. J Cell Biol. 2014;206(2):151–62.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  76. Mahmud H, Scherpen FJG, Meeuwsen-de Boer T, Lourens HJ, de Bont ES. Essential role for phospholipase C gamma 1 (PLC-gamma 1) in the survival of t(8;21) acute myeloid leukemia. Blood. 2016;(22):128.

  77. von Luxberg U: A tutorial on spectral clustering. Max Planck Institute for Biological Cybernetics 2006, Technical Report No. TR-149.

  78. Barrett T, Wilhite SE, Ledoux P, Evangelista C, Kim IF, Tomashevsky M, Marshall KA, Phillippy KH, Sherman PM, Holko M, et al. NCBI GEO: archive for functional genomics data sets-update. Nucleic Acids Res. 2013;41(D1):D991–5.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

Not applicable

Funding

Study design and collaborative meeting were supported by the Collaborative Genome Program for Fostering New Post-Genome Industry of the National Research Foundation (NRF) funded by the Ministry of Science and ICT (MSIT) [2014M3C9A3068554, 2014M3C9A3068555]; wages of SY, JK, and BB and open access charge were supported by Basic Science Research Program (NRF) [2017R1E1A1A03070107, 2018R1A5A1024340]; development of GSAseq web server was supported by Agenda Project (PJ012814) of the Rural Development Administration (RDA) and KRIBB research initiative program.

Availability of data and materials

GScluster software is available from GitHub (https://github.com/unistbig/GScluster) and GSAseq web server is available at http://gsaseq.appex.kr. All the three example datasets (GSA results) are provided in GScluster package. The original data before performing GSA are publicly available as follows: The colorectal cancer gene expression microarray data are downloaded from GEO database [78] with series number GSE4107. The GWAS summary data for type II diabetes were downloaded from DIAGRAM consortium site (http://diagram-consortium.org). The RNA-seq read count data for AML vs. normal are downloaded from GEO database with series number (GSE92494).

Author information

Authors and Affiliations

Authors

Contributions

DN, SYK, and SY conceived the problem and managed the study. DN, SY, and JK developed algorithms. SY performed simulation and real data analysis. JK developed GScluster package. BB tested and revised software. SK, SY, and SMC developed GSAseq web server. DN and SY wrote the manuscript. All the authors read and approved the final manuscript.

Corresponding authors

Correspondence to Seon-Young Kim or Dougu Nam.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Additional files

Additional file 1:

Supplementary Material. This includes descriptions of GSAseq web server, gene-set collection method, network visualization and runtime of GScluster, and Supplementary Figure S2. (DOCX 1970 kb)

Additional file 2:

Table S1, Table S2, and Table S3. Supplementary tables. Gene-set clustering results of the colon cancer, type II diabetes, and AML examples using three different distance measures. (XLSX 139 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Yoon, S., Kim, J., Kim, SK. et al. GScluster: network-weighted gene-set clustering analysis. BMC Genomics 20, 352 (2019). https://doi.org/10.1186/s12864-019-5738-6

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12864-019-5738-6

Keywords