Skip to main content

Network topology-based detection of differential gene regulation and regulatory switches in cell metabolism and signaling

Abstract

Background

Common approaches to pathway analysis treat pathways merely as lists of genes disregarding their topological structures, that is, ignoring the genes' interactions on which a pathway's cellular function depends. In contrast, PathWave has been developed for the analysis of high-throughput gene expression data that explicitly takes the topology of networks into account to identify both global dysregulation of and localized (switch-like) regulatory shifts within metabolic and signaling pathways. For this purpose, it applies adjusted wavelet transforms on optimized 2D grid representations of curated pathway maps.

Results

Here, we present the new version of PathWave with several substantial improvements including a new method for optimally mapping pathway networks unto compact 2D lattice grids, a more flexible and user-friendly interface, and pre-arranged 2D grid representations. These pathway representations are assembled for several species now comprising H. sapiens, M. musculus, D. melanogaster, D. rerio, C. elegans, and E. coli. We show that PathWave is more sensitive than common approaches and apply it to RNA-seq expression data, identifying crucial metabolic pathways in lung adenocarcinoma, as well as microarray expression data, identifying pathways involved in longevity of Drosophila.

Conclusions

PathWave is a generic method for pathway analysis complementing established tools like GSEA, and the update comprises efficient new features. In contrast to the tested commonly applied approaches which do not take network topology into account, PathWave enables identifying pathways that are either known be involved in or very likely associated with such diverse conditions as human lung cancer or aging of D. melanogaster. The PathWave R package is freely available at http://www.ichip.de/software/pathwave.html.

Background

Large-scale gene expression profiling by microarrays or transcript sequencing enables identifying relevant expression changes in cells by comparing gene expression patterns of two distinct conditions (e.g. tumor versus normal tissue). A frequent goal of such studies is the identification of dysregulated cellular pathways involved in an observed phenotype like, for example, abnormal proliferation and migration of cancer cells.

For this, gene set enrichment tests are commonly applied on large scale gene expression profiles, testing over-representation of up- or/and downregulated genes in pathways. While most gene set enrichment approaches used for pathway analysis ignore topological information, we have introduced a computational method (PathWave) [1] that explicitly takes the topology of metabolic and signaling networks into account by applying adjusted wavelet transforms on optimized, compact 2D grid representations of curated pathway maps, like those from the Kyoto Encyclopedia of Genes and Genomes (KEGG) [2]. In particular, this approach allows identifying not only metabolic pathways that show differential regulation as a whole, but also pathways affected by specific, localized switch-like regulatory shifts indicating a redirection of metabolic fluxes. This way, we have identified important metabolic switches in neuroblastoma [1], breast cancer [3], Alzheimer's disease [4], glioblastoma [5] and in an evolutionary study of E. coli[6].

Here, we present the new, entirely revised and refined version of PathWave with several substantial improvements:

  1. i.

    a faster and more efficient arrangement of 2D grid representations of pathway networks (see below),

  2. ii.

    pre-arranged 2D grid representations for several species, including H. sapiens, M. musculus, D. melanogaster, D. rerio, C. elegans, and E. coli,

  3. iii.

    compliance with version 0.7.1 of the KEGG Markup Language (KGML),

  4. iv.

    an interface to obtain colored KEGG pathway maps depicting the identified expression changes,

  5. v.

    the use of pathways extracted from the Human metabolic model reconstruction [7] from the Biochemical Genetic and Genomic (BiGG) knowledgebase [8],

  6. vi.

    performance improvements due to faster processing of expression data, and

  7. vii.

    a more flexible and user-friendly interface.

We briefly summarize the PathWave workflow, discuss the most important novelties of the new version and demonstrate its usage by two case studies: (i) we applied PathWave to RNA-seq expression data to identify metabolic pathways that play a role in lung cancer, and (ii) we analyzed microarray expression data to identify pathways associated with longevity of Drosophila. Finally, we show that PathWave is more sensitive than the frequently used methods Gene Set Enrichment Analysis (GSEA) [9] and DAVID [10].

Implementation

PathWave workflow

The workflow consists of two major steps: the preprocessing of pathway information and the analysis of expression data. We briefly summarize the two steps (for more details, see Schramm et al. [1]):

Step 1 (preprocessing of pathway information): To run a PathWave analysis which involves the use of wavelet transforms (see below), compact 2D grid representations of pathways are required. Curated pathway maps are translated into networks in which nodes represent metabolic reactions and edges link two reactions if one reaction produces a metabolite that serves as a substrate for the other. Edges in signaling pathways are derived from direct interactions of the corresponding signaling proteins. These networks are described by their binary adjacency matrices {A ij } i,jV where V is the set of nodes and A ij  = 1 if nodes i and j are joined by an edge. The sparse adjacency matrices (A ij  = 0 for most pairs of nodes) are optimally rearranged and embedded into smaller 2D, regular square lattice grid representations, best preserving the neighborhood characteristics of the reactions by placing adjacent nodes (A ij  = 1) of the original network as close to each other as possible on the lattice grid (see Figure 1A). For this, the overall Manhattan distance on the lattice grid between neighboring nodes of the network is minimized using integer linear programming techniques. These optimal 2D grid representations need to be computed only once for a given set of pathways and can be saved for later use. We calculated and integrated preprocessed pathway sets for several species into the new PathWave R package (see below), such that this step can be skipped for these organisms.

Figure 1
figure 1

Mapping of pathways and expression data. Schematic representations of (A) the embedding of pathways into compact 2D lattice grids and (B) gene expression data mapped onto to the embedded pathways. In this toy example, R1 to R9 represent metabolic reactions.

Step 2 (analysis of expression data): To identify pathways that are differentially regulated between two conditions or subsets of gene expression data, PathWave first associates gene expression levels with metabolic reactions or signaling proteins, thus mapping the expression data of each individual sample onto the 2D lattice grids of the pathways (see Figure 1B). Then, Haar wavelet transforms are applied to each optimized grid to explore every possible expression pattern of neighboring reactions or signaling proteins within an embedded pathway and to identify statistically significant discriminative patterns between samples of the two different conditions [1]. We used Haar wavelet transforms to systematically apply low pass and high pass filters from fine grain to coarse resolutions [11].

Namely, a 2D expression grid—corresponding to the expression data of a single sample mapped onto a particular pathway (as exemplified in Figure 1B)—is divided into disjoint sections of 2 × 2 pixels (i.e. nodes), e.g. a 2D grid of size 8 × 8 is divided into 16 disjoint sections. Grids with odd sizes (e.g. 3 × 3, 4 × 5, 5 × 5) are extended with rows and/or columns of zeros to allow their division into disjoint 2 × 2 sections. For each section, all combinations of row-wise and column-wise mean and differences, respectively, are calculated, yielding 4 combined quantitative features for each 2 × 2 section: 1st) mean of the mean of the upper and mean of the lower row; 2nd) difference of the mean of the upper and the mean of the lower row; 3rd) mean of the difference of the upper and the difference of the lower row; and 4th) difference of the difference of the upper and the difference of the lower row (see Figure 2A and B for an example). When these features are determined for all sections of the grid, all mean of means features (1st) are taken to construct a new, smaller averaged grid which is again grouped into 2 × 2 sections to be transformed into features in the same manner, again yielding 4 quantitative features for every section. This procedure is repeated until no further averaging is possible (see Figure 2C), thus computing quantitative low and high pass features from fine grain (initial 2D grid) to coarse resolutions (averaged grids after repeated grouping). For more details on this Haar wavelet transformation, please see Mallat [11]. For each pathway, the features at all resolutions, obtained from the wavelet transformation, are used to identify features that can significantly discriminate between samples of the two conditions or subsets.

Figure 2
figure 2

Schematic representation of the Haar wavelet transformation. (A, B) Representation of a local (high frequency) change in an expression pattern that is (A) not detected by low pass filters (here, 1st feature; mean of means) but (B) detected by high pass filters (here, 3rd feature; mean of differences). (C) Step-wise reduction of the resolution by averaging (1st feature) of 2 × 2 sections.

Thus, Haar wavelets suit to detect both globally dysregulated pathways (low-pass filter) and switch-like behaviors within the pathways, which significantly affect only small subnetworks (high-pass filter). To overcome the rigidity of wavelet transforms, PathWave covers any possible combination of neighboring nodes by implementing a one-step frameshift concept that applies the transform to the original grids and to grids shifted by one row, one column, or by both. Finally, pathways are ranked according to their most discriminative expression pattern, being it at a fine (e.g. metabolic switch in a sub-network) or coarse grain resolution (e.g. global up- or down-regulation of an entire pathway). This ranking is done by statistical significance which is obtained by repeated random sampling of the samples (i.e., patients; drawing without replacement) [1]. Namely, for each pathway a Gumbel distribution (extreme value distribution) is fitted to the pathway-scores obtained for the randomly shuffled samples. P-values of the pathways are determined from the respective fitted curves and the actual scores obtained for unpermuted samples, and are finally corrected for multiple testing. The robustness of both the estimated P-values of single pathways and the resulting overall pathway ranking increase with the number of random samplings. An assessment of their stability demonstrates a good to excellent robustness already at a rather modest number of 1,000 to 10,000 random samplings (see Additional file 1).

It is to note that an expression pattern composed of multiple genes (regarding an entire pathway or a sub-network) may significantly discriminate between two conditions (e.g. tumor and normal tissue) even when the single genes do not appear to be differentially expressed after multiple testing correction (e.g. using t-tests). Due to the identification of such potentially relevant patterns within pathways, PathWave can be more sensitive than common gene set enrichment approaches.

Improved embedding of metabolic pathways in 2D lattice grids

The current PathWave version uses a new, up to 103 times faster branch-and-cut algorithm to embed metabolic and signaling pathways into compact 2D lattice grids, on which wavelet transforms can be applied, and to allow for optimal arrangements of larger instances [12]. The new method to optimally arrange every KEGG/BiGG pathway G = (V,E) (represented by an undirected, unweighted network or graph G with nodes V and edges E) into a compact 2D lattice grid computes an embedding of G into the lattice grid with the minimum possible total Manhattan distance (edge length) of nodes (metabolic reactions or signaling proteins) that are adjacent in G. The method is based on a novel integer programming formulation that models the pairwise distances between the nodes on the grid, instead of their absolute positions used in the previous version [1]. Clearly, not every distance combination is a feasible solution: We say that an integral distance vector {d uv } uvE is embeddable, if there exists a 2D arrangement of the nodes V on the grid such that the Manhattan distance of u and v is exactly d uv for every edge uv.

For every unordered pair {u,v} of adjacent nodes u and v, we set the distance variable x uvk to 1 if k is less than or equal to the Manhattan distance of u and v. We set it to 0 otherwise. Since for fixed u and v the number of variables being 1 is exactly the Manhattan distance of u and v, the latter can be written as the sum of all variables x uvk over k. To obtain the total length of a pathway's embedding (sum of all Manhattan distances) one has to additionally sum over all edges uv that constitute the pathway. This is done in the objective function (1) of the following integer programming formulation whose goal is to minimize the pathway's total length in the embedding:

min uv E k = 1 d max x uvk
(1)

subject to

uv E H x uv d uv - x uv d uv + 1 E H - 1
(2)

for all sub graphs H = (V H ,E H ) of G and all distance vectors d on H that are not embeddable, and to

x uvk x uv k + 1
(3)

for all uvE, 1 ≤ k ≤ d max  - 1, where all x variables are required to be binary.

The objective function (1) minimizes the total edge length of the embedding. The constraints in equation (2) ensure that the optimal distance vector is embeddable. They are the reason for the choice of the binary distance variables x, as these constraints cannot be modeled with integer variables directly taking the distance values (i.e., d uv ). Since their number is exponential, we do not add them to the model from the beginning, but separate them during the branch-and-cut algorithm. The constraints in equation (3) ensure consistency of the x variables: if the Manhattan distance is at least k + 1, then it must be also at least k. The maximum possible distance d max can be set to the diagonal diameter of the lattice grid. As d max is usually significantly lower in practice, it is estimated by our algorithm via an initial series of tests. Moreover, the branch-and-cut algorithm features a simple primal construction heuristic. It produces approximate solutions even for large instances.

Compatibility and programming languages

PathWave 2.1 is compliant with the latest KEGG KGML version (v0.7.1) and an additional Perl script can be used to translate Systems Biology Markup Language (SBML) files from the BiGG database [7, 8] to compatible KGML-like files. While the parsing of the KGML pathway files to produce adjacency matrices is implemented in R, the integral linear program (LP) that optimizes grid arrangements is written in C++, using CPLEX (ILOG, Gentilly, France) as an LP solver.

Improved user-interface

We made the PathWave user interface more flexible and easier to use. Now, running a PathWave analysis (step 2) requires a single function call in R, as shown in the following simplified example:

pwres < - pathWave.run(preprocessed.tag = "KEGG.hsa", input.sampleclasses = "sample_classes.tsv", input.exprdata = "expr_data.tsv", param.numperm = 10000, param.pvalue.correction.method = "Bonferroni", param.pvalue.threshold = 0.001, param.kegg.only_metabolism = TRUE)

Expression data and the definition of the two sample classes, or conditions, can either be specified as file names or passed as R data.frame objects and/or factor objects. The preprocessed pathway information (from step 1) to be used is specified as well as the number of permutations to be performed for statistical testing. When using KEGG, the search can optionally be limited to metabolic pathways. Additionally, we provide a simple function to build URLs for querying the KEGG web server at http://www.genome.jp/kegg/ to obtain graphical pathway maps with color-coded metabolic reactions or signaling proteins according to their up- or down-regulation:

urls < - pathWave.getColorKEGGMapURLs(pwres$results.filtered, preprocessed.tag = "KEGG.hsa")

For convenience, the R package of the new version includes seven sets of preprocessed pathways for six species: KEGG pathways for H. sapiens, M. musculus, D. melanogaster, D. rerio, C. elegans, and E. coli and pathways extracted from the human metabolic model from BiGG [7, 8].

Results and discussion

First case study: analyzing regulation of metabolic pathways in lung cancer

Lung adenocarcinoma is the most common type of lung cancer, and lung cancer is the world-wide leading cause of cancer-related deaths in males [13]. Here, we have used PathWave and analyzed a gene expression dataset derived from a large-scale RNA sequencing study [14] to identify metabolic pathways showing significant dysregulation between lung adencarcinomas and patient matched normal controls of tumor adjacent tissues. As expected, metabolism of lung cancer cells showed profound differences to normal cell metabolism (Table 1). One of the characteristic changes in metabolism of tumor cells is an increased uptake and utilization of glucose and fermentation into lactate [15], already described by Otto Warburg in the 1920s [16]. Accordingly, PathWave identified glycolysis to be significantly dysregulated (Bonferroni corrected P < 1E-16), along with the citrate cycle (TCA cycle; P < 1E-16). Notably, in contrast to most reactions of the two pathways, some key reactions were down-regulated as shown in Additional file 1: Figure S1 and Additional file 1: Figure S2: FBP1 and FBP2 encode fructose-1,6-bisphosphatase 1 and 2 (EC 3.1.3.11) and showed significantly lower expression in tumor cells than in adjacent normal tissue (P = 2.5E-7 and P = 5.8E-3, respectively). The reaction catabolized by these enzymes converts D-fructose 1,6-bisphosphate to D-fructose 6-phosphate and opposes the metabolic flux during glycolysis (gluconeogenesis). In turn, the inverse reaction catabolized by phosphofructokinase (EC 2.7.1.11) was upregulated to allow high glycolytic flux. Phosphoenolpyruvate carboxykinase (PCK1, EC 4.1.1.32) is the main control point for extracting metabolites from the TCA cycle for gluconeogenesis, and this enzyme was downregulated while lactate production was upregulated.

Table 1 Metabolic pathways with significant dysregulation in lung cancer

We detected a less known but nonetheless interesting metabolic switch in lung adenocarcinomas, namely the increased conversion of tryptophan to kynurenine by tryptophan 2,3-dioxygenase (EC 1.13.11.11) and indoleamine 2,3-dioxygenase (EC 1.13.11.52), both of which were upregulated (see Additional file 1: Figure S3). Kynurenine has been shown to induce immunosuppression and aid tumor cells to evade immune surveillance in tumors [1719]. Interestingly, we also found a significant pattern in glycosylphosphatidylinositol (GPI) anchor biosynthesis. Biosynthesis of GPI anchors is essential for appropriately locating GPI-anchored proteins onto cellular membranes. GPI transamidase (GPI-T) is in the downstream part of the pathway representation by KEGG. The upregulation of GPI-T has been described in tumorigenesis and its genes suggested as biomarkers [20]. Interestingly, the pattern we found showed particularly the upper part of GPI biosynthesis to be upregulated (significant upregulation of PIG-C: P = 1.46E-11 (Bonferroni corrected), DPM2: P = 7.04E-11, PIG-L: P = 0.005, PIG-W: P = 5.21E-8 and PIG-M: P = 1.02E-13 encoding enyzmes processing UDP-N-acetylglucosamine into GPI anchor (GlcN)1 (Ino(acyl)-P)1 (Man)1).

For comparison, we performed the same analysis using pathways extracted from the human metabolic model of the BiGG database (see Additional file 1: Table S1). The obtained results were generally in line with those obtained for KEGG and differences were mostly due to pathways that were differently represented in these databases.

To demonstrate that PathWave's extension of pathway analysis to the identification of significantly dysregulated subnetworks is more sensitive than common gene set enrichment approaches, we applied GSEA [9] and DAVID [10] to the same dataset for metabolic KEGG pathways. Using DAVID, only two pathways were significant after correction for multiple testing (Bonferroni), namely aminoacyl-tRNA biosynthesis (P = 6.46E-4) and purine metabolism (P = 9.80E-3), and only six pathways had a nominal (uncorrected) P-value of less than 0.05 (see Additional file 1: Table S2). For GSEA, three pathways were identified at nominal P < 0.05 but none was significant after correction for multiple testing (see Additional file 1: Table S3).

Second case study: pathways associated with aging in Drosophila melanogaster

As a second case study, we analyzed microarray expression data of D. melanogaster with an extended lifespan and controls [21] to identify pathways being relevant for aging. We compared gene expression profiles of 8 samples from naturally long-living specimen with 8 samples from normal specimen at optimal nutrition. For the Drosophila study signaling and metabolic pathways were considered. The two most prominent pathways obtained (see Table 2) are indeed associated with aging in other species:

Table 2 Pathways with significant dysregulation in long-lived D. melanogaster

(i) Starch and sucrose metabolism (Additional file 1: Figure S4) is central for starch digestion which has been reported to increase with increasing age in chicken [22, 23], suggesting that it is more effectively metabolized. In long lived specimen of Drosophila this could in principle be driven by an increased expression of genes encoding for enzymes digesting starch into glucose (we identified upregulation of EC 2.4.1.1, EC 3.2.1.33, see Additional file 1: Figure S4). (ii) We detected a significant pattern in the pathway for circadian rhythm. The disruption of the circadian clock has been associated with aging and morbidity [24]. Notably, expression of the clock gene was higher in D. melanogaster with an extended lifespan, consistent with the recent observation that the disruption of the encoded protein (dCLK in Additional file 1: Figure S5) reduces lifespan in mice [25].

Methods

KEGG pathways

KEGG pathways [2] were extracted from the corresponding KGML files obtained from the KEGG website (download: April 14, 2011) for the following species: H. sapiens (human), M. musculus (mouse), D. melanogaster (fly), D. rerio (zebrafish), C. elegans (worm), and E. coli. The KGML files were preprocessed to build pathway networks in which nodes represent metabolic reactions or signaling proteins (depending on the type of pathway) that are linked by an edge if one reaction produces a metabolite that serves as a substrate for another or one signaling protein interacts with another, respectively. For each of these pathway networks an optimally arranged 2D grid representation was produced as described in Results.

Extraction of pathway maps from the human metabolic model

The compartmentalized version of the Human recon 1 metabolic model [7] was obtained from the BiGG database [8]. The SBML file was parsed to extract subsystems (e.g. “Alanine and Aspartate Metabolism”) that were interpreted as pathways and converted to KGML-like XML files. These files were preprocessed in the same way as the pathways obtained from KEGG (see above).

To focus on functionally relevant interactions, several exceedingly common metabolites (like H2O) were ignored. Roughly, metabolites were excluded if they were involved in more than eight reactions. The final list was manually curated to (i) retain some specific, informative metabolites even if they were involved in more than eight reactions; and to (ii) exclude additional uninformative metabolites even if they were involved in eight or less reactions. Additional file 1: Table S4 lists all metabolites that were excluded from the model and thus from the extracted subsystems/pathways.

RNA-seq data for lung cancer

Gene expression levels for 77 lung adenocarcinomas and patient matched normal tissue were obtained from a recently published large-scale RNA sequencing study [14] (GEO accession: GSE40419). Expression levels were given in reads per kilobase of exon model per million mapped reads (RPKM) [26]. We mapped the HUGO gene symbols obtained from GEO to their corresponding Entrez/NCBI gene IDs [27] (mapping downloaded on August 31st, 2013) and restricted our analysis to genes with unique mappings (20,817 genes). For these, the lowest non-zero RPKM value of the dataset was added to all expression levels as a pseudocount, such that expression levels could be log2-transformed for use with PathWave.

Gene expression data for the Drosophila study

For this case study, we used a very recent expression data set for D. melanogaster[21] (Gene Expression Omnibus identifier: GSE36582). The dataset consisted of 46 samples of adult females of normal lifespan (22 samples) and adult females of a long-lived, natural variant of D. melanogaster (24 samples; obtained by selection for starvation resistant specimens). Samples were selected at two time points (middle age sampled at 90% survival; and old age sampled at 10% survival) and for three adult diets (malnutrition, optimal food, and overfeeding). For more details, see Doroszuk et al. [21]. For our analysis, we selected 16 samples of animals with optimal nutrition: 8 samples for normal specimen (four at each time point) and 8 samples for long-lived specimen (four at each time point). We used the data as normalized in [21]. We mapped probeset IDs of the Affymetrix Drosophila Genome 2.0 Array to gene IDs using the producers annotation information (na31). Probesets that mapped to more than one EntrezGene ID were discarded. Expression profiles from multiple probesets mapping to the same gene ID were averaged yielding one single expression profile for each of the 12,578 genes analyzed.

Mapping of gene expression data to metabolic reactions

PathWave applies Haar wavelet transforms to compact 2D grid representations of metabolic pathways. The represented nodes are metabolic reactions, not genes. Hence the gene expression values were associated with these reactions. This is done by averaging the expression values of all genes coding for enzymes that are required for catabolizing the reaction. The resulting reaction expression profiles are z-transformed over the sample set and mapped onto the compact 2D grid representations of each pathway.

PathWave analyses

For the Drosophila case study, we performed the PathWave analysis on both metabolic and signaling KEGG pathways using default parameters with the exception of performing 10,000 (default: 1,000) random shufflings of phenotype labels (long-lived D. melanogaster and normal controls) for statistical testing. Final pathway P-values were corrected for multiple testing using the Bonferroni correction. For the lung cancer case study, we performed the PathWave analysis on metabolic pathways from KEGG and the human metabolic model from BiGG. Having more samples and thus more statistical power, we additionally required at least 10 genes/reactions to be up- or downregulated for a pathway to be selected and lowered the threshold of the Bonferroni corrected P-value from 0.05 to 0.001.

Comparison with DAVID and GSEA

To compare the sensitivity of PathWave with other, common approaches we used the RPKM expression values of 77 lung adenocarcinomas and their matched normal tissue, which was the larger dataset of our case studies.

We identified 4,078 significantly upregulated and 3,065 significantly downregulated genes (Wilcoxon signed-rank test; Bonferroni-corrected P-value < 0.05) which were tested for significant pathway enrichment using DAVID (http://david.abcc.ncifcrf.gov/). The background was the set of all 20,817 genes we had used for the PathWave analysis. The functional enrichment analysis was performed with default parameters. Results were extracted only for metabolic KEGG pathways and P-value correction for multiple testing was applied accordingly. For GSEA (http://www.broadinstitute.org/gsea/), we used only annotations from metabolic KEGG pathways. Statistical significance was evaluated by comparison with 10,000 random shufflings of phenotype labels (tumor or normal) of the 154 samples.

Conclusions

Many patho-physiological clinical courses come along with major changes in cell physiology affecting single pathways or even largely remodelling signaling and the entire cellular metabolism, such as in the case of cancers [15, 28]. Even the dysregulation of only a few genes in a pathway can lead to a substantial regulatory switch that alters the output of a signaling process or redirects the metabolic flux in the cell. This may be related to aging or lead to growth advantages driving tumorigenesis, particularly when dysregulated genes are connected in the same subnetwork of a pathway and their functionality is closely linked. A good example found in this study, is the conversion of starch to glucose for which we observed a regulatory switch enabling improved digestion of starch in long-lived Drosophila specimen. Unfortunately, most pathway analysis methods require a considerably high number of genes to be dysregulated within a pathway in order to suggest the pathway as functionally relevant for the disease. These approaches do not consider significant regulatory patterns interlinked at smaller scales. For the purpose of identifying not only globally dysregulated pathways but in particular important switches in pathways, we have developed PathWave. Here, we presented a considerably improved version that, among other changes, uses a novel LP formulation to optimally embed pathway networks into compact 2D lattice grids and provides a more flexible and user-friendly interface including ready-to-use pre-arranged 2D grid representations of pathway collections for now six organisms.

We used PathWave to identify pathways that play central roles in human lung cancer and longevity of D. melanogaster. A comparison to commonly used pathway and gene set analysis methods showed PathWave to be considerably more sensitive. In contrast to common approaches, it regards pathways also when they contain only small numbers of significantly dysregulated genes, which may potentially constitute functionally relevant pathway switches, suggesting follow up investigations in the wet-lab.

Availability and requirements

Project name: PathWave

Project homepage: http://www.ichip.de/software/pathwave.html

Operating system (s ): Platform independent

Programming language: R, C++, Perl

Other requirements: For running PathWave on expression data: R version 2.14 or higher, standard CRAN R packages (XML, e1071, gtools, evd), standard Bioconductor R packages (multtest, RCurl, genefilter); for embedding pathways into compact 2D lattice grids: CPLEX, GridArranger v1.0 (available from the project homepage), ABACUS v2.4-alpha (available from the project homepage).

License: GNU GPL

Any restrictions to use by non-academics: none

References

  1. Schramm G, Wiesberg S, Diessl N, Kranz AL, Sagulenko V, Oswald M, Reinelt G, Westermann F, Eils R, König R: PathWave: discovering patterns of differentially regulated enzymes in metabolic pathways. Bioinformatics. 2010, 26: 1225-1231. 10.1093/bioinformatics/btq113.

    Article  CAS  PubMed  Google Scholar 

  2. Kanehisa M, Goto S, Sato Y, Furumichi M, Tanabe M: KEGG for integration and interpretation of large-scale molecular data sets. Nucleic Acids Res. 2012, 40: D109-D114. 10.1093/nar/gkr988.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Schramm G, Surmann EM, Wiesberg S, Oswald M, Reinelt G, Eils R, König R: Analyzing the regulation of metabolic pathways in human breast cancer. BMC Med Genomics. 2010, 3: 39-10.1186/1755-8794-3-39.

    Article  PubMed Central  PubMed  Google Scholar 

  4. Lewis NE, Schramm G, Bordbar A, Schellenberger J, Andersen MP, Cheng JK, Patel N, Yee A, Lewis RA, Eils R, König R, Palsson BØ: Large-scale in silico modeling of metabolic interactions between cell types in the human brain. Nat Biotechnol. 2010, 28: 1279-1285. 10.1038/nbt.1711.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Tönjes M, Barbus S, Park YJ, Wang W, Schlotter M, Lindroth AM, Pleier SV, Bai AH, Karra D, Felsberg J, Addington A, Lemke D, Hovestadt V, Piro RM, König R, Rolli CG, Sturm D, Witt H, Kemkemer R, Schmidt K, Hull WE, Pfister SM, Hutson SM, Plass C, Okun JG, Reifenberger G, Lichter P, Radlwimmer B: BCAT1 promotes cell proliferation via amino acid catabolism in IDH1 wildtype gliomas. Nat Medicine. 2013, 19: 901-908. 10.1038/nm.3217.

    Article  Google Scholar 

  6. Lewis NE, Hixson KK, Conrad TM, Lerman JA, Charusanti P, Polpitiya AD, Adkins JN, Schramm G, Purvine SO, Lopez-Ferrer D, Weitz KK, Eils R, König R, Smith RD, Palsson BØ: Omic data from evolved E. coli are consistent with computed optimal growth from genome-scale models. Mol Syst Biol. 2010, 6: 390-

    Article  PubMed Central  PubMed  Google Scholar 

  7. Duarte NC, Becker SA, Jamshidi N, Thiele I, Mo ML, Vo TD, Srivas R, Palsson BØ: Global reconstruction of the human metabolic network based on genomic and bibliomic data. Proc Natl Acad Sci U S A. 2007, 104: 1777-1782. 10.1073/pnas.0610772104.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Schellenberger J, Park JO, Conrad TM, Palsson BØ: BiGG: a Biochemical Genetic and Genomic knowledgebase of large scale metabolic reconstructions. BMC Bioinformatics. 2010, 11: 213-10.1186/1471-2105-11-213.

    Article  PubMed Central  PubMed  Google Scholar 

  9. Subramanian A, Tamayo P, Mootha VK, Mukherjee S, Ebert BL, Gillette MA, Paulovich A, Pomeroy SL, Golub TR, Lander ES, Mesirov JP: Gene set enrichment analysis: a knowledge-based approach for interpreting genome-wide expression profiles. Proc Natl Acad Sci U S A. 2005, 102: 15545-15550. 10.1073/pnas.0506580102.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  10. Huang DW, Sherman BT, Lempicki RA: Systematic and integrative analysis of large gene lists using DAVID bioinformatics resources. Nat Protocols. 2009, 4: 44-57.

    Article  CAS  Google Scholar 

  11. Mallat S: A Wavelet Tour of Signal Processing. 1998, New York: Academic Press

    Google Scholar 

  12. Oswald M, Reinelt G, Wiesberg S: Exact solution of the 2-dimensional grid arrangement problem. Discrete Optimization. 2012, 9: 189-199. 10.1016/j.disopt.2012.07.002.

    Article  Google Scholar 

  13. Jemal A, Bray F, Center MM, Ferlay J, Ward E, Forman D: Global cancer statistics. CA Cancer J Clin. 2011, 61: 69-90. 10.3322/caac.20107.

    Article  PubMed  Google Scholar 

  14. Seo JS, Ju YS, Lee WC, Shin JY, Lee JK, Bleazard T, Lee J, Jung YJ, Kim JO, Shin JY, Yu SB, Kim J, Lee ER, Kang CH, Park IK, Rhee H, Lee SH, Kim JI, Kang JH, Kim YT: The transcriptional landscape and mutational profile of lung adenocarcinoma. Genome Res. 2012, 22: 2109-2119. 10.1101/gr.145144.112.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  15. Jang M, Kim SS, Lee J: Cancer cell metabolism: implications for therapeutic targets. Exp Mol Med. 2013, 45: e45-10.1038/emm.2013.85.

    Article  PubMed Central  PubMed  Google Scholar 

  16. Warburg O, Wind F, Negelein E: The metabolism of tumors in the body. J Gen Physiol. 1927, 8: 519-530. 10.1085/jgp.8.6.519.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  17. Suzuki Y, Suda T, Furuhashi K, Suzuki M, Fujie M, Hahimoto D, Nakamura Y, Inui N, Nakamura H, Chida K: Increased serum kynurenine/tryptophan ratio correlates with disease progression in lung cancer. Lung Cancer. 2010, 67: 361-365. 10.1016/j.lungcan.2009.05.001.

    Article  PubMed  Google Scholar 

  18. Creelan BC, Antonia S, Bepler G, Garrett TJ, Simon GR, Soliman HH: Indoleamine 2,3-dioxygenase activity and clinical outcome following induction chemotherapy and concurrent chemoradiation in Stage III non-small cell lung cancer. Oncoimmunology. 2013, 2: e23428-10.4161/onci.23428.

    Article  PubMed Central  PubMed  Google Scholar 

  19. Opitz CA, Litzenburger UM, Sahm F, Ott M, Tritschler I, Trump S, Schumacher T, Jestaedt L, Schrenk D, Weller M, Jugold M, Guillemin GJ, Miller CL, Lutz C, Radlwimmer B, Lehmann I, Von Deimling A, Wick W, Platten M: An endogenous tumour-promoting ligand of the human aryl hydrocarbon receptor. Nature. 2011, 478: 197-120. 10.1038/nature10491.

    Article  CAS  PubMed  Google Scholar 

  20. Gamage DG, Hendrickson TL: GPI transamidase and GPI anchored proteins: oncogenes and biomarkers for cancer. Crit Rev Biochem Mol Biol. 2013, 48: 446-464. 10.3109/10409238.2013.831024.

    Article  CAS  PubMed  Google Scholar 

  21. Doroszuk A, Jonker MJ, Pul N, Breit TM, Zwaan BJ: Transcriptome analysis of a long-lived natural Drosophila variant: a prominent role of stress- and reproduction-genes in lifespan extension. BMC Genomics. 2012, 13: 167-10.1186/1471-2164-13-167.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Batal AB, Parsons CM: Effects of age on nutrient digestibility in chicks fed different diets. Poult Sci. 2002, 81: 400-407. 10.1093/ps/81.3.400.

    Article  CAS  PubMed  Google Scholar 

  23. Batal AB, Parsons CM: Utilization of various carbohydrate sources as affected by age in the chick. Poult Sci. 2004, 83: 1140-1147. 10.1093/ps/83.7.1140.

    Article  CAS  PubMed  Google Scholar 

  24. Froy O: Circadian rhythms, aging, and life span in mammals. Physiology. 2011, 26: 225-235. 10.1152/physiol.00012.2011.

    Article  CAS  PubMed  Google Scholar 

  25. Dubrovsky YV, Samsa WE, Kondratov RV: Deficiency of circadian protein CLOCK reduces lifespan and increases age-related cataract development in mice. Aging. 2010, 2: 936-944.

    PubMed Central  CAS  PubMed  Google Scholar 

  26. Mortazavi A, Williams BA, McCue K, Schaeffer L, Wold B: Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nat Methods. 2008, 5: 621-628. 10.1038/nmeth.1226.

    Article  CAS  PubMed  Google Scholar 

  27. Sayers EW, Barrett T, Benson DA, Bolton E, Bryant SH, Canese K, Chetvernin V, Church DM, Dicuccio M, Federhen S, Feolo M, Fingerman IM, Geer LY, Helmberg W, Kapustin Y, Krasnov S, Landsman D, Lipman DJ, Lu Z, Madden TL, Madej T, Maglott DR, Marchler-Bauer A, Miller V, Karsch-Mizrachi I, Ostell J, Panchenko A, Phan L, Pruitt KD, Schuler GD: Database resources of the National Center for Biotechnology Information. Nucleic Acids Res. 2012, 40: D13-D25. 10.1093/nar/gkr1184.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Sharma AK, König R: Metabolic network modeling approaches for investigating the "hungry cancer". Semin Cancer Biol. 2013, 23: 227-234. 10.1016/j.semcancer.2013.05.001.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

We thank Zita Soons (Maastricht University) and Ashwini Kumar Sharma (DKFZ) for extensive testing of the R package, and Moritz Aschoff (DKFZ), Volker Ast (DKFZ), Volker Hovestadt (DKFZ) and Barbara Hutter (DKFZ) for support and discussions. We acknowledge funding from the BMBF (CSCC/IFB FKZ: 01EO1002 and SYSMET-BC FKZ: 0316168D); the Helmholtz Alliance on Systems Biology of Signaling in Cancer; and the BMBF/CancerSys initiative MYCNET (0316076C). The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Rainer König.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

RK, RMP and RE designed the study; SW, MO and GR designed the new grid optimization method; SW and NR implemented the new grid optimization method; RMP and GS implemented the new PathWave R package; RMP performed the data analysis; RMP, RK and SW wrote the manuscript. All authors read and approved the final manuscript.

Electronic supplementary material

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly credited. 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.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Piro, R.M., Wiesberg, S., Schramm, G. et al. Network topology-based detection of differential gene regulation and regulatory switches in cell metabolism and signaling. BMC Syst Biol 8, 56 (2014). https://doi.org/10.1186/1752-0509-8-56

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1752-0509-8-56

Keywords