knitr::opts_chunk$set(collapse=TRUE, comment=">") knitr::opts_chunk$set(dpi=150) knitr::opts_chunk$set(cache=FALSE) knitr::opts_chunk$set(echo=TRUE) knitr::opts_chunk$set(warning=FALSE) knitr::opts_chunk$set(message=FALSE) knitr::opts_chunk$set(fig_cap="yes") knitr::opts_chunk$set(eval=FALSE)
cd ~/Sites/XGR ################################################ R #devtools::install_github(c("Bioconductor/BiocStyle")) #rmarkdown::render("now.Pi_vignettes.Rmd", BiocStyle::html_document(toc=TRUE,toc_depth=2,number_sections=TRUE,hightlight="default",toc_float=FALSE)) #rmarkdown::render("now.Pi_vignettes.Rmd", BiocStyle::html_document2(toc=TRUE,toc_depth=2,number_sections=TRUE,theme="journal", hightlight="monochrome",toc_float=TRUE,code_folding="hide")) rmarkdown::render("now.Pi_vignettes.Rmd", BiocStyle::html_document(toc=TRUE,toc_depth=2,number_sections=TRUE,theme="journal", hightlight="monochrome",toc_float=TRUE,code_folding="hide")) #knitr::purl("now.Pi_vignettes.Rmd") q('no') ################################################ scp now.Pi_vignettes.html galahad.well.ox.ac.uk:/var/www/Pi/Pi_vignettes.html scp now.Pi_vignettes.Rmd galahad.well.ox.ac.uk:/var/www/Pi/Pi_vignettes.Rmd
The latest version on different platforms can be installed following instructions at http://bioconductor.org/install/#install-R.
Install Pi
(the latest stable release version from Bioconductor):
BiocManager("Pi", dependencies=T)
Also install the latest development version from github (highly recommended):
# first, install the dependant packages (the stable version) BiocManager(c("Pi","devtools"), dependencies=T) # then, install the `Pi` package and its dependency (the latest version) BiocManager::install("hfang-bristol/Pi")
library(png) library(grid) img <- readPNG("saved.Pi.workflow.png") grid.raster(img)
Priority functions are designed in a nested way. The core relation follows this route: xPierSNPs
-> xPierGenes
-> xPier
-> xRWR
, achieving gene-level prioritisation from an input list of SNPs (along with their significant level). The output of this route is taken as the input of either xPierManhattan
for visualising gene priority scores, xPierPathways
for prioritising pathways, or xPierSubnet
for identifying a network of top prioritised genes.
library(png) library(grid) img <- readPNG("saved.Pi.functions.png") grid.raster(img)
xRWR
: implements Random Walk with Restart (RWR) estimating the affinity score of nodes in a graph to a list of seed nodes. The affinity score can be viewed as the influential impact
over the graph that is collectively imposed by seed nodes. If the seeds are not given, it will pre-compute affinity matrix for nodes in the input graph with respect to each starting node (as a seed) by looping over every node in the graph. A higher-level function xPier
directly relies on it.
xPier
: uses RWR to calculate the affinity score of nodes in a graph to a list of seed nodes. A node that has a higher affinity score to seed nodes will receive a higher priority score. It is an internal function acting as a general template for RWR-based prioritisation. A higher-level function xPierGenes
directly relies on it.
xPierGenes
: prioritises gene targets from an input gene interaction network and the score info imposed on its seed nodes/genes. This function can be considered to be a specific instance of xPier
, that is, specifying a gene interaction network as a graph and seed nodes as seed genes.
There are two sources of gene interaction network information: the STRING database [@Szklarczyk2015] and the Pathway Commons database [@Cerami2011]. STRING is a meta-integration of undirect interactions from a functional aspect, while Pathway Commons mainly contains both undirect and direct interactions from a physical/pathway aspect. In addition to interaction type, users can choose the interactions of varying quality:
net <- list() net[['STRING_high']] <- c('STRING', 'Functional interactions (with high confidence scores>=700)', 'STRING_high') net[['STRING_medium']] <- c('STRING', 'Functional interactions (with medium confidence scores>=400)', 'STRING_medium') net[['PCommonsUN_high']] <- c('Pathway Commons', 'Physical/undirect interactions (with references & >=2 sources)', 'PCommonsUN_high') net[['PCommonsUN_medium']] <- c('Pathway Commons', 'Physical/undirect interactions (with references & >=1 sources)', 'PCommonsUN_medium') net[['PCommonsDN_high']] <- c('Pathway Commons', 'Pathway/direct interactions (with references & >=2 sources)', 'PCommonsDN_high') net[['PCommonsDN_medium']] <- c('Pathway Commons', 'Pathway/direct interactions (with references & >=1 sources)', 'PCommonsDN_medium') df_net <- do.call(rbind, net) colnames(df_net) <- c('Database', 'Interaction (type and quality)', 'Code') knitr::kable(df_net[,c(3,2,1)], caption="", row.names=FALSE)
xPierSNPs
: prioritises gene targets from an input gene interaction network and a given list of SNPs together with the significance level (eg GWAS reported p-values). To do so, it first defines seed genes and their scores that are calculated in an integrative manner to quantify the genetic influence under SNPs. Genetic influential score on a seed gene is calculated from the SNP score (reflecting the SNP significant level), the gene-to-SNP distance weight, the eQTL mapping weight and the promoter capture HiC weight. This function can be considered to be a specific instance of xPierGenes
, that is, specifying seed genes plus their scores.
Knowledge of co-inherited variants is also used to include additional SNPs that are in Linkage Disequilibrium (LD) with GWAS lead SNPs. LD SNPs are calculated based on 1000 Genomes Project data [@Project2012]. LD SNPs are defined to be any SNPs having R2 > 0.8 with GWAS lead SNPs. The user can choose the population used to calculate LD SNPs:
pop <- list() pop[['AFR']] <- c('1000 Genomes Project', 'African', 'AFR') pop[['AMR']] <- c('1000 Genomes Project', 'Admixed American', 'AMR') pop[['EAS']] <- c('1000 Genomes Project', 'East Asian', 'EAS') pop[['EUR']] <- c('1000 Genomes Project', 'European', 'EUR') pop[['SAS']] <- c('1000 Genomes Project', 'South Asian', 'SAS') df_pop <- do.call(rbind, pop) colnames(df_pop) <- c('Project', 'Population', 'Code') knitr::kable(df_pop[,c(3,2,1)], caption="", row.names=FALSE)
xPierAnno
: prioritises seed genes only from a list of pNode objects using annotation data. To do so, it first extracts seed genes from a list of pNode objects and then scores seed genes using annotation data (or something similar), followed by xPierGenes
.
xPierMatrix
: extracts priority matrix from a list of pNode
objects, in which rows are genes and columns for the predictors (corresponding to the pNode
objects). Also highlighted is to generate priority results in the discovery mode, that is, (similar to meta-analysis) aggregation of priority matrix.
xPierEvidence
: extracts evidence from a list of pNode
objects, in terms of seed genes under genetic influence.
xVisEvidence
: visualises evidence for prioritised genes in a gene network.
xPierManhattan
: visualises prioritised genes using manhattan plot, in which priority for genes is displayed on the Y-axis along with genomic locations on the X-axis. Also highlighted are genes with the top priority.
xPierTrack
: visualises a prioritised gene using track plot, in which priority for the gene in query is displayed on the data track and nearby genes on the annotation track. Genomic locations on the X-axis are indicated on the X-axis, and the gene in query is highlighted.
xPierTrackAdv
: visualises a list of prioritised genes using advanced track plot.
xPierPathways
: prioritises pathways based on enrichment analysis of genes with the top priority (eg top 100 genes) using a compendium of pathways. It returns an object of class eTerm
. A highly prioritised pathway has its member genes with high gene-level priority scores, that is, having evidence of direct modulation by disease-associated lead (or LD) SNPs, and/or having evidence of indirect modulation at the network level.
xPierGSEA
: prioritises pathways based on gene set enrichment analysis (GSEA) of prioritised genes using a compendium of pathways. It returns an object of class eGSEA
. A highly prioritised pathway has its member genes with a tendency of having high gene-level priority scores.
In addition to pathways, analysis can be extended to other ontologies, as listed below:
obo <- list() obo[['DO']] <- c('Disease', 'Disease Ontology', 'DO') obo[['GOMF']] <- c('Function', 'Gene Ontology Molecular Function', 'GOMF') obo[['GOBP']] <- c('Function', 'Gene Ontology Biological Process', 'GOBP') obo[['GOCC']] <- c('Function', 'Gene Ontology Cellular Component', 'GOCC') obo[['HPPA']] <- c('Phenotype', 'Human Phenotype Phenotypic Abnormality', 'HPPA') obo[['HPMI']] <- c('Phenotype', 'Human Phenotype Mode of Inheritance', 'HPMI') obo[['HPCM']] <- c('Phenotype', 'Human Phenotype Clinical Modifier', 'HPCM') obo[['HPMA']] <- c('Phenotype', 'Human Phenotype Mortality Aging', 'HPMA') obo[['MP']] <- c('Phenotype', 'Mammalian/Mouse Phenotype', 'MP') obo[['DGIdb']] <- c('Druggable', 'DGI druggable gene categories', 'DGIdb') obo[['SF']] <- c('Structural domain', 'SCOP domain superfamilies', 'SF') obo[['Pfam']] <- c('Structural domain', 'Pfam domain families', 'Pfam') obo[['PS2']] <- c('Evolution', 'phylostratific age information (our ancestors)', 'PS2') obo[['MsigdbH']] <- c('Hallmark (MsigDB)', 'Hallmark gene sets', 'MsigdbH') obo[['MsigdbC1']] <- c('Cytogenetics (MsigDB)', 'Chromosome and cytogenetic band positional gene sets', 'MsigdbC1') obo[['MsigdbC2CGP']] <- c('Perturbation (MsigDB)', 'Chemical and genetic perturbation gene sets', 'MsigdbC2CGP') obo[['MsigdbC2CPall']] <- c('Pathways (MsigDB)', 'All pathway gene sets', 'MsigdbC2CPall') obo[['MsigdbC2CP']] <- c('Pathways (MsigDB)', 'Canonical pathway gene sets', 'MsigdbC2CP') obo[['MsigdbC2KEGG']] <- c('Pathways (MsigDB)', 'KEGG pathway gene sets', 'MsigdbC2KEGG') obo[['MsigdbC2REACTOME']] <- c('Pathways (MsigDB)', 'Reactome pathway gene sets', 'MsigdbC2REACTOME') obo[['MsigdbC2BIOCARTA']] <- c('Pathways (MsigDB)', 'BioCarta pathway gene sets', 'MsigdbC2BIOCARTA') obo[['MsigdbC3TFT']] <- c('TF targets (MsigDB)', 'Transcription factor target gene sets', 'MsigdbC3TFT') obo[['MsigdbC3MIR']] <- c('microRNA targets (MsigDB)', 'microRNA target gene sets', 'MsigdbC3MIR') obo[['MsigdbC4CGN']] <- c('Cancer (MsigDB)', 'Cancer gene neighborhood gene sets', 'MsigdbC4CGN') obo[['MsigdbC4CM']] <- c('Cancer (MsigDB)', 'Cancer module gene sets', 'MsigdbC4CM') obo[['MsigdbC5BP']] <- c('Function (MsigDB)', 'GO biological process gene sets', 'MsigdbC5BP') obo[['MsigdbC5MF']] <- c('Function (MsigDB)', 'GO molecular function gene sets', 'MsigdbC5MF') obo[['MsigdbC5CC']] <- c('Function (MsigDB)', 'GO cellular component gene sets', 'MsigdbC5CC') obo[['MsigdbC6']] <- c('Oncology (MsigDB)', 'Oncogenic signature gene sets', 'MsigdbC6') obo[['MsigdbC7']] <- c('Immunology (MsigDB)', 'Immunologic signature gene sets', 'MsigdbC7') df_obo <- do.call(rbind, obo) colnames(df_obo) <- c('Category', 'Ontology', 'Code') knitr::kable(df_obo[,c(3,2,1)], caption="", row.names=FALSE)
xPierSubnet
: identifies a gene network that contains as many highly prioritised genes as possible but a few lowly prioritised genes as linkers. An iterative procedure of choosing different priority cutoff is also used to identify the network with a desired number of nodes/genes.
xPredictROCR
: assesses the prediction/prioritisation performance via Receiver Operating Characteristic (ROC) and Precision-Recall (PR) analysis.
xPredictCompare
: compares the prediction/prioritisation performance.
xGSsimulator
: simulates the gold standard negatives (GSN) from gold standard positives (GSP) considering the gene interaction evidence and returns an object of class sGS
.
xPierROCR
: assesses the dTarget performance via ROC and PR analysis.
xMLfeatureplot
: visualises/assesses features used for machine learning.
xMLrandomforest
: integrates predictor matrix via machine learning algorithm random forest and returns an object of class sTarget
.
xMLcaret
: integrates predictor matrix in a supervised manner via machine learning algorithms using caret and returns an object of class sTarget
.
xMLparameters
: visualises cross-validation performance against tuning parameters.
xMLdotplot
: visualise machine learning results (a sTarget
object) using dot plot and returns an object of class ggplot
.
xMLdensity
: visualise machine learning results (a sTarget
or dTarget
object) using density plot and returns an object of class ggplot
.
xMLzoom
: visualise machine learning results (a sTarget
or dTarget
object) using zoom plot and returns an object of class ggplot
.
xPierSNPsAdv
: prepares genetic predictors given a list of seed SNPs together with the significance level (e.g. GWAS reported p-values).
xPierCross
: extracts priority matrix from a list of dTarget
/sTarget
objects.
xSNP2eGenes
: defines eQTL genes given a list of SNPs.
xSNP2cGenes
: defines HiC genes given a list of SNPs.
xPCHiCplot
: visualises promoter capture HiC data using different network layouts.
xContour
: visualises a numeric matrix as a contour plot.
xGSEAdotplot
: visualises GSEA results using dot plot.
xGSEAbarplot
: visualises GSEA results using bar plot.
xGSEAconciser
: makes GSEA results conciser by removing redundant terms.
In this section, we use GWAS SNPs about an inflammatory disease Spondyloarthritis
(including Ankylosing Spondylitis
and Psoriatic Arthritis
) as a case study, and give a step-by-step demo showing how to use Pi
to achieve disease-specific genetic prioritisation of targets at the gene, pathway and network level.
First of all, load the packages including Pi
:
library(Pi) # optionally, specify the local location of built-in RData # by default: RData.location <- "http://galahad.well.ox.ac.uk/bigdata"
# This intends to use the local version of data RData.location <- "~/Sites/SVN/github/bigdata_dev"
Spondyloarthritis-associated GWAS lead SNPs are collected mainly from GWAS Catalog [@Welter2014], complemented by ImmunoBase and latest publications.
data.file <- "http://galahad.well.ox.ac.uk/bigdata/Spondyloarthritis.txt" data <- read.delim(data.file, header=TRUE, stringsAsFactors=FALSE)
The first 15 rows of data
are shown below, with the column SNP
for GWAS SNPs and the column Pval
for GWAS-detected P-values.
knitr::kable(data[1:15,], digits=200, caption="", row.names=FALSE)
It includes the following steps:
define seed genes
, that is, seed genes are defined based on distance-to-SNP window, genetic association with gene expression, and physical interaction involving variants and genes: nearby genes
that are located within defined distance window (by default, 50kb) of lead or Linkage Disequilibrium (LD) SNPs that are calculated based on European population data from 1000 Genome Project; expression associated genes (eQTL genes)
for which gene expression is, either in a cis- or trans-acting manner, significantly associated with lead or LD SNPs, based on eQTL mapping; promoter capture HiC genes (HiC genes)
for which gene promoters physically interact with variants, based on genome-wide capture HiC-generated promoter interactomes.
score seed genes
, that is, quantifying the genetic influence under lead or LD SNPs.
prioritise target genes
, that is, estimating their global network connectivity to seed genes. With scored seed genes superposed onto a gene interaction network, RWR algorithm is implemented to prioritise candidate target genes based on their network connectivity/affinity to seed genes. As such, a gene that has a higher affinity score to seed genes will receive a higher priority score.
Specify parameters
include.LD <- 'EUR' LD.r2 <- 0.8 LD.customised <- NULL significance.threshold <- 5e-8 distance.max <- 50000 decay.kernel <- "rapid" decay.exponent <- 2 include.eQTL <- c("JKscience_TS2A","JKscience_TS2B","JKscience_TS3A","JKng_bcell","JKng_mono","JKnc_neutro", "GTEx_V4_Whole_Blood") eQTL.customised <- NULL include.HiC <- c("Monocytes","Neutrophils","Total_B_cells") GR.SNP <- "dbSNP_GWAS" GR.Gene <- "UCSC_knownGene" cdf.function <- "empirical" relative.importance <- c(1/3, 1/3, 1/3) scoring.scheme <- 'max' network <- "STRING_high" network.customised <- NULL weighted <- FALSE normalise <- "laplacian" normalise.affinity.matrix <- "none" restart <- 0.75 parallel <- TRUE multicores <- NULL verbose <- TRUE
Do prioritisation
pNode <- xPierSNPs(data, include.LD=include.LD, LD.r2=LD.r2, significance.threshold=significance.threshold, distance.max=distance.max, decay.kernel=decay.kernel, decay.exponent=decay.exponent, include.eQTL=include.eQTL, include.HiC=include.HiC, GR.SNP=GR.SNP, GR.Gene=GR.Gene, cdf.function=cdf.function, scoring.scheme=scoring.scheme, network=network, restart=restart, RData.location=RData.location)
The results are stored in the data frame pNode$priority
, which can be saved into a file Genes_priority.txt
:
write.table(pNode$priority, file="Genes_priority.txt", sep="\t", row.names=FALSE)
Visualise in manhattan plot
Top genes can be highlighted in manhattan plot, in which priority scores for genes are displayed on the Y-axis along with genomic locations on the X-axis.
mp <- xPierManhattan(pNode, top=40, y.scale="sqrt", RData.location=RData.location) print(mp)
png(file="saved.Pi.gene_manhattan.png", height=480, width=480*2.2, res=96*1.3) print(mp) dev.off()
library(png) library(grid) img <- readPNG("saved.Pi.gene_manhattan.png") grid.raster(img)
Pathway-level prioritisation is based on top 100 genes using a compendium of pathways from diverse sources (Canonical, KEGG, BioCarta and Reactome). Since diverse sources are used, it is necessary to remove redundant pathways (of the same granularity to the similar pathways with higher priority scores), done by XGR [@Fang2016].
eTerm <- xPierPathways(pNode, priority.top=100, ontology="MsigdbC2CPall", RData.location=RData.location) eTerm_nonred <- xEnrichConciser(eTerm) # view the top pathways/terms xEnrichViewer(eTerm_nonred) # save results to a file `Pathways_priority.nonredundant.txt` Pathways_nonred <- xEnrichViewer(eTerm_nonred, top_num=length(eTerm_nonred$adjp), sortBy="fdr", details=TRUE) output <- data.frame(term=rownames(Pathways_nonred), Pathways_nonred) write.table(output, file="Pathways_priority.nonredundant.txt", sep="\t", row.names=FALSE)
Barplot of prioritised pathways (non-redundant and informative):
bp <- xEnrichBarplot(eTerm_nonred, top_num="auto", displayBy="fdr", FDR.cutoff=1e-3, wrap.width=50, signature=FALSE) bp
png(file="saved.Pi.pathway_barplot.png", height=360, width=360*3, res=96) print(bp) dev.off()
library(png) library(grid) img <- readPNG("saved.Pi.pathway_barplot.png") grid.raster(img)
Network-level prioritisation is to identify a gene network that contains as many highly prioritised genes as possible but a few lowly prioritised genes as linkers. Given a gene network (the same as used in gene-level prioritisation) with nodes labelled with gene priority scores, the search for a maximum-scoring gene subnetwork is briefed as follows:
score transformation
, that is, given a threshold of tolerable priority scores, nodes above this threshold (nodes of interest) are scored positively, and negative scores for nodes below the threshold (intolerable).
subnetwork identification
, that is, to find an interconnected gene subnetwork enriched with positive-score nodes but allowing for a few negative-score nodes as linkers, done via heuristically solving prize-collecting Steiner tree problem [@Fang2014c].
controlling the subnetwork size
, that is, an iterative procedure of scanning different priority thresholds is used to identify the network with a desired number of nodes/genes.
Notably, the preferential use of the same network as used in gene-level prioritisation is due to the fact that gene-level affinity/priority scores are smoothly distributed over the network after being walked. In other words, the chance of identifying such a gene network enriched with top prioritised genes is much higher. To reduce the runtime, by default only top 10% prioritised genes will be used to search for the maximum-scoring gene network.
# find maximum-scoring gene network with the desired node number=50 g <- xPierSubnet(pNode, priority.quantite=0.1, subnet.size=50, RData.location=RData.location)
The identified gene network has nodes/genes colored according to their priority scores (see below). Notably, if nodes appear abnormally, please remove vertex.shape="sphere"
when running the function xVisNet
.
pattern <- as.numeric(V(g)$priority) zmax <- ceiling(quantile(pattern,0.75)*1000)/1000 xVisNet(g, pattern=pattern, vertex.shape="sphere", colormap="yr", newpage=FALSE, edge.arrow.size=0.3, vertex.label.color="blue", vertex.label.dist=0.35, vertex.label.font=2, zlim=c(0,zmax), signature=FALSE)
png(file="saved.Pi.network_vis.png", height=480*2, width=480*2, res=96*1.5) xVisNet(g, pattern=pattern, vertex.shape="sphere", colormap="yr", newpage=FALSE, vertex.label.color="blue", vertex.label.dist=0.35, vertex.label.font=2, zlim=c(0,zmax), signature=FALSE) dev.off()
library(png) library(grid) img <- readPNG("saved.Pi.network_vis.png") grid.raster(img)
Here is the output of sessionInfo()
on the system on which this user manual was compiled:
sessionInfo()
Below is the list of references that Pi stands on:
Any scripts or data that you put into this service are public.
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.