The list of differentially expressed genes is sometimes so long that its interpretation becomes cumbersome and time consuming. It may also be very short while some genes have low p-value yet higher than the given threshold.
A common downstream procedure to combine information across genes is gene set testing. It aims at finding pathways or gene networks the differentially expressed genes play a role in.
Various ways exist to test for enrichment of biological pathways. We will look into over representation and gene set enrichment analyses.
A gene set comprises genes that share a biological function, chromosomal location, or any other relevant criterion.
To save time and effort there are a number of packages that make applying these tests to a large number of gene sets simpler, and which will import gene lists for testing from various sources.
Today we will use clusterProfiler
.
This method tests whether genes in a pathway are present in a subset of our data in a higher number than expected by chance (explanations derived from the clusterProfiler manual).
Genes in the experiment are split in two ways:
We can then create a contingency table with:
And test for independence of the two variables with the Fisher exact test.
clusterProfiler
clusterprofiler
(Yu et al. 2012) supports direct online access of the current KEGG database (KEGG: Kyoto Encyclopedia of Genes and Genomes), rather than relying on R annotation packages. It also provides some nice visualisation options.
We first search the resource for mouse data:
library(DESeq2)
library(clusterProfiler)
library(tidyverse)
search_kegg_organism("mouse", by = "common_name")
## kegg_code scientific_name
## 26 mmur Microcebus murinus
## 30 mmu Mus musculus
## 31 mcal Mus caroli
## 32 mpah Mus pahari
## 34 mcoc Mastomys coucha
## 40 pleu Peromyscus leucopus
## 50 plop Perognathus longimembris pacificus
## 113 mmyo Myotis myotis
## 188 csti Colius striatus
## 5722 asf Candidatus Arthromitus sp. SFB-mouse-Japan
## 5723 asm Candidatus Arthromitus sp. SFB-mouse-Yit
## 5724 aso Candidatus Arthromitus sp. SFB-mouse-NL
## common_name
## 26 gray mouse lemur
## 30 house mouse
## 31 Ryukyu mouse
## 32 shrew mouse
## 34 southern multimammate mouse
## 40 white-footed mouse
## 50 Pacific pocket mouse
## 113 greater mouse-eared bat
## 188 speckled mousebird
## 5722 Candidatus Arthromitus sp. SFB-mouse-Japan
## 5723 Candidatus Arthromitus sp. SFB-mouse-Yit
## 5724 Candidatus Arthromitus sp. SFB-mouse-NL
We will use the ‘mmu’ ‘kegg_code’.
The input for the KEGG enrichment analysis is the list of gene IDs of significant genes.
ddsObj.interaction <- readRDS("RObjects/DESeqDataSet.interaction.rds")
results.interaction.11 <- readRDS("RObjects/DESeqResults.interaction_d11.rds")
DESeq2
provides a function called lfcShrink
that shrinks log-Fold Change (LFC) estimates towards zero using and empirical Bayes procedure. The reason for doing this is that there is high variance in the LFC estimates when counts are low and this results in lowly expressed genes appearing to show greater differences between groups than highly expressed genes.
plotMA(results.interaction.11, alpha = 0.05)
The lfcShrink
method compensates for this and allows better visualisation and ranking of genes.
ddsShrink.11 <- lfcShrink(ddsObj.interaction,
res = results.interaction.11,
type = "ashr")
## using 'ashr' for LFC shrinkage. If used in published research, please cite:
## Stephens, M. (2016) False discovery rates: a new deal. Biostatistics, 18:2.
## https://doi.org/10.1093/biostatistics/kxw041
shrinkTab.11 <- as.data.frame(ddsShrink.11) %>%
rownames_to_column("GeneID") %>%
rename(logFC = log2FoldChange, FDR = padj)
MA plots are a common way to visualize the results of a differential analysis. We met them briefly towards the end of the DESeq2 session. This plot shows the log-Fold Change for each gene against its average expression across all samples in the two conditions being contrasted. DESeq2
has a handy function for plotting this. Let’s use it too compare the shrunk and un-shrunk fold changes.
par(mfrow = c(1, 2))
plotMA(results.interaction.11, alpha = 0.05)
plotMA(ddsShrink.11, alpha = 0.05)
We now load the R object keeping the outcome of the differential expression analysis for the d11 contrast.
shrink.d11 <- readRDS("RObjects/Shrunk_Results.d11.rds")
We will only use genes that have:
We need to remember to eliminate genes with missing values in the FDR as a result of the independent filtering by DESeq2.
For this tool we need to use Entrez IDs, so we will also need to eliminate genes with a missing Entrez ID (NA values in the ‘Entrez’ column).
sigGenes <- shrink.d11 %>%
drop_na(Entrez, FDR) %>%
filter(FDR < 0.05 & abs(logFC) > 1) %>%
pull(Entrez)
keggRes <- enrichKEGG(gene = sigGenes, organism = "mmu")
## Reading KEGG annotation online: "https://rest.kegg.jp/link/mmu/pathway"...
## Reading KEGG annotation online: "https://rest.kegg.jp/list/pathway/mmu"...
as_tibble(keggRes)
## # A tibble: 74 × 14
## category subcategory ID Description GeneRatio BgRatio RichFactor
## <chr> <chr> <chr> <chr> <chr> <chr> <dbl>
## 1 Organismal Systems Immune sys… mmu0… Antigen pr… 39/347 87/9793 0.448
## 2 Human Diseases Infectious… mmu0… Epstein-Ba… 55/347 228/97… 0.241
## 3 Human Diseases Immune dis… mmu0… Graft-vers… 31/347 60/9793 0.517
## 4 Human Diseases Endocrine … mmu0… Type I dia… 32/347 67/9793 0.478
## 5 Human Diseases Immune dis… mmu0… Allograft … 30/347 60/9793 0.5
## 6 Cellular Processes Transport … mmu0… Phagosome … 47/347 183/97… 0.257
## 7 Human Diseases Infectious… mmu0… Influenza … 45/347 174/97… 0.259
## 8 Environmental Inf… Signaling … mmu0… Cell adhes… 44/347 179/97… 0.246
## 9 Human Diseases Infectious… mmu0… Leishmania… 28/347 70/9793 0.4
## 10 Human Diseases Cardiovasc… mmu0… Viral myoc… 31/347 94/9793 0.330
## # ℹ 64 more rows
## # ℹ 7 more variables: FoldEnrichment <dbl>, zScore <dbl>, pvalue <dbl>,
## # p.adjust <dbl>, qvalue <dbl>, geneID <chr>, Count <int>
clusterProfiler
has a function browseKegg
to view the KEGG pathway in a browser, highlighting the genes we selected as differentially expressed.
We will show one of the top hits: pathway ‘mmu04612’ for ‘Antigen processing and presentation’.
browseKEGG(keggRes, "mmu04612")
The package pathview
(Luo et al. 2013) can be used to generate figures of KEGG pathways.
One advantage over the clusterProfiler
browser method browseKEGG
is that genes can be coloured according to fold change levels in our data. To do this we need to pass pathview
a named vector of fold change values (one could in fact colour by any numeric vector, e.g. p-value).
The package plots the KEGG pathway to a png
file in the working directory.
library(pathview)
logFC <- shrink.d11$logFC
names(logFC) <- shrink.d11$Entrez
pathview(gene.data = logFC,
pathway.id = "mmu04612",
species = "mmu",
limit = list(gene = 20, cpd = 1))
mmu04612.pathview.png:
clusterProfiler
can also perform over-representation analysis on GO terms using the command enrichGO
. For this analysis we will use Ensembl gene IDs instead of Entrez IDs and in order to do this we need to load another package which contains the mouse database called org.Mm.eg.db
.
To run the GO enrichment analysis, this time we also need a couple of extra things. Firstly, we should provide a list of the ‘universe’ of all the genes in our DE analysis not just the ones we have selected as significant.
Gene Ontology terms are divided into 3 categories. - Metabolic Functions - Biological Processes - Cellular Components
For this analysis we will narrow our search terms in the ‘Biological Processes’ Ontology so we can add the parameter “BP” with the ‘ont’ argument (the default is Molecular Functions).
library(org.Mm.eg.db)
sigGenes_GO <- shrink.d11 %>%
drop_na(FDR) %>%
filter(FDR < 0.01 & abs(logFC) > 2) %>%
pull(GeneID)
universe <- shrink.d11$GeneID
ego <- enrichGO(gene = sigGenes_GO,
universe = universe,
OrgDb = org.Mm.eg.db,
keyType = "ENSEMBL",
ont = "BP",
pvalueCutoff = 0.01,
readable = TRUE)
We can use the barplot
function to visualise the results. Count is the number of differentially expressed in each gene ontology term.
barplot(ego, showCategory = 20)
or perhaps the dotplot
version is more informative. Gene ratio is Count divided by the number of genes in that GO term.
dotplot(ego, font.size = 14)
Another visualisation that can be nice to try is the emapplot
which shows the overlap between genes in the different GO terms.
library(enrichplot)
ego_pt <- pairwise_termsim(ego)
emapplot(ego_pt, cex_label_category = 0.5)
## Warning in emapplot.enrichResult(x, showCategory = showCategory, ...): Use 'cex.params = list(category_label = your_value)' instead of 'cex_label_category'.
## The cex_label_category parameter will be removed in the next version.
Gene Set Enrichment Analysis (GSEA) identifies gene sets that are enriched in the dataset between samples (Subramanian et al. 2005).
The software is distributed by the Broad Institute and is freely available for use by academic and non-profit organisations. The Broad also provide a number of very well curated gene sets for testing against your data - the Molecular Signatures Database (MSigDB).
These gene lists are made availalble for R in the Bioconductor package msigdb
and the available dataset can be explored via ExperimentHub
.
First, we need to locate the correct database and download the data.
library(msigdb)
library(ExperimentHub)
## Loading required package: AnnotationHub
## Loading required package: BiocFileCache
## Loading required package: dbplyr
##
## Attaching package: 'dbplyr'
## The following objects are masked from 'package:dplyr':
##
## ident, sql
##
## Attaching package: 'AnnotationHub'
## The following object is masked from 'package:Biobase':
##
## cache
eh <- ExperimentHub()
query(eh, c("msigdb", "mm", "2023"))
## ExperimentHub with 10 records
## # snapshotDate(): 2024-04-29
## # $dataprovider: Broad Institute, EBI
## # $species: Mus musculus, Homo sapiens
## # $rdataclass: GSEABase::GeneSetCollection, data.frame
## # additional mcols(): taxonomyid, genome, description,
## # coordinate_1_based, maintainer, rdatadateadded, preparerclass, tags,
## # rdatapath, sourceurl, sourcetype
## # retrieve records with, e.g., 'object[["EH8285"]]'
##
## title
## EH8285 | msigdb.v2022.1.mm.EZID
## EH8286 | msigdb.v2022.1.mm.idf
## EH8287 | msigdb.v2022.1.mm.SYM
## EH8291 | msigdb.v2023.1.mm.EZID
## EH8292 | msigdb.v2023.1.mm.idf
## EH8293 | msigdb.v2023.1.mm.SYM
## EH8297 | msigdb.v7.5.1.mm.EZID
## EH8298 | msigdb.v7.5.1.mm.idf
## EH8299 | msigdb.v7.5.1.mm.SYM
## EH8300 | imex_hsmm_0722
The most recent available release of MSigDb is “msigdb.v2023.1”, so we’ll download this one. We have the option to use Entrez IDs or gene symbols. As we already have Entrez IDs in our annotation, we’ll use these.
msigdb.mm <- getMsigdb(org = "mm", id = "EZID", version = "2023.1")
## see ?msigdb and browseVignettes('msigdb') for documentation
## loading from cache
## require("GSEABase")
msigdb.mm
## GeneSetCollection
## names: 10qA1, 10qA2, ..., ZZZ3_TARGET_GENES (45953 total)
## unique identifiers: 13853, 13982, ..., 115489304 (56211 total)
## types in collection:
## geneIdType: EntrezIdentifier (1 total)
## collectionType: BroadCollection (1 total)
listCollections(msigdb.mm)
## [1] "c1" "c3" "c2" "c8" "c6" "c7" "c4" "c5" "h"
The analysis is performed by:
The article describing the original software is available here, while this commentary on GSEA provides a shorter description.
We will use clusterProfiler
’s GSEA
package (Yu et al. 2012) that implements the same algorithm in R.
We need to provide GSEA
with a vector containing values for a given gene mtric, e.g. log(fold change), sorted in decreasing order.
To start with we will simply use a rank the genes based on their fold change.
We must exclude genes with no Entrez ID.
Also, we should use the shrunk LFC values.
rankedGenes <- shrink.d11 %>%
drop_na(GeneID, FDR, logFC, Entrez) %>%
mutate(rank = logFC) %>%
arrange(desc(rank)) %>%
pull(rank, Entrez)
head(rankedGenes)
## 15945 24108 626578 20210 17329 64380
## 8.437974 8.305865 7.818294 7.783899 7.782181 7.525202
For clusterProfiler
we need the genes and genesets to be in the form of is a tibble
with information on each {gene set; gene} pair in the rows.
hallmarks <- subsetCollection(msigdb.mm, "h")
msigdb_ids <- geneIds(hallmarks)
term2gene <- enframe(msigdb_ids, name = "gs_name", value = "entrez") %>%
unnest(entrez)
head(term2gene)
## # A tibble: 6 × 2
## gs_name entrez
## <chr> <chr>
## 1 HALLMARK_ADIPOGENESIS 11303
## 2 HALLMARK_ADIPOGENESIS 11304
## 3 HALLMARK_ADIPOGENESIS 27403
## 4 HALLMARK_ADIPOGENESIS 268379
## 5 HALLMARK_ADIPOGENESIS 74591
## 6 HALLMARK_ADIPOGENESIS 381072
Arguments passed to GSEA
include:
gseaRes <- GSEA(rankedGenes,
TERM2GENE = term2gene,
pvalueCutoff = 1.00,
minGSSize = 15,
maxGSSize = 500)
## using 'fgsea' for GSEA analysis, please cite Korotkevich et al (2019).
## preparing geneSet collections...
## GSEA analysis...
## leading edge analysis...
## done...
Let’s look at the top 10 results.
as_tibble(gseaRes) %>%
arrange(desc(abs(NES))) %>%
top_n(10, wt = -p.adjust) %>%
dplyr::select(-core_enrichment) %>%
mutate(across(c("enrichmentScore", "NES"), ~round(.x, digits = 3))) %>%
mutate(across(c("pvalue", "p.adjust", "qvalue"), scales::scientific))
The enrichment score plot displays along the x-axis that represents the decreasing gene rank:
gseaplot(gseaRes,
geneSetID = "HALLMARK_INFLAMMATORY_RESPONSE",
title = "HALLMARK_INFLAMMATORY_RESPONSE")
Remember to check the GSEA article for the complete explanation.