Skip to main content
bioRxiv
  • Home
  • About
  • Submit
  • ALERTS / RSS
Advanced Search
New Results

From Differentiated Genes to Affected Pathways

Shailesh Patil, Bharath Venkatesh, Randeep Singh
doi: https://doi.org/10.1101/038901
Shailesh Patil
1SAP Labs India, 138, EPIP Zone, Whitefield, Bengaluru, Karnataka 560066
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Bharath Venkatesh
1SAP Labs India, 138, EPIP Zone, Whitefield, Bengaluru, Karnataka 560066
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
Randeep Singh
1SAP Labs India, 138, EPIP Zone, Whitefield, Bengaluru, Karnataka 560066
2Advanced Centre for Treatment Research and Education in Cancer (ACTREC), Kharghar, Navi Mumbai, Maharashtra 410210
  • Find this author on Google Scholar
  • Find this author on PubMed
  • Search for this author on this site
  • Abstract
  • Full Text
  • Info/History
  • Metrics
  • Preview PDF
Loading

Abstract

Expression analysis and variant calling workflows are employed to identify genes that either exhibit a differential behaviour or have a significant functional impact of mutations. This is always followed by pathway analysis which provides greater insights and simplifies explanation of observed phenotype. The current techniques used towards this purpose have some serious limitations. In this paper, we propose a theoretical framework to overcome many limitations of current techniques. Our framework takes into account the networked nature of the data and provides facility to weigh each gene differently and in the process we do away with the need of arbitrary cut-offs. This framework is designed to be modular and provides the researchers with flexibility to plug analytical tools of their choice for every component. We also demonstrate effectiveness of our approach for personalized and cohort analysis of cancer gene expression samples with PageRank as one of the modules in the framework.

1 Introduction

Gene expression analysis and structural variants detection tools are used to identify genes that are significantly affected in a given disease condition. Tools ranging from earlier generation microarrays to Next Generation Sequencing like RNAseq, DNAseq and Exomeseq are often used to achieve this task. Microarray and RNAseq gene expression experiments are performed to measure changes in gene expression levels across conditions like normal vs tumor. Statistical analysis of this data usually results in p-value and fold change for each gene. Cutoffs are applied on both p-value (usually less than 0.05) and absolute fold change (usually greater than 2) to declare some of the genes as statistically significant. Structural Variant analysis workflows detect the variants in the given sample and various tools like SIFT [1], PolyPhen2 [2] and MutationAssessor [3] are employed to identify the functional impact of the mutations. Sometimes these are converted to gene level p-values and some genes are shortlisted based on certain thresholds. However, a list of significant genes alone does not provide necessary explanatory power owing to the complex interaction network of these genes. Therefore, these significant genes are further used to detect significantly affected pathways. Pathways are essentially groupings of genes based on their interactions and functions. Each pathway represents a subgraph of the gene interaction network and represents a specific cellular functionality. Techniques such as Over-Representation Analysis [4], Functional Class Scoring [5] and Pathway Topology based analysis are used to identify significantly affected pathways[6].

1.1 Need For a New Pathway Analysis Framework

Though a great variety of methodologies are available for pathway analysis, there are serious inconsistencies in these current approaches. Two recent papers by Khatri et al. [6] and by Mitrea et al. [7] provide a detailed review of various analytical approaches along with their shortcomings. The following are some recurring issues -

  1. p-value depends on the nature of the test performed, type of multiple testing correction and more importantly degrees of freedom.

  2. Reliable tests are not available for personalized analysis using a normal tumor sample pair.

  3. The cutoffs are rigid and therefore a lot of information is lost. For example, a gene of p-value 0.05 and fold change 2 qualifies to be statistically significant whereas gene with p-value 0.051 and fold change 4 is not considered for further downstream analysis.

  4. All the significantly expressed genes are treated equally for their pathways analysis irrespective of differences in their fold change values.

  5. Pathways analysis treats and tests each pathway independently. However pathways interact with each other and many genes are part of more than one pathway.

  6. Many of the current pathway databases do not concur on the graph structure of the pathways and the interactions graphs are far from complete (Soh, 2010). This uncertainty is not modeled by current algorithms

To summarize, the current methodology uses ad-hoc cutoffs, uses only part of the information and does not model the interactive nature of the data.

2 A Novel Approach

To address the problems mentioned in previous section, we propose a new approach which accommodates information of every single gene in the experiment and models the network of interactions of the genes. Our model is based on the PageRank algorithm [8]. PageRank has a proven mathematical foundation [9] and has been successfully applied to variety of network analysis problems across domains including biology [10].

The model is very general and each component can be modeled in a variety of different ways depending on nature of the task at hand. We illustrate with this with some examples for each component in section 4.

We first define the notation that we use in our model followed by the description of PageRank. We then discuss the model - the components and their interpretation.

2.1 Notation

Table 1 shows the notation that we follow in this paper.

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 1:

Notation

Small letters are used to denote scalar quantities. Uppercase letters are used to denote sets. We use bold type faces to denote matrices and vectors. Bold uppercase letters are used to represent a matrix while bold lowercase letters are used to represent vectors. Subscripts are used to denote individual components.

2.2 PageRank

Given a directed, weighted graph G(V, E) consisting of the set of edges E which represent the interactions between vertices (genes) in the set V, the PageRank vector measures the importance of each vertex.

Each element of the adjacency matrix of the graph G is given by -

Embedded Image

If the weights of the interactions are not available, the matrix Aij reduces to a boolean matrix with wij = 1 for each interaction.

The PageRank vector is computed on the normalized adjacency matrix M of the graph, where each entry is divided by the sum of its row (also called the outdegree of the vertex). The properties of M are -

  1. 0 ≤ Mij ≤ 1

  2. Mij = 0 if gene i does not interact with gene j

  3. Embedded Image

The |V|-dimensional PageRank vector r is computed iteratively as the solution to following equation

Embedded Image

PageRank and personalized PageRank are illustrated using a toy 11-vertex network in Figure 1. The vertices are sized according to their PageRank The PageRank vector can be interpreted as the probability of landing at a given node by a random walker who jumps from vertex to vertex at each iteration. The random walker can with a certain probability α choose to teleport at random to any vertex in the graph instead of following an edge. The unit vector ŝ of the |V|-dimensional personalization vector s gives the probability of landing at a vertex if the walker teleports. α is known as the damping factor, and is a tunable parameter between 0 and 1.

Figure 1:
  • Download figure
  • Open in new tab
Figure 1:

Illustrative example using differential sized vertices based on PageRank

The algorithm to compute the PageRank vector is described in Algorithm 1.

Algorithm 1:

PageRank

Figure
  • Download figure
  • Open in new tab

2.3 Pathway Analysis Model

Our model uses an available gene-gene interaction network. In this new approach, we treat gene scores such as fold changes or functional impacts as the extent to which the gene is disturbed and determines the personalization vector. Hence, each iteration of the page rank algorithm represents the propagation of disturbance through the gene interaction network. These are the components of our model

  1. G(V, E) = The gene-gene interaction network, consisting of the set of interactions E between the set of genes V.

  2. p = | V |-dimensional vector of gene p-values.

  3. f = | V |-dimensional vector of gene fold changes.

  4. ϕ(p, f) = a vector valued function that assigns weights to given vector of genes;

  5. α = damping factor; 0 ≤ α ≤< 1

  6. r = rank vector, computed using the PageRank algorithm using the quantities G(V, E), the personalization vector computed on the basis of ϕ(p, f) and α as input.

The interpretations of the components are as follows

  • ϕ determines the personalization vector s, which indicates the bias of interaction of network towards various genes. The bias is directly proportional to s.

  • α = damping factor serves dual purpose (Boldi, 2005). It can be interpreted as our faith in current graph structure and it can also be used to adjust the bias induced by personalization vector. A very small value (close to zero) indicates that we don’t trust the current graph structure and any gene would randomly interact with any other gene in the network irrespective of the edges in the graph. The magnitude of alpha also affects the rate of convergence of the algorithm. Rate of convergence is inversely proportional to magnitude of α. α can also be used to model uncertainty and incompleteness of gene network. Most networks use value of around 0.85. We would recommend a values smaller than that (in range of 0.7 to 0.75) to compensate for the incompleteness of the interaction graph-structure.

  • r= rank vector represents the final extent to which each gene is affected.

Thus, the page rank model takes into account the interconnected nature of the data and it can compensate for the incompleteness of the interaction graph structures.

3 An Algorithm for Pathway Analysis

Algorithm 2:

Page Rank based Pathway Analysis Algorithm

Figure
  • Download figure
  • Open in new tab

Here, we present an approach for pathway analysis which differs from current enrichment based approaches. We would order the pathways based on how distribution ranks of the genes in a given pathway changes compared to itself and in overall context. For this purpose, we compute two different page ranks. These correspond to the following two scenarios

  1. The term 1|V| corresponds to a situation where the network has no bias.

  2. The term ϕ(p, f) decides the extent to which each gene is disturbed and creates proportionate bias.

  3. For both of the vectors, each entry is multiplied by the outdegree of the corresponding gene in the graph. The resulting vectors sN and sA are used as the personalization vectors for the normal and diseased condition respectively.

    1. Embedded Image

    2. Embedded Image

    3. This makes sure that the affected genes with higher outdegrees disturb the graph more. Without this correction, the disturbance cause by a gene with higher degree gets diluted.

Here, we use same interaction matrix M and damping factor α in both these scenarios. Corresponding to personalization vectors sN and sA we get two rank vectors rN and rA respectively. Now we compute the distance of these two vectors for each pathway using distance metric of our choice. The pathways are sorted in descending order of absolute distance to quantify relative affectedness of the pathways. This provides the appropriate prioritization of the affected pathways. We prefer not have any cutoff to remove pathways. In order to compute relative affect-edness, we can compute divergence value of each pathway and sort pathways in descending order of pathways. A p-value can be computed from KL divergences if necessary. The entire procedure is summarised in Algorithm 2.

4 Illustrations for fine tuning of various components

Following are the components which one can fine tune

  1. ϕ(p, f): following are some possible definitions of f

    1. ϕ = 1 – p where 1 denotes vector of all ones - Here we ignore fold change and use only p-values

    2. ϕ = –log(p) - This formulation will introduce non-linear exaggeration of p-values while deciding weights.

    3. ϕ = | f| - This uses absolute value of fold change

    4. ϕ = (1 – p) * |f| - This uses both p-value and fold change.

    5. ϕ = –log(p) * |f - This use both p-value and fold change but non-linearly exaggerates impact of p-value.

    In short, one can combine multiple linear and nonlinear combinations of p-vlues and fold change to decide weights of genes in personalization vector.

  2. Divergence - Consider a pathway P with k genes g1, g2,gk, and let Embedded Image be their respective values in rank vector rN and Embedded Image be their respective values in rank vector rA.

    1. KL divergence - We can compute impact of disease on pathway p as Kullback-Leibler (KL) divergence of disease pathway vector rA from normal pathway vector rN. KL divergence is used to calculate distance between two probability distributions. In the given context, impact of disease on a pathway can be measured as Embedded Image

      Where DKL(rN || rA) is divergence of rA from rN. KL divergence is a asymmetric measure, in certain scenarios a symmetric measure might be desirable. Jensen-Shannon divergence can be used in these scenarios.

    2. Mean Absolute Deviation (MAD): average of absolute fold changes of rank values of disease to normal. Embedded Image

  3. Interaction adjacency matrix M:

    1. We have chosen to weigh all types of interaction equally. Different interactions (that is graph edges) can be assigned different weights depending on rate of interaction.

    2. We have used unsigned matrix. However, one can model interactions as signed edges. In such scenarios, variations of page rank from social network analysis based on trust and distrust propagation (Guha, 2004) can be used to compute rank.

    3. M can represent heterogeneous graph that includes more cellular entities which can provide much more comprehensive model. In addition to genes, following are the some of the entities one can add

      1. miRNAs here miRNAs can be connected to their targets. Edges could be signed.

      2. promoters connected with corresponding gene. This can be useful to model impact of methylation

    4. M can even represent interactions among transcripts instead of genes. A gene can give rise to multiple transcripts and each transcript can code for different protein. With RNAseq, it is possible to estimate transcript description accurately. A transcript graph would provide finer level of information.

5 Materials and Methods

We use Reactome pathway database (Version 2014) to generate gene-gene interaction network. We use publicly available data from TCGA and GEO for our analysis. We demonstrate results of two analysis scenarios.

  1. Personalized Analysis

  2. Cohort Analysis

Damping factor is set at α = 0.7. For nodes that do not exist in the expression analysis, a default value of 1 was assumed. We use mean absolute deviation (Equation (3)) of the rank values to calculate pathway level disturbances.

5.1 Personalized Analysis

This analysis considers only a single patient’s data. Hence, a normal-tumor breast cancer sample pair (TCGA-BH-A0H7-11A-13R-A089-07, TCGA-BH-A0H7-01A-13R-A056-07) gene expression data is analyzed.

Here, ϕ(p, f) = | f |. Only the absolute fold change values are used for personalization. No p-value is calculated or used in this analysis. Top twenty pathways from this analysis are presented in Table 2.

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 2:

Personalized Analysis - Breast Cancer

5.2 Cohort Analysis

This analysis is performed on small cell lung carcinoma samples. Microarray gene expression data from 60 pairs of normal and tumor is analyzed. This data is obtained from GEO( Dataset Record: GDS3837, Data Accession Series: GSE19804). p-value is obtained using a paired t-test.

Here, a personalization function based on both the computed p-values and the fold changes is used - ϕ(p, f) = f * (1 – p). Top twenty pathways from this analysis are presented in table 3

View this table:
  • View inline
  • View popup
  • Download powerpoint
Table 3:

Cohort Analysis - Lung Cancer

6 Related Work

As explained in earlier sections, PageRank attempts to propagate an entity (belief, disturbance, perturbation- depending on the application) across the edges of the graph until steady state is achieved. The convergence is guaranteed if adjacency matrix is non negative. Certain variants model it for signed graphs, however due to lack of convergence they perform some maximum number of iterations and accept the final vector as rank vector. There are some examples of PageRank and its variants being used in NGS and pathway analysis in general. We briefly explain two such examples this section.

SPIA [11] combines both over representation analysis and perturbation analysis to come up with a p-value for a pathway. The perturbation factor for each gene is calculated as sum of signed log-fold change and the sum of perturbation factors of the genes directly upstream of the target gene, normalized by the number of downstream genes. So the perturbation propagation is similar to belief propagation. However this approach has two shortcomings. The perturbation propagation involves negative entries, so algorithm is not guaranteed to converge. Once the fold changes are captured in personalization vector, overrepresentations analysis becomes redundant.

DawnRank [12] attempts to rank mutated genes in a single cancer patient based on its potential to be a driver gene. Here fold change serves as personalization component of PageRank. However, it uses M instead of MT in PageRank formulations. That means nodes with higher centrality values get ranked higher. Here node centrality is interpreted as ability to affect other nodes in the graph.

7 Future Scope

In this paper, we proposed a new framework for pathway analysis which addresses some of the imminent issues of the state of the art. However, there is huge scope for improvement as follows.

  • The current pathway databases are far from complete and have high degree of discordance. Though damping factor mitigates some of the uncertainty, a comprehensive pathway database will lead to more accurate analysis

  • Rate of interaction is not currently available for all the interactions in the network. When rate of interactions will be available for all the interactions, Flux Balance Analysis (FBA) could be employed or page rank algorithm needs to be modified to accommodate rate of interaction.

  • The interaction network can be enhanced by accommodating miRNA and transcripts

Footnotes

  • ↵* shailesh.patil{at}gmail.com

  • ↵† bharath.venkatesh85{at}gmail.com

  • ↵‡ singh.randeep{at}gmail.com

References

  1. [1].↵
    Kumar, P., Henikoff, S. & Ng, P. C. Predicting the effects of coding non-synonymous variants on protein function using the sift algorithm. Nature protocols 4, 1073–1081 (2009).
    OpenUrl
  2. [2].↵
    Adzhubei, I. A. et al. A method and server for predicting damaging missense mutations. Nature methods 7, 248–249 (2010).
    OpenUrlCrossRefPubMed
  3. [3].↵
    Reva, B., Antipin, Y. & Sander, C. Predicting the functional impact of protein mutations: application to cancer genomics. Nucleic acids research gkr407 (2011).
  4. [4].↵
    Huang, D. W., Sherman, B. T. & Lempicki, R. A. Bioinformatics enrichment tools: paths toward the comprehensive functional analysis of large gene lists. Nucleic acids research 37, 1–13 (2009).
    OpenUrlCrossRefPubMedWeb of Science
  5. [5].↵
    Ackermann, M. & Strimmer, K. A general modular framework for gene set enrichment analysis. BMC bioinformatics 10, 47 (2009).
    OpenUrlCrossRefPubMed
  6. [6].↵
    Khatri, P., Sirota, M. & Butte, A. J. Ten years of pathway analysis: current approaches and outstanding challenges. PLoS Comput Biol 8, e1002375 (2012).
    OpenUrlCrossRefPubMed
  7. [7].↵
    Mitrea, C. et al. Methods and approaches in the topology-based analysis of biological pathways. Frontiers in physiology 4 (2013).
  8. [8].↵
    Page, L., Brin, S., Motwani, R. & Winograd, T. The pagerank citation ranking: bringing order to the web. (1999).
  9. [9].↵
    Ipsen, I. C. & Wills, R. S. Mathematical properties and analysis of google’s pagerank. Bol. Soc. Esp. Mat. Apl 34, 191–196 (2006).
    OpenUrl
  10. [10].↵
    Iván, G. & Grolmusz, V. When the web meets the cell: using personalized pagerank for analyzing protein interaction networks. Bioinformatics 27, 405–407 (2011).
    OpenUrlCrossRefPubMedWeb of Science
  11. [11].↵
    Tarca, A. L. et al. A novel signaling pathway impact analysis. Bioinformatics 25, 75–82 (2009).
    OpenUrlCrossRefPubMedWeb of Science
  12. [12].↵
    Hou, J. P. & Ma, J. Dawnrank: discovering personalized driver genes in cancer. Genome Med 6, 56 (2014).
    OpenUrlCrossRefPubMed
Back to top
PreviousNext
Posted February 07, 2016.
Download PDF
Email

Thank you for your interest in spreading the word about bioRxiv.

NOTE: Your email address is requested solely to identify you as the sender of this article.

Enter multiple addresses on separate lines or separate them with commas.
From Differentiated Genes to Affected Pathways
(Your Name) has forwarded a page to you from bioRxiv
(Your Name) thought you would like to see this page from the bioRxiv website.
CAPTCHA
This question is for testing whether or not you are a human visitor and to prevent automated spam submissions.
Share
From Differentiated Genes to Affected Pathways
Shailesh Patil, Bharath Venkatesh, Randeep Singh
bioRxiv 038901; doi: https://doi.org/10.1101/038901
Reddit logo Twitter logo Facebook logo LinkedIn logo Mendeley logo
Citation Tools
From Differentiated Genes to Affected Pathways
Shailesh Patil, Bharath Venkatesh, Randeep Singh
bioRxiv 038901; doi: https://doi.org/10.1101/038901

Citation Manager Formats

  • BibTeX
  • Bookends
  • EasyBib
  • EndNote (tagged)
  • EndNote 8 (xml)
  • Medlars
  • Mendeley
  • Papers
  • RefWorks Tagged
  • Ref Manager
  • RIS
  • Zotero
  • Tweet Widget
  • Facebook Like
  • Google Plus One

Subject Area

  • Genomics
Subject Areas
All Articles
  • Animal Behavior and Cognition (4229)
  • Biochemistry (9118)
  • Bioengineering (6753)
  • Bioinformatics (23949)
  • Biophysics (12103)
  • Cancer Biology (9498)
  • Cell Biology (13746)
  • Clinical Trials (138)
  • Developmental Biology (7618)
  • Ecology (11666)
  • Epidemiology (2066)
  • Evolutionary Biology (15479)
  • Genetics (10621)
  • Genomics (14298)
  • Immunology (9468)
  • Microbiology (22808)
  • Molecular Biology (9083)
  • Neuroscience (48900)
  • Paleontology (355)
  • Pathology (1479)
  • Pharmacology and Toxicology (2566)
  • Physiology (3827)
  • Plant Biology (8320)
  • Scientific Communication and Education (1467)
  • Synthetic Biology (2294)
  • Systems Biology (6172)
  • Zoology (1297)