License: GPL (>= 2)
GSVA is an R package distributed as part of the Bioconductor project. To install the package, start R and enter:
Once GSVA is installed, it can be loaded with the following command.
Given a gene expression data matrix, which we shall call
X
, with rows corresponding to genes and columns to samples,
such as this one simulated from random Gaussian data:
p <- 10000 ## number of genes
n <- 30 ## number of samples
## simulate expression values from a standard Gaussian distribution
X <- matrix(rnorm(p*n), nrow=p,
dimnames=list(paste0("g", 1:p), paste0("s", 1:n)))
X[1:5, 1:5]
s1 s2 s3 s4 s5
g1 0.01308661 0.85211170 -1.00735853 1.1766833 -0.5099661
g2 0.04753665 -0.16001417 -0.47464918 -0.4480376 0.3556070
g3 -0.75590974 0.20851109 2.78837824 -1.6987920 -2.4370575
g4 1.62094562 -0.05754292 -0.08663623 -2.2887241 -0.3172562
g5 -0.13225026 -0.35256507 -0.27497467 -2.2245925 0.2457407
Given a collection of gene sets stored, for instance, in a
list
object, which we shall call gs
, with
genes sampled uniformly at random without replacement into 100 different
gene sets:
## sample gene set sizes
gs <- as.list(sample(10:100, size=100, replace=TRUE))
## sample gene sets
gs <- lapply(gs, function(n, p)
paste0("g", sample(1:p, size=n, replace=FALSE)), p)
names(gs) <- paste0("gs", 1:length(gs))
We can calculate GSVA enrichment scores as follows. First we should
build a parameter object for the desired methodology. Here we illustrate
it with the GSVA algorithm of Hänzelmann,
Castelo, and Guinney (2013) by calling the function
gsvaParam()
, but other parameter object constructor
functions are available; see in the next section below.
gsvaPar <- gsvaParam(X, gs)
gsvaPar
A GSVA::gsvaParam object
expression data:
matrix [10000, 30]
rows: g1, g2, ..., g10000 (10000 total)
cols: s1, s2, ..., s30 (30 total)
using assay: none
using annotation:
geneIdType: Null
gene sets:
list
names: gs1, gs2, ..., gs100 (100 total)
unique identifiers: g6043, g5658, ..., g9708 (4299 total)
gene set size: [1, Inf]
kcdf: auto
kcdfNoneMinSampleSize: 200
tau: 1
maxDiff: TRUE
absRanking: FALSE
checkNA: auto
missing data: no
The first argument to the gsvaParam()
function
constructing this parameter object is the gene expression data matrix,
and the second is the collection of gene sets. In this example, we
provide expression data and gene sets into base R matrix and
list objects, respectively, to the gsvaParam()
function, but it can take also different specialized containers that
facilitate the access and manipulation of molecular and phenotype data,
as well as their associated metadata.
Second, we call the gsva()
function with the parameter
object as first argument. Other additional arguments to the
gsva()
function are verbose
to control
progress reporting and BPPPARAM
to perform calculations in
parallel through the package BiocParallel.
gsva.es <- gsva(gsvaPar, verbose=FALSE)
dim(gsva.es)
[1] 100 30
gsva.es[1:5, 1:5]
s1 s2 s3 s4 s5
gs1 -0.09294423 0.05910505 0.16189404 -0.022423079 -0.03850436
gs2 0.29442952 -0.04944476 -0.03226705 0.156321459 0.02425620
gs3 -0.01564699 -0.07850748 0.10760749 -0.060584258 0.13343523
gs4 0.11693608 0.02191545 -0.04044286 0.009954378 0.18269889
gs5 -0.07686307 -0.12261854 -0.10532509 0.119988332 0.05135062
Gene set variation analysis (GSVA) provides an estimate of pathway activity by transforming an input gene-by-sample expression data matrix into a corresponding gene-set-by-sample expression data matrix. This resulting expression data matrix can be then used with classical analytical methods such as differential expression, classification, survival analysis, clustering or correlation analysis in a pathway-centric manner. One can also perform sample-wise comparisons between pathways and other molecular data types such as microRNA expression or binding data, copy-number variation (CNV) data or single nucleotide polymorphisms (SNPs).
The GSVA package provides an implementation of this approach for the following methods:
plage (Tomfohr, Lu, and Kepler 2005). Pathway level analysis of gene expression (PLAGE) standardizes expression profiles over the samples and then, for each gene set, it performs a singular value decomposition (SVD) over its genes. The coefficients of the first right-singular vector are returned as the estimates of pathway activity over the samples. Note that, because of how SVD is calculated, the sign of its singular vectors is arbitrary.
zscore (Lee et al. 2008). The z-score method standardizes expression profiles over the samples and then, for each gene set, combines the standardized values as follows. Given a gene set γ = {1, …, k} with standardized values z1, …, zk for each gene in a specific sample, the combined z-score Zγ for the gene set γ is defined as: $$ Z_\gamma = \frac{\sum_{i=1}^k z_i}{\sqrt{k}}\,. $$
ssgsea (Barbie et al.
2009). Single sample GSEA (ssGSEA) is a non-parametric method
that calculates a gene set enrichment score per sample as the normalized
difference in empirical cumulative distribution functions (CDFs) of gene
expression ranks inside and outside the gene set. By default, the
implementation in the GSVA package follows the last step described in
(Barbie et al. 2009, online methods, pg.
2) by which pathway scores are normalized, dividing them by the
range of calculated values. This normalization step may be switched off
using the argument ssgsea.norm
in the call to the
gsva()
function; see below.
gsva (Hänzelmann, Castelo, and Guinney 2013). This is the default method of the package and similarly to ssGSEA, is a non-parametric method that uses the empirical CDFs of gene expression ranks inside and outside the gene set, but it starts by calculating an expression-level statistic that brings gene expression profiles with different dynamic ranges to a common scale.
The interested user may find full technical details about how these methods work in their corresponding articles cited above. If you use any of them in a publication, please cite them with the given bibliographic reference.
The workhorse of the GSVA package is the function
gsva()
, which takes a parameter object as its main
input. There are four classes of parameter objects corresponding to the
methods listed above, and may have different additional parameters to
tune, but all of them require at least the following two input
arguments:
matrix
of expression values with genes corresponding
to rows and samples corresponding to columns.ExpressionSet
object; see package Biobase.SummarizedExperiment
object, see package SummarizedExperiment.list
object where each element corresponds to a gene
set defined by a vector of gene identifiers, and the element names
correspond to the names of the gene sets.GeneSetCollection
object; see package GSEABase.One advantage of providing the input data using specialized
containers such as ExpressionSet
,
SummarizedExperiment
and GeneSetCollection
is
that the gsva()
function will automatically map the gene
identifiers between the expression data and the gene sets (internally
calling the function mapIdentifiers()
from the package
GSEABase),
when they come from different standard nomenclatures, i.e.,
Ensembl versus Entrez, provided the input objects
contain the appropriate metadata; see next section.
If either the input gene expression data is provided as a
matrix
object or the gene sets are provided in a
list
object, or both, it is then the responsibility of the
user to ensure that both objects contain gene identifiers following the
same standard nomenclature.
Before the actual calculations take place, the gsva()
function will apply the following filters:
Discard genes in the input expression data matrix with constant expression.
Discard genes in the input gene sets that do not map to a gene in the input gene expression data matrix.
Discard gene sets that, after applying the previous filters, do not meet a minimum and maximum size, which by default is one for the minimum size and has no limit for the maximum size.
If, as a result of applying these three filters, either no genes or
gene sets are left, the gsva()
function will prompt an
error. A common cause for such an error at this stage is that gene
identifiers between the expression data matrix and the gene sets do not
belong to the same standard nomenclature and could not be mapped. This
may happen because either the input data were not provided using some of
the specialized containers described above or the necessary metadata in
those containers that allows the software to successfully map gene
identifiers, is missing.
The method employed by the gsva()
function is determined
by the class of the parameter object that it receives as an input. An
object constructed using the gsvaParam()
function runs the
method described by Hänzelmann, Castelo, and
Guinney (2013), but this can be changed using the parameter
constructor functions plageParam()
,
zscoreParam()
, or ssgseaParam()
, corresponding
to the methods briefly described in the introduction; see also their
corresponding help pages.
When using gsvaParam()
, the user can additionally tune
the following parameters, whose default values cover most of the use
cases:
kcdf
: The first step of the GSVA algorithm brings
gene expression profiles to a common scale by calculating an expression
statistic through the estimation of the CDF across samples. The way in
which such an estimation is performed by GSVA is controlled by the
kcdf
parameter, which accepts the following four possible
values: (1) "auto"
, the default value, lets GSVA
automatically decide the estimation method; (2) "Gaussian"
,
use a Gaussian kernel, suitable for continuous expression data, such as
microarray fluorescent units in logarithmic scale and RNA-seq log-CPMs,
log-RPKMs or log-TPMs units of expression; (2) "Poisson"
,
use a Poisson kernel, suitable for integer counts, such as those derived
from RNA-seq alignments; (3) "none"
, which will perform a
direct estimation of the CDF without a kernel function.
kcdfNoneMinSampleSize
: When
kcdf="auto"
, this parameter decides at what minimum sample
size kcdf="none"
, i.e., the estimation of the empirical
cumulative distribution function (ECDF) of expression levels across
samples is performed directly without using a kernel; see the previous
kcdf
parameter.
tau
: Exponent defining the weight of the tail in the
random walk. By default tau=1
.
maxDiff
: The last step of the GSVA algorithm
calculates the gene set enrichment score from two Kolmogorov-Smirnov
random walk statistics. This parameter is a logical flag that allows the
user to specify two possible ways to do such calculation: (1)
TRUE
, the default value, where the enrichment score is
calculated as the magnitude difference between the largest positive and
negative random walk deviations. This default value gives larger
enrichment scores to gene sets whose genes are concordantly activated in
one direction only; (2) FALSE
, where the enrichment score
is calculated as the maximum distance of the random walk from zero. This
approach produces a distribution of enrichment scores that is bimodal,
but it can be give large enrichment scores to gene sets whose genes are
not concordantly activated in one direction only.
absRanking
: Logical flag used only when
maxDiff=TRUE
. By default, absRanking=FALSE
and
it implies that a modified Kuiper statistic is used to calculate
enrichment scores, taking the magnitude difference between the largest
positive and negative random walk deviations. When
absRanking=TRUE
the original Kuiper statistic is used, by
which the largest positive and negative random walk deviations are added
together.
sparse
: Logical flag used only when the input
expression data is stored in a sparse matrix (e.g., a
dgCMatrix
or a SingleCellExperiment
object
storing the expression data in a dgCMatrix
). In such as
case, when sparse=TRUE
(default), a sparse version of the
GSVA algorithm will be applied. Otherwise, when
sparse=FALSE
, the classical version of the GSVA algorithm
will be used.
In general, the default values for the previous parameters are suitable for most analysis settings, which usually consist of some kind of normalized continuous expression values.
Gene sets constitute a simple, yet useful, way to define pathways because we use pathway membership definitions only, neglecting the information on molecular interactions. Gene set definitions are a crucial input to any gene set enrichment analysis because if our gene sets do not capture the biological processes we are studying, we will likely not find any relevant insights in our data from an analysis based on these gene sets.
There are multiple sources of gene sets, the most popular ones being The Gene Ontology (GO) project and The Molecular Signatures Database (MSigDB). Sometimes gene set databases will not include the ones we need. In such a case we should either curate our own gene sets or use techniques to infer them from data.
The most basic data container for gene sets in R is the
list
class of objects, as illustrated before in the quick
start section, where we defined a toy collection of three gene sets
stored in a list object called gs
:
class(gs)
[1] "list"
length(gs)
[1] 100
head(lapply(gs, head))
$gs1
[1] "g6043" "g5658" "g8135" "g1510" "g8380" "g9042"
$gs2
[1] "g8249" "g6215" "g8619" "g4282" "g5613" "g6444"
$gs3
[1] "g5114" "g5672" "g9593" "g3609" "g7954" "g152"
$gs4
[1] "g2391" "g4438" "g256" "g892" "g4551" "g6694"
$gs5
[1] "g7355" "g9553" "g5164" "g6422" "g8175" "g8010"
$gs6
[1] "g799" "g4124" "g1448" "g3596" "g3127" "g514"
Using a Bioconductor organism-level package such as org.Hs.eg.db we can easily build a list object containing a collection of gene sets defined as GO terms with annotated Entrez gene identifiers, as follows:
library(org.Hs.eg.db)
goannot <- select(org.Hs.eg.db, keys=keys(org.Hs.eg.db), columns="GO")
head(goannot)
ENTREZID GO EVIDENCE ONTOLOGY
1 1 GO:0002764 IBA BP
2 1 GO:0003674 ND MF
3 1 GO:0005576 HDA CC
4 1 GO:0005576 IDA CC
5 1 GO:0005576 TAS CC
6 1 GO:0005615 HDA CC
genesbygo <- split(goannot$ENTREZID, goannot$GO)
length(genesbygo)
[1] 18678
head(genesbygo)
$`GO:0000002`
[1] "291" "1890" "4205" "4358" "4976" "9361" "10000" "55186" "55186"
[10] "80119" "84275" "84275" "92667"
$`GO:0000009`
[1] "55650" "79087"
$`GO:0000012`
[1] "1161" "2074" "3981" "7141" "7374" "7515"
[7] "23411" "54840" "54840" "54840" "55247" "55775"
[13] "55775" "200558" "100133315"
$`GO:0000014`
[1] "2021" "2067" "2072" "4361" "4361" "5932" "6419" "6419" "6419"
[10] "9941" "10111" "28990" "64421"
$`GO:0000015`
[1] "2023" "2023" "2026" "2027" "387712"
$`GO:0000016`
[1] "3938" "3938" "3938"
A more sophisticated container for gene sets is the
GeneSetCollection
object class defined in the GSEABase
package, which also provides the function getGmt()
to
import gene
matrix transposed (GMT) files such as those provided by MSigDB into a
GeneSetCollection
object. The experiment data package
GSVAdata
provides one such object with the old (3.0) version of the C2 collection
of curated genesets from MSigDB, which can be
loaded as follows.
library(GSEABase)
library(GSVAdata)
data(c2BroadSets)
class(c2BroadSets)
[1] "GeneSetCollection"
attr(,"package")
[1] "GSEABase"
c2BroadSets
GeneSetCollection
names: NAKAMURA_CANCER_MICROENVIRONMENT_UP, NAKAMURA_CANCER_MICROENVIRONMENT_DN, ..., ST_PHOSPHOINOSITIDE_3_KINASE_PATHWAY (3272 total)
unique identifiers: 5167, 100288400, ..., 57191 (29340 total)
types in collection:
geneIdType: EntrezIdentifier (1 total)
collectionType: BroadCollection (1 total)
The documentation of GSEABase
contains a description of the GeneSetCollection
class and
its associated methods.
Here we illustrate how GSVA provides an analogous quantification of pathway activity in both microarray and RNA-seq data by using two such datasets that have been derived from the same biological samples. More concretely, we will use gene expression data of lymphoblastoid cell lines (LCL) from HapMap individuals that have been profiled using both technologies Pickrell et al. (2010). These data form part of the experimental package GSVAdata and the corresponding help pages contain details on how the data were processed. We start loading these data and verifying that they indeed contain expression data for the same genes and samples, as follows:
library(Biobase)
data(commonPickrellHuang)
stopifnot(identical(featureNames(huangArrayRMAnoBatchCommon_eset),
featureNames(pickrellCountsArgonneCQNcommon_eset)))
stopifnot(identical(sampleNames(huangArrayRMAnoBatchCommon_eset),
sampleNames(pickrellCountsArgonneCQNcommon_eset)))
Next, for the current analysis we use the subset of canonical pathways from the C2 collection of MSigDB Gene Sets. These correspond to the following pathways from KEGG, REACTOME and BIOCARTA:
canonicalC2BroadSets <- c2BroadSets[c(grep("^KEGG", names(c2BroadSets)),
grep("^REACTOME", names(c2BroadSets)),
grep("^BIOCARTA", names(c2BroadSets)))]
canonicalC2BroadSets
GeneSetCollection
names: KEGG_GLYCOLYSIS_GLUCONEOGENESIS, KEGG_CITRATE_CYCLE_TCA_CYCLE, ..., BIOCARTA_ACTINY_PATHWAY (833 total)
unique identifiers: 55902, 2645, ..., 8544 (6744 total)
types in collection:
geneIdType: EntrezIdentifier (1 total)
collectionType: BroadCollection (1 total)
Additionally, we extend this collection of gene sets with two formed
by genes with sex-specific expression, which also form part of the
GSVAdata
experiment data package. Here we use the constructor function
GeneSet
from the GSEABase
package to build the objects that we add to the
GeneSetCollection
object
canonicalC2BroadSets
.
data(genderGenesEntrez)
MSY <- GeneSet(msYgenesEntrez, geneIdType=EntrezIdentifier(),
collectionType=BroadCollection(category="c2"),
setName="MSY")
MSY
setName: MSY
geneIds: 266, 84663, ..., 353513 (total: 34)
geneIdType: EntrezId
collectionType: Broad
bcCategory: c2 (Curated)
bcSubCategory: NA
details: use 'details(object)'
XiE <- GeneSet(XiEgenesEntrez, geneIdType=EntrezIdentifier(),
collectionType=BroadCollection(category="c2"),
setName="XiE")
XiE
setName: XiE
geneIds: 293, 8623, ..., 1121 (total: 66)
geneIdType: EntrezId
collectionType: Broad
bcCategory: c2 (Curated)
bcSubCategory: NA
details: use 'details(object)'
canonicalC2BroadSets <- GeneSetCollection(c(canonicalC2BroadSets, MSY, XiE))
canonicalC2BroadSets
GeneSetCollection
names: KEGG_GLYCOLYSIS_GLUCONEOGENESIS, KEGG_CITRATE_CYCLE_TCA_CYCLE, ..., XiE (835 total)
unique identifiers: 55902, 2645, ..., 1121 (6810 total)
types in collection:
geneIdType: EntrezIdentifier (1 total)
collectionType: BroadCollection (1 total)
We calculate now GSVA enrichment scores for these gene sets using
first the normalized microarray data and then the normalized RNA-seq
integer count data. Note that the only requirement to do the latter is
to set the argument kcdf="Poisson"
, which is
"Gaussian"
by default. Note, however, that if our RNA-seq
normalized expression levels would be continuous, such as log-CPMs,
log-RPKMs or log-TPMs, the default value of the kcdf
argument should remain unchanged.
huangPar <- gsvaParam(huangArrayRMAnoBatchCommon_eset, canonicalC2BroadSets,
minSize=5, maxSize=500)
esmicro <- gsva(huangPar)
pickrellPar <- gsvaParam(pickrellCountsArgonneCQNcommon_eset,
canonicalC2BroadSets, minSize=5, maxSize=500,
kcdf="Poisson")
esrnaseq <- gsva(pickrellPar)
We are going to assess how gene expression profiles correlate between
microarray and RNA-seq data and compare those correlations with the ones
derived at pathway level. To compare gene expression values of both
technologies, we will transform first the RNA-seq integer counts into
log-CPM units of expression using the cpm()
function from
the edgeR
package.
We calculate Spearman correlations between gene expression profiles of the previous log-CPM values and the microarray RMA values.
genecorrs <- sapply(1:nrow(lcpms),
function(i, expmicro, exprnaseq)
cor(expmicro[i, ], exprnaseq[i, ], method="spearman"),
exprs(huangArrayRMAnoBatchCommon_eset), lcpms)
names(genecorrs) <- rownames(lcpms)
Now calculate Spearman correlations between GSVA enrichment scores derived from the microarray and the RNA-seq data.
pwycorrs <- sapply(1:nrow(esmicro),
function(i, esmicro, esrnaseq)
cor(esmicro[i, ], esrnaseq[i, ], method="spearman"),
exprs(esmicro), exprs(esrnaseq))
names(pwycorrs) <- rownames(esmicro)
Figure @ref(fig:compcorrs) below shows the two distributions of these correlations and we can see that GSVA enrichment scores provide an agreement between microarray and RNA-seq data comparable to the one observed between gene-level units of expression.
par(mfrow=c(1, 2), mar=c(4, 5, 3, 2))
hist(genecorrs, xlab="Spearman correlation",
main="Gene level\n(RNA-seq log-CPMs vs microarray RMA)",
xlim=c(-1, 1), col="grey", las=1)
hist(pwycorrs, xlab="Spearman correlation",
main="Pathway level\n(GSVA enrichment scores)",
xlim=c(-1, 1), col="grey", las=1)
Finally, in Figure @ref(fig:compsexgenesets) we compare the actual GSVA enrichment scores for two gene sets formed by genes with sex-specific expression. Concretely, one gene set (XIE) formed by genes that escape chromosome X-inactivation in females (Carrel and Willard 2005) and another gene set (MSY) formed by genes located on the male-specific region of chromosome Y (Skaletsky et al. 2003).
par(mfrow=c(1, 2))
rmsy <- cor(exprs(esrnaseq)["MSY", ], exprs(esmicro)["MSY", ])
plot(exprs(esrnaseq)["MSY", ], exprs(esmicro)["MSY", ],
xlab="GSVA scores RNA-seq", ylab="GSVA scores microarray",
main=sprintf("MSY R=%.2f", rmsy), las=1, type="n")
fit <- lm(exprs(esmicro)["MSY", ] ~ exprs(esrnaseq)["MSY", ])
abline(fit, lwd=2, lty=2, col="grey")
maskPickrellFemale <- pickrellCountsArgonneCQNcommon_eset$Gender == "Female"
maskHuangFemale <- huangArrayRMAnoBatchCommon_eset$Gender == "Female"
points(exprs(esrnaseq["MSY", maskPickrellFemale]),
exprs(esmicro)["MSY", maskHuangFemale],
col="red", pch=21, bg="red", cex=1)
maskPickrellMale <- pickrellCountsArgonneCQNcommon_eset$Gender == "Male"
maskHuangMale <- huangArrayRMAnoBatchCommon_eset$Gender == "Male"
points(exprs(esrnaseq)["MSY", maskPickrellMale],
exprs(esmicro)["MSY", maskHuangMale],
col="blue", pch=21, bg="blue", cex=1)
legend("topleft", c("female", "male"), pch=21, col=c("red", "blue"),
pt.bg=c("red", "blue"), inset=0.01)
rxie <- cor(exprs(esrnaseq)["XiE", ], exprs(esmicro)["XiE", ])
plot(exprs(esrnaseq)["XiE", ], exprs(esmicro)["XiE", ],
xlab="GSVA scores RNA-seq", ylab="GSVA scores microarray",
main=sprintf("XiE R=%.2f", rxie), las=1, type="n")
fit <- lm(exprs(esmicro)["XiE", ] ~ exprs(esrnaseq)["XiE", ])
abline(fit, lwd=2, lty=2, col="grey")
points(exprs(esrnaseq["XiE", maskPickrellFemale]),
exprs(esmicro)["XiE", maskHuangFemale],
col="red", pch=21, bg="red", cex=1)
points(exprs(esrnaseq)["XiE", maskPickrellMale],
exprs(esmicro)["XiE", maskHuangMale],
col="blue", pch=21, bg="blue", cex=1)
legend("topleft", c("female", "male"), pch=21, col=c("red", "blue"),
pt.bg=c("red", "blue"), inset=0.01)
We can see how microarray and RNA-seq single-sample GSVA enrichment scores correlate very well in these gene sets, with ρ = 0.80 for the male-specific gene set and ρ = 0.79 for the female-specific gene set. Male and female samples show higher GSVA enrichment scores in their corresponding gene set.
In (Verhaak et al. 2010) four subtypes of glioblastoma multiforme (GBM) -proneural, classical, neural and mesenchymal- were identified by the characterization of distinct gene-level expression patterns. Using four gene set signatures specific to brain cell types (astrocytes, oligodendrocytes, neurons and cultured astroglial cells), derived from murine models by Cahoy et al. (2008), we replicate the analysis of Verhaak et al. (2010) by using GSVA to transform the gene expression measurements into enrichment scores for these four gene sets, without taking the sample subtype grouping into account. We start by having a quick glance to the data, which forms part of the GSVAdata package:
data(gbm_VerhaakEtAl)
gbm_eset
ExpressionSet (storageMode: lockedEnvironment)
assayData: 11861 features, 173 samples
element names: exprs
protocolData: none
phenoData
rowNames: TCGA.02.0003.01A.01 TCGA.02.0010.01A.01 ...
TCGA.12.0620.01A.01 (173 total)
varLabels: subtype
varMetadata: labelDescription channel
featureData: none
experimentData: use 'experimentData(object)'
Annotation:
head(featureNames(gbm_eset))
[1] "AACS" "FSTL1" "ELMO2" "CREB3L1" "RPS11" "PNMA1"
table(gbm_eset$subtype)
Classical Mesenchymal Neural Proneural
38 56 26 53
data(brainTxDbSets)
lengths(brainTxDbSets)
astrocytic_up astroglia_up neuronal_up oligodendrocytic_up
85 88 98 70
lapply(brainTxDbSets, head)
$astrocytic_up
[1] "GRHL1" "GPAM" "PAPSS2" "MERTK" "BTG1" "SLC46A1"
$astroglia_up
[1] "BST2" "SERPING1" "ACTA2" "C9orf167" "C1orf31" "ANXA4"
$neuronal_up
[1] "STXBP1" "JPH4" "CACNG3" "BRUNOL6" "CLSTN2" "FAM123C"
$oligodendrocytic_up
[1] "DCT" "ZNF536" "GNG8" "ELOVL6" "NR2C1" "RCBTB1"
GSVA enrichment scores for the gene sets contained in
brainTxDbSets
are calculated, in this case using
mx.diff=FALSE
, as follows:
Figure @ref(fig:gbmSignature) shows the GSVA enrichment scores obtained for the up-regulated gene sets across the samples of the four GBM subtypes. As expected, the neural class is associated with the neural gene set and the astrocytic gene sets. The mesenchymal subtype is characterized by the expression of mesenchymal and microglial markers, thus we expect it to correlate with the astroglial gene set. The proneural subtype shows high expression of oligodendrocytic development genes, thus it is not surprising that the oligodendrocytic gene set is highly enriched for ths group. Interestingly, the classical group correlates highly with the astrocytic gene set. In summary, the resulting GSVA enrichment scores recapitulate accurately the molecular signatures from Verhaak et al. (2010).
library(RColorBrewer)
subtypeOrder <- c("Proneural", "Neural", "Classical", "Mesenchymal")
sampleOrderBySubtype <- sort(match(gbm_es$subtype, subtypeOrder),
index.return=TRUE)$ix
subtypeXtable <- table(gbm_es$subtype)
subtypeColorLegend <- c(Proneural="red", Neural="green",
Classical="blue", Mesenchymal="orange")
geneSetOrder <- c("astroglia_up", "astrocytic_up", "neuronal_up",
"oligodendrocytic_up")
geneSetLabels <- gsub("_", " ", geneSetOrder)
hmcol <- colorRampPalette(brewer.pal(10, "RdBu"))(256)
hmcol <- hmcol[length(hmcol):1]
heatmap(exprs(gbm_es)[geneSetOrder, sampleOrderBySubtype], Rowv=NA,
Colv=NA, scale="row", margins=c(3,5), col=hmcol,
ColSideColors=rep(subtypeColorLegend[subtypeOrder],
times=subtypeXtable[subtypeOrder]),
labCol="", gbm_es$subtype[sampleOrderBySubtype],
labRow=paste(toupper(substring(geneSetLabels, 1,1)),
substring(geneSetLabels, 2), sep=""),
cexRow=2, main=" \n ")
par(xpd=TRUE)
text(0.23,1.21, "Proneural", col="red", cex=1.2)
text(0.36,1.21, "Neural", col="green", cex=1.2)
text(0.47,1.21, "Classical", col="blue", cex=1.2)
text(0.62,1.21, "Mesenchymal", col="orange", cex=1.2)
mtext("Gene sets", side=4, line=0, cex=1.5)
mtext("Samples ", side=1, line=4, cex=1.5)
We illustrate here how to conduct a differential expression analysis
at pathway level. We will use an example gene expression microarray data
from Armstrong et al. (2002), which
consists of 37 different individuals with human acute leukemia, where 20
of them have conventional childhood acute lymphoblastic leukemia (ALL)
and the other 17 are affected with the MLL (mixed-lineage leukemia gene)
translocation. This leukemia data set is stored as an
ExpressionSet
object called leukemia
in the
GSVAdata
package and and details on how the data was pre-processed can be found
in the corresponding help page. Jointly with the RMA expression values,
we provide some metadata including the main phenotype corresponding to
the leukemia sample subtype.
data(leukemia)
leukemia_eset
ExpressionSet (storageMode: lockedEnvironment)
assayData: 12626 features, 37 samples
element names: exprs
protocolData
sampleNames: CL2001011101AA.CEL CL2001011102AA.CEL ...
CL2001011152AA.CEL (37 total)
varLabels: ScanDate
varMetadata: labelDescription
phenoData
sampleNames: CL2001011101AA.CEL CL2001011102AA.CEL ...
CL2001011152AA.CEL (37 total)
varLabels: subtype
varMetadata: labelDescription channel
featureData: none
experimentData: use 'experimentData(object)'
Annotation: hgu95a
Next, we calculate GSVA enrichment scores using a subset of gene sets from the MSigDB C2 collection that represent signatures of genetic and chemical perturbations (CGP), and setting the the minimum and maximum gene set size to 10 and 500 genes, respectively.
cgpC2BroadSets <- c2BroadSets[c(grep("_UP$", names(c2BroadSets)),
grep("_DN$", names(c2BroadSets)))]
cgpC2BroadSets
leukPar <- gsvaParam(leukemia_eset, cgpC2BroadSets,
minSize=10, maxSize=500)
leukemia_es <- gsva(leukPar)
The object returned by the function gsva()
is always of
the same class as the input object with the expression data. Therefore,
in this case, we obtain an ExpressionSet
object with
features corresponding to gene sets.
class(leukemia_es)
[1] "ExpressionSet"
attr(,"package")
[1] "Biobase"
leukemia_es
ExpressionSet (storageMode: lockedEnvironment)
assayData: 1305 features, 37 samples
element names: exprs
protocolData: none
phenoData
sampleNames: CL2001011101AA.CEL CL2001011102AA.CEL ...
CL2001011152AA.CEL (37 total)
varLabels: subtype
varMetadata: labelDescription channel
featureData: none
experimentData: use 'experimentData(object)'
Annotation:
head(featureNames(leukemia_es))
[1] "NAKAMURA_CANCER_MICROENVIRONMENT_UP"
[2] "WEST_ADRENOCORTICAL_TUMOR_MARKERS_UP"
[3] "WINTER_HYPOXIA_UP"
[4] "PYEON_HPV_POSITIVE_TUMORS_UP"
[5] "NAKAMURA_TUMOR_ZONE_PERIPHERAL_VS_CENTRAL_UP"
[6] "PICCALUGA_ANGIOIMMUNOBLASTIC_LYMPHOMA_UP"
We will perform now a differential expression analysis using limma (Smyth 2004) between the two different leukemia subtypes.
library(limma)
mod <- model.matrix(~ factor(leukemia_es$subtype))
colnames(mod) <- c("ALL", "MLLvsALL")
fit <- lmFit(leukemia_es, mod)
fit <- eBayes(fit)
res <- decideTests(fit, p.value=0.01)
summary(res)
ALL MLLvsALL
Down 0 21
NotSig 1305 1255
Up 0 29
As Figure @ref(fig:setsizebysigma) below shows, GSVA scores have higher precision for larger gene sets1.
gssizes <- geneSetSizes(leukemia_es)
plot(sqrt(gssizes), sqrt(fit$sigma), xlab="Sqrt(gene sets sizes)",
ylab="Sqrt(standard deviation)", las=1, pch=".", cex=3)
In such a setting, we can improve the analysis of differentially
expressed pathways by using the limma-trend approach (Phipson et al. 2016) setting the
trend
parameter in the call to the eBayes()
function to the vector of gene set sizes. The list of gene sets or a
vector of gene set sizes can be obtained from the GSVA scores container
using function geneSets()
or geneSetSizes()
and has been stored in gssizes
before.
fit <- eBayes(fit, trend=gssizes)
res <- decideTests(fit, p.value=0.01)
summary(res)
ALL MLLvsALL
Down 0 21
NotSig 1305 1256
Up 0 28
There are 49 MSigDB C2 differentially expressed pathways with FDR < 5%. Figure @ref(fig:leukemiavolcano) below shows a volcano plot of the expression changes.
tt <- topTable(fit, coef=2, n=Inf)
DEpwys <- rownames(tt)[tt$adj.P.Val <= 0.01]
plot(tt$logFC, -log10(tt$P.Value), pch=".", cex=4, col=grey(0.75),
main="", xlab="GSVA enrichment score difference", las=1,
ylab=expression(-log[10]~~Raw~P-value))
abline(h=-log10(max(tt$P.Value[tt$adj.P.Val <= 0.01])),
col=grey(0.5), lwd=1, lty=2)
points(tt$logFC[match(DEpwys, rownames(tt))],
-log10(tt$P.Value[match(DEpwys, rownames(tt))]),
pch=".", cex=5, col="darkred")
text(max(tt$logFC)*0.85, -log10(max(tt$P.Value[tt$adj.P.Val <= 0.01])),
"1% FDR", pos=3)
Figure @ref(fig:leukemiaheatmap) below shows a heatmap of GSVA enrichment scores for the 49 differentially expressed pathways.
DEpwys_es <- exprs(leukemia_es[DEpwys, ])
colorLegend <- c("darkred", "darkblue")
names(colorLegend) <- c("ALL", "MLL")
sample.color.map <- colorLegend[pData(leukemia_es)[, "subtype"]]
names(sample.color.map) <- colnames(DEpwys_es)
sampleClustering <- hclust(as.dist(1-cor(DEpwys_es, method="spearman")),
method="complete")
geneSetClustering <- hclust(as.dist(1-cor(t(DEpwys_es), method="pearson")),
method="complete")
heatmap(DEpwys_es, ColSideColors=sample.color.map, xlab="samples",
ylab="Pathways", margins=c(2, 20),
labRow=substr(gsub("_", " ", gsub("^KEGG_|^REACTOME_|^BIOCARTA_", "",
rownames(DEpwys_es))), 1, 35),
labCol="", scale="row", Colv=as.dendrogram(sampleClustering),
Rowv=as.dendrogram(geneSetClustering))
legend("topleft", names(colorLegend), fill=colorLegend, inset=0.01, bg="white")
The gsva()
function can be also used through an
interactive web app developed with shiny. To start
it just type on the R console:
It will open your browser with the web app shown here below. The
button SAVE & CLOSE
will close the app and return the
resulting object on the R console. Hence, the need to call igsva() on
the right-hand side of an assignment if you want to store the result in
your workspace. Alternatively, you can use the DOWNLOAD
button to download the result in a CSV file.
In the starting window of the web app, after running GSVA, a
non-parametric kernel density estimation of sample profiles of GSVA
scores will be shown. By clicking on one of the lines, the cumulative
distribution of GSVA scores for the corresponding samples will be shown
in the GeneSets
tab, as illustrated in the image below.
GSVA has benefited from contributions by multiple developers, see https://github.com/rcastelo/GSVA/graphs/contributors for a list of them. Contributions to the software codebase of GSVA are welcome as long as contributors abide to the terms of the Bioconductor Contributor Code of Conduct. If you want to contribute to the development of GSVA please open an issue to start discussing your suggestion or, in case of a bugfix or a straightforward feature, directly a pull request.
Here is the output of sessionInfo()
on the system on
which this document was compiled running pandoc 3.2.1:
sessionInfo()
R version 4.4.2 (2024-10-31)
Platform: x86_64-pc-linux-gnu
Running under: Ubuntu 24.04.1 LTS
Matrix products: default
BLAS: /usr/lib/x86_64-linux-gnu/openblas-pthread/libblas.so.3
LAPACK: /usr/lib/x86_64-linux-gnu/openblas-pthread/libopenblasp-r0.3.26.so; LAPACK version 3.12.0
locale:
[1] LC_CTYPE=en_US.UTF-8 LC_NUMERIC=C
[3] LC_TIME=en_US.UTF-8 LC_COLLATE=C
[5] LC_MONETARY=en_US.UTF-8 LC_MESSAGES=en_US.UTF-8
[7] LC_PAPER=en_US.UTF-8 LC_NAME=C
[9] LC_ADDRESS=C LC_TELEPHONE=C
[11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C
time zone: Etc/UTC
tzcode source: system (glibc)
attached base packages:
[1] stats4 stats graphics grDevices utils datasets methods
[8] base
other attached packages:
[1] RColorBrewer_1.1-3 edgeR_4.5.0
[3] limma_3.63.1 GSVAdata_1.42.0
[5] SummarizedExperiment_1.37.0 GenomicRanges_1.59.0
[7] GenomeInfoDb_1.43.0 MatrixGenerics_1.19.0
[9] matrixStats_1.4.1 hgu95a.db_3.13.0
[11] GSEABase_1.69.0 graph_1.85.0
[13] annotate_1.85.0 XML_3.99-0.17
[15] org.Hs.eg.db_3.20.0 AnnotationDbi_1.69.0
[17] IRanges_2.41.0 S4Vectors_0.45.0
[19] Biobase_2.67.0 BiocGenerics_0.53.1
[21] generics_0.1.3 GSVA_2.1.1
[23] BiocStyle_2.35.0
loaded via a namespace (and not attached):
[1] blob_1.2.4 Biostrings_2.75.1
[3] fastmap_1.2.0 SingleCellExperiment_1.29.0
[5] digest_0.6.37 rsvd_1.0.5
[7] lifecycle_1.0.4 statmod_1.5.0
[9] KEGGREST_1.47.0 RSQLite_2.3.7
[11] magrittr_2.0.3 compiler_4.4.2
[13] rlang_1.1.4 sass_0.4.9
[15] tools_4.4.2 yaml_2.3.10
[17] knitr_1.49 S4Arrays_1.7.1
[19] bit_4.5.0 DelayedArray_0.33.1
[21] abind_1.4-8 BiocParallel_1.41.0
[23] HDF5Array_1.35.1 sys_3.4.3
[25] grid_4.4.2 beachmat_2.23.0
[27] xtable_1.8-4 Rhdf5lib_1.29.0
[29] cli_3.6.3 rmarkdown_2.29
[31] crayon_1.5.3 httr_1.4.7
[33] rjson_0.2.23 DBI_1.2.3
[35] cachem_1.1.0 rhdf5_2.51.0
[37] splines_4.4.2 zlibbioc_1.52.0
[39] parallel_4.4.2 BiocManager_1.30.25
[41] XVector_0.47.0 vctrs_0.6.5
[43] Matrix_1.7-1 jsonlite_1.8.9
[45] BiocSingular_1.23.0 bit64_4.5.2
[47] irlba_2.3.5.1 maketools_1.3.1
[49] magick_2.8.5 locfit_1.5-9.10
[51] jquerylib_0.1.4 codetools_0.2-20
[53] UCSC.utils_1.3.0 ScaledMatrix_1.15.0
[55] htmltools_0.5.8.1 rhdf5filters_1.19.0
[57] GenomeInfoDbData_1.2.13 R6_2.5.1
[59] sparseMatrixStats_1.19.0 evaluate_1.0.1
[61] lattice_0.22-6 png_0.1-8
[63] SpatialExperiment_1.17.0 memoise_2.0.1
[65] bslib_0.8.0 Rcpp_1.0.13-1
[67] SparseArray_1.7.1 xfun_0.49
[69] buildtools_1.0.0 pkgconfig_2.0.3
Thanks to Gordon Smyth for pointing this out to us.↩︎