Abstract
BgeeDB is a collection of functions to import into R re-annotated, quality-controlled and reprocessed expression data available in the Bgee database. This includes data from thousands of wild-type healthy samples of multiple animal species, generated with different gene expression technologies (RNA-seq, Affymetrix microarrays, expressed sequence tags, and in situ hybridizations). BgeeDB facilitates downstream analyses, such as gene expression analyses with other Bioconductor packages. Moreover, BgeeDB includes a new gene set enrichment test for preferred localization of expression of genes in anatomical structures (“TopAnat”). Along with the classical Gene Ontology enrichment test, this test provides a complementary way to interpret gene lists.
Availability: http://www.bioconductor.org/packages/BgeeDB/
Keywords: Bioconductor, R Package, Collective Data Access, Gene expression, Gene Enrichment Analysis
Introduction
Gene expression levels influence the behavior of cells, the functionality of tissues, and a wide range of processes from development and aging to physiology or behavior. It is of particular importance that researchers are able to take advantage of the vast amounts of publicly available gene expression datasets to reproduce and validate results, or to investigate new research questions 1– 3.
To that purpose, one should be able to easily query and import gene expression datasets generated using different technologies, and their associated metadata. The R environment 4 has now become a standard for bioinformatics and statistical analysis of gene expression data, through the Bioconductor framework and its many open source packages 5, 6. It is thus desirable to provide access to gene expression datasets programmatically and directly in R. For example, the Bioconductor packages ArrayExpress 7, GEOquery 8 and SRAdb 9 provide access to the reference databases ArrayExpress 10, GEO 11 and SRA 12 respectively.
However, such databases are primary archives aiming at comprehensiveness. They include gene expression datasets and other functional genomics data, generated from diverse experimental conditions, of diverse quality. The data provided are heterogeneous, with some datasets including only unprocessed raw data, and others including only data processed using specific analysis pipelines. For instance, over the 44,177 RNA array assay experiments stored in ArrayExpress with processed data available as of October 2016, 7,520 do not include the raw data. Metadata are often provided as free-text information that is difficult to query. For instance, the GEO database encourages submitters of high-throughput sequencing experiments to provide MINSEQE elements, but does not enforce this practice (see, e.g., GEO submission guidelines, and GEO Excel template for submissions). Unless the user needs to retrieve a specific known dataset from its accession number, it can be difficult to identify relevant available datasets. This can ultimately constitute an obstacle to data reuse.
One response to this diversity of primary archives is topical databases 1. They can be useful for researchers of specialized fields, and even more so if they propose an R package for data access. For example, the BrainStars Bioconductor package allows access to microarray data of mouse brain regions samples from the BrainStars project 13, 14. The ImmuneSpaceR Bioconductor package allows access to the gene expression data generated by the Human Immunology Project Consortium 15. Such efforts allow better control of the data and annotation quality, but by nature they include a limited number of conditions, which only fit the needs of specialized projects. Similarly, numerous “ExperimentData” packages are available on the Bioconductor repository, which each include a single curated and well-formatted expression dataset (see http://www.bioconductor.org/packages/release/BiocViews.html#___ExpressionData). But these packages are rarely updated and are mostly meant to be used as examples in software packages vignettes, for teaching, or as supplementary data for publications.
Finally, added-value databases aim at filtering, annotating, and possibly reprocessing all or some of the datasets available from the primary archives 1. For example, a Bioconductor package was recently released to access the Expression Atlas, which includes a selection of microarray and RNA-seq datasets from ArrayExpress that are re-annotated and reprocessed 16, 17. Similarly, the recount Bioconductor package provides access to a dataset of 2,040 reanalyzed human RNA-seq samples from SRA (see https://jhubiostatistics.shinyapps.io/recount/) 18– 20.
The Bgee database ( http://bgee.org/) 21 is another added-value database, which currently offers access to reprocessed gene expression datasets from 17 animal species. Bgee aims to compare gene expression patterns across tissues, developmental stages, ages and species. It provides manually curated annotations to ontology terms, describing precisely the experimental conditions used. It integrates expression data generated with multiple technologies: RNA-Seq, Affymetrix microarrays, in situ hybridization, and expressed sequence tags (ESTs). An important characteristic of Bgee is that all datasets are manually curated to retain only “normal” healthy wild-type samples, i.e., excluding gene knock-out, treatments or diseases. Finally, Bgee datasets are carefully checked for quality issues, and reprocessed to produce normalized expression level, calls of presence/absence of expression, and of differential expression. Bgee thus provides a reference of high-quality and reusable gene expression datasets that are relevant for biological insights into normal conditions of gene expression. Release 13 of Bgee includes 526 RNA-seq libraries, 12,736 Affymetrix chips, 349,613 results from 46,619 in situ hybridization experiments and 3,185 EST libraries. Release 14 of Bgee is in preparation and will notably include 5,746 RNA-seq libraries from 29 animal species, including 4,860 human libraries from the GTEx project 22, 23.
Until recently the Bgee database lacked programmatic access to data through an R package, a shortcoming that we have addressed with the release of the BgeeDB Bioconductor package, available at http://www.bioconductor.org/packages/BgeeDB/. The package provides functions for fast extraction of data and metadata. The data structures used in the package can be easily incorporated with other Bioconductor packages, offering a wide range of possibilities for downstream analyses.
Moreover, in BgeeDB we introduce the possibility to run TopAnat analyses, i.e., anatomical expression enrichment tests on gene lists provided by the user. This functionality is based on the topGO package 24, 25, modified to use Bgee data (A. Alexa, personal communication). TopAnat is similar to the widely used Gene Ontology enrichment test 26– 28. But in our case, the enrichment test is applied to terms from an anatomical ontology, mapped to genes by expression patterns. As a result, TopAnat allows for discovery of tissues where a set of genes is preferentially expressed. This feature is available as a web-tool at http://bgee.org/?page=top_anat, but the R package offers more flexibility in the choice of input data and analysis parameters, and possibilities of inclusion within programs or pipelines.
In the following sections we provide some typical examples of usage of the BgeeDB package.
Methods
Requirements
R >= 3.3
Bioconductor >= 3.4
BgeeDB package version >= 2.0.0
Working internet connection
Package installation
source("https://bioconductor.org/biocLite.R")
biocLite("BgeeDB")
# load the library
library(BgeeDB)
Use cases
Data download and import of normalized expression levels
The first step of data retrieval is to initialize a new Bgee reference class object, for a targeted species and data type. Normalized expression levels are currently available in the BgeeDB package for two data types: Affymetrix microarrays and Illumina RNA-seq. The list of species available in the Bgee database for each data type, along with their NCBI taxonomy IDs and common names can be obtained with the listBgeeSpecies() function. By default, data will be downloaded from the latest Bgee release, but this can be changed with the release argument.
Next, the functions getAnnotation(), getData(), and formatData() can be called to respectively download the annotations of datasets, download the actual expression data, and reformat the expression data for more convenient use. Of note, BgeeDB creates a directory to store the downloaded annotation files and datasets, by default in the user’s R working directory, but this can be changed with the pathToData argument. These versioned cached files make it faster for the user to return to previously used data and allow for offline work.
Microarray dataset retrieval. In the following example, we look for a microarray dataset in mouse ( Mus musculus), spanning multiple early developmental stages, including zygote. At the time of publication the latest Bgee release is 13.2, so if one needs to strictly reproduce the output of the code below in the future, the release="13.2" argument needs to be added when creating the Bgee object (see Supplementary file S1 and Supplementary file S2).
# specify species and data type
bgee.affymetrix <- Bgee$new(species="Mus_musculus", dataType="affymetrix")
# retrieve annotation of all mouse affymetrix datasets in Bgee
annotation.bgee.mouse.affymetrix <- getAnnotation(bgee.affymetrix)
str(annotation.bgee.mouse.affymetrix)
This creates a list of two data frames, one including the annotation of experiments, and one including the annotation of each individual sample, i.e., hybridized microarray chip. For mouse, there are 694 Affymetrix experiments and 6,077 samples available in Bgee release 13. Anatomical structures and developmental stages are annotated using the Uberon ontology 29, 30. Below, we are selecting the experiments for which at least one sample is annotated to the zygote stage ( UBERON:0000106).
# retrieve annotations of samples and experiments
sample.annotation <- annotation.bgee.mouse.affymetrix$sample.annotation
experiment.annotation <- annotation.bgee.mouse.affymetrix$experiment.annotation
# list experiments including a zygote sample
selected.experiments <- unique(sample.annotation$Experiment.ID[sample.annotation$Stage.ID == "UBERON:0000106"])
experiment.annotation[experiment.annotation$Experiment.ID %in% selected.experiments,]
# stages sampled in each of these experiments
unique(sample.annotation[sample.annotation$Experiment.ID %in% selected.experiments, c(1,6)])
This yields three microarray experiments, with accessions GSE1749, E-MEXP-51 and GSE18290. Among these, the accession E-MEXP-51, submitted to ArrayExpress by Wang and colleagues 31, includes samples from more developmental stages than the other two, so we use this in the next steps. For this experiment, raw data were available from ArrayExpress, so samples were fully normalized with gcRMA 32 version 2.40.0 through the Bgee pipeline.
# List all samples from E-MEXP-51 in Bgee
sample.annotation[sample.annotation$Experiment.ID == "E-MEXP-51",]
The experiment includes 35 samples that passed Bgee quality controls. They originate from 12 developmental stages: primary and secondary oocyte, zygote, early, mid and late 2-cells embryo, 4-cells embryo, 8-cells embryo, 16-cells embryo, early, mid and late blastocyst, although the developmental stages ontology used is not precise enough yet to differentiate some of these conditions: the early, mid and late 2-cells stages are annotated as Theiler stage 2 embryo, and the 4-cells and 8-cells stages are annotated as Theiler stage 3 embryo. All samples were hybridized to the Affymetrix GeneChip Murine Genome U74Av2 microarray. Let us download the normalized probesets intensities measured for all samples.
data.E.MEXP.51 <- getData(bgee.affymetrix, experimentId="E-MEXP-51")
head(data.E.MEXP.51)
The resulting data frame lists for each sample (column “Chip.ID”), the 9,017 probesets on the microarray (column “Probeset.ID”), their mapping to Ensembl gene IDs 33 (column “Gene.ID”), their logged normalized intensities (column “Log.of.normalized.signal.intensity”), and a presence/absence call and quality (columns “Detection.flag” and “Detection.quality”).
As this format might not be the most convenient for downstream processing of an expression dataset, we offer the formatData() function, which creates an ExpressionSet object including the expression data matrix, the probesets annotation to Ensembl genes and the samples' anatomical structure and stage annotation into ( assayData, featureData and phenoData slots respectively). This object class is of standard use in numerous Bioconductor packages.
data.E.MEXP.51.formatted <- formatData(bgee.affymetrix, data.E.MEXP.51, callType="all", stats="intensities")
data.E.MEXP.51.formatted
# matrix of expression intensities
head(exprs(data.E.MEXP.51.formatted))
# annotation of samples
pData(data.E.MEXP.51.formatted)
# annotation of probesets
head(fData(data.E.MEXP.51.formatted))
The callType option of the formatData() function could alternatively be set to present or present high quality to display only the intensities of probesets detected as actively expressed.
The result is a nicely formatted Bioconductor object including expression data and their annotations, ready to be used for downstream analysis with other Bioconductor packages.
RNA-seq dataset retrieval. We now search Bgee for a RNA-seq dataset sampling brain and liver tissues (Uberon Ids UBERON:0000955 and UBERON:0002107 respectively) in macaque ( Macaca mulatta), and including multiple biological replicates for each tissue.
# specify species and data type
bgee.rnaseq <- Bgee$new(species="Macaca_mulatta", dataType="rna_seq")
# retrieve annotations of RNA-seq samples and experiments
annotation.bgee.macaque.rna.seq <- getAnnotation(bgee.rnaseq)
sample.annotation <- annotation.bgee.macaque.rna.seq$sample.annotation
experiment.annotation <- annotation.bgee.macaque.rna.seq$experiment.annotation
# list experiments including both brain and liver samples
selected.experiments <- intersect(unique(sample.annotation$Experiment.ID[sample.annotation$Anatomical.entity.ID == "UBERON:0000955"]),
unique(sample.annotation$Experiment.ID[sample.annotation$Anatomical.entity.ID == "UBERON:0002107"]))
experiment.annotation[experiment.annotation$Experiment.ID %in% selected.experiments,]
# check whether experiments include biological replicates
sample.annotation[sample.annotation$Experiment.ID %in%
selected.experiments & (sample.annotation$Anatomical.entity.ID == "UBERON:0000955" |
sample.annotation$Anatomical.entity.ID == "UBERON:0002107"), 1:6]
Accessions GSE41637 34 and GSE30352 35 both include biological replicates for brain and liver. We focus on GSE41637 for the next steps since it includes three replicates of each tissue, vs. only two for GSE30352. We download the dataset and reformat it to obtain an ExpressionSet including counts of mapped reads on each Ensembl gene for each sample.
data.GSE41637 <- getData(bgee.rnaseq, experimentId="GSE41637")
data.GSE41637.formatted <- formatData(bgee.rnaseq, data.GSE41637, callType="all", stats="counts")
data.GSE41637.formatted
Instead of mapped read counts, it is also possible to fill the data matrix with expression levels in the RPKM unit (reads per kilobase per million reads), using the option stats="rpkm". In the next Bgee release (release 14), it will be possible to obtain expression levels in the TPM unit (transcript per million) 36, 37 from pseudo-mapping of reads computed in Bgee using the Kallisto software 38.
Presence/absence calls retrieval. It is often difficult to compare expression levels across species 39, and even within species, across datasets generated by different experimenters or laboratories 40– 42. Batch effects have indeed been shown to impact extensively gene expression levels, confounding biological signal differences.
Encoding gene expression as present or absent in a sample allows a more robust comparison across such conditions. In addition to retrieving RNA-seq and Affymetrix quantitative expression levels, BgeeDB also allows to retrieve calls of presence or absence of expression computed in the Bgee database for each gene (RNA-seq) or probeset (Affymetrix), in the column “Detection.flag” of the data.E.MEXP.51 and data.GSE41637 objects created above. And interestingly, expression calls are also available in Bgee for ESTs and in situ hybridization data, as well as for the consensus of the four data types for each triplet “gene / tissue / developmental stage”.
A powerful use of these expression calls is the anatomical expression enrichment test “TopAnat”. TopAnat uses a similar approach to Gene Ontology enrichment tests 26, but genes are associated to the anatomical structures where they display expression, instead of to their functional classification. These tests allow detecting where a set of genes is preferentially expressed as compared to a background universe (Roux J., Seppey M., Sanjeev K., Rech de Laval V., Moret P., Artimo P., Duvaud S., Ioannidis V., Stockinger H., Robinson-Rechavi M., Bastian F.B.; unpublished report). We show an example of such an analysis in the section “Anatomical expression enrichment analysis” below.
Of note, the expression calls imported from BgeeDB can also be used for other downstream analyses. For example, when studying protein-protein interaction datasets, it might be biologically relevant to retain only interactions for which both members are expressed in the same tissues 43, 44.
Downstream analysis examples
Clustering analysis. A variety of downstream analyses can be performed on the imported expression data. Below we detail an example of gene expression clustering analysis on the developmental time-series microarray experiment imported above. The analysis, performed with the Mfuzz package 45, 46 (version 2.34.0 for this paper), aims at uncovering genes with similar expression profiles across development. We can readily start with the ExpressionSet object previously created.
# for simplicity, keep only one sample per condition
data.E.MEXP.51.formatted <- data.E.MEXP.51.formatted[, !duplicated(pData(data.E.MEXP.51.formatted)[2:5])]
# order developmental stages
data.E.MEXP.51.formatted <- data.E.MEXP.51.formatted[, c(5,8,9,3,2,1,4,7,6)]
# filter out rows with no variance
data.E.MEXP.51.formatted <- data.E.MEXP.51.formatted[apply(exprs(data.E.MEXP.51.formatted), 1, sd) != 0, ]
# Mfuzz clustering
biocLite("Mfuzz")
library(Mfuzz)
# standardize matric of expression data
z.mat <- standardise(data.E.MEXP.51.formatted)
# cluster data into 16 clusters
clusters <- mfuzz(z.mat, centers=16, m=1.25)
# visualizing clusters
mfuzz.plot2(z.mat, cl=clusters, mfrow=c(4,4), colo="fancy",
time.labels=row.names(pData(z.mat)), las=2, xlab="", ylab="Standardized expression level", x11=FALSE)
The resulting plot can be seen in Figure 1.
Figure 1. Standardized expression levels of 16 groups of microarray probesets, clustered according to their expression during mouse early development.
The x-axis displays sample names (column “Chip.ID” of the data.E.MEXP.51 object).
Differential expression analysis. Below, we detail a differential expression analysis, with the package edgeR 47, 48 (version 3.16.1 for this paper), on the previously imported RNA-seq dataset of macaque tissues. We aim at isolating genes differentially expressed between brain and liver.
# differential expression analysis with edgeR
biocLite("edgeR")
library(edgeR)
# subset the dataset to brain and liver
brain.liver <- data.GSE41637.formatted[, pData(data.GSE41637.formatted)$Anatomical.entity.name %in% c("brain", "liver")]
# filter out very lowly expressed genes
brain.liver.filtered <- brain.liver[rowSums(cpm(brain.liver) > 1) > 3, ]
# create edgeR DGElist object
dge <- DGEList(counts=brain.liver.filtered,
group=pData(brain.liver.filtered)$Anatomical.entity.name)
dge <- calcNormFactors(dge)
dge <- estimateCommonDisp(dge)
dge <- estimateTagwiseDisp(dge)
de <- exactTest(dge, pair=c("brain","liver"))
de.genes <- topTags(de, n=nrow(de))$table
# MA plot with DE genes highlighted
plotSmear(dge, de.tags=rownames(de.genes)[de.genes$FDR < 0.01], cex=0.3)
The resulting plot can be seen in Figure 2.
Figure 2. Mean-average (MA) plot of differential gene expression between brain and liver in macaque based on RNA-seq data.
Significantly differentially expressed genes (FDR < 1%) are highlighted in red.
Anatomical expression enrichment analysis
The loadTopAnatData() function loads the names of anatomical structures, and relationships between them, from the Uberon anatomical ontology (based on parent-child “is_a” and “part_of” relationships). It also loads a mapping from genes to anatomical structures, based on the presence calls of the genes in the targeted species. These calls come from a consensus of all data types specified in the input Bgee class object. We recommend to use all available data types (RNA-seq, Affymetrix, EST and in situ hybridization) for both genomic coverage and anatomical precision, which is the default behavior if no dataType argument is specified when the Bgee class object is created.
By default, presence calls of both high and low quality are used, which can be changed with the confidence argument of the loadTopAnatData() function. Finally, it is possible to specify the developmental stage under consideration, with the stage argument. By default expression calls generated from samples of all developmental stages are used, which is equivalent to specifying stage="UBERON:0000104" (“life cycle”, the root of the stage ontology). Data are stored in versioned tab-separated cached files that will be read again if a query with the exact same parameters is launched later, to save time and server resources, and to work offline.
In this example, we use expression calls for zebrafish genes using all sources of expression data.
bgee.topanat <- Bgee$new(species="Danio_rerio")
myTopAnatData <- loadTopAnatData(bgee.topanat)
str(myTopAnatData)
We look at the expression localization of the genes with an annotated phenotype related to pectoral fin (i.e., genes which upon knock-out or knock-down led to abnormal phenotypes of pectoral fin or its components). Zebrafish phenotypic data are available from the ZFIN database 49 and integrated into the Ensembl database 50. We thus retrieve the targeted genes using the biomaRt 51 Bioconductor package (version 2.30.0 for this paper).
biocLite("biomaRt")
library(biomaRt)
# zebrafish data in Ensembl 85 (stable link)
ensembl <- useMart("ENSEMBL_MART_ENSEMBL",
dataset="drerio_gene_ensembl", host="jul2016.archive.ensembl.org")
# get the mapping of Ensembl genes to phenotypes
genesToPhenotypes <- getBM(filters=c("phenotype_source"), value=c("ZFIN"),
attributes=c("ensembl_gene_id","phenotype_description"), mart=ensembl)
# select phenotypes related to pectoral fin
myPhenotypes <- grep("pectoral fin", unique(genesToPhenotypes$phenotype_description), value=T)
# select the genes annotated to select phenotypes
myGenes <- unique(genesToPhenotypes$ensembl_gene_id[genesToPhenotypes$phenotype_description %in% myPhenotypes])
This gives a list of 150 zebrafish genes implicated in the development and function of pectoral fin. The next step of the analysis relies on the topGO Bioconductor package. We prepare a modified topGOdata object allowing to handle the Uberon anatomical ontology instead of the Gene Ontology, and perform a GO-like enrichment test for anatomical terms. As for a classical topGO analysis, we need to prepare a vector including all background genes, and with values 0 or 1 depending if genes are part of the foreground or not. The choice of background is very important since the wrong background can lead to spurious results in enrichment tests 52. Here we choose as background all zebrafish Ensembl genes with an annotated phenotype from ZFIN.
# prepare the gene list vector
geneList <- factor(as.integer(unique(genesToPhenotypes$ensembl_gene_id) %in% myGenes))
names(geneList) <- unique(genesToPhenotypes$ensembl_gene_id)
summary(geneList)
# prepare the topAnat object based on topGO
myTopAnatObject <- topAnat(myTopAnatData, geneList)
At this step, expression calls are propagated through the whole ontology (e.g., expression in the forebrain will also be counted as expression in the brain, the nervous system, etc). This can take some time, especially if the gene list is large.
Finally, we launch an enrichment test for anatomical terms. The functions of the topGO package can directly be used at this step. See the vignette of this package for more details 25. Here we use a Fisher test, coupled with the “weight” decorrelation algorithm.
results <- runTest(myTopAnatObject, algorithm='weight', statistic='fisher')
Finally, we implement a function to display results in a formatted table. By default anatomical structures are sorted by their test p-value, which is displayed along with the associated false discovery rate (FDR 53) and the enrichment fold. Sorting on other columns of the table (e.g., on decreasing enrichment folds) is possible with the ordering argument. Of note, it is debated whether a FDR correction is relevant on such enrichment test results, since tests on different terms of the ontologies are not independent. An interesting discussion can be found in the vignette of the topGO package.
# retrieve anatomical structures enriched at a 1% FDR threshold tableOver <- makeTable(myTopAnatData, myTopAnatObject, results, cutoff=0.01)
The 22 anatomical structures displaying a significant enrichment at a FDR threshold of 1% are show in Table 1. The first term is “paired limb/fin bud”, and the second “pectoral fin”. Other terms in the list, especially those with high enrichment folds, are clearly related to pectoral fins (e.g., “pectoral appendage cartilage tissue”), substructures of fins (e.g., “fin bone”), or located next to them (e.g., “ceratohyal cartilage”). This analysis shows that genes with phenotypic effects on pectoral fins are specifically expressed in or next to these structures. More generally, it proves the pertinence of TopAnat analysis for the characterization of lists of genes.
Table 1. Zebrafish anatomical structures showing a significant enrichment in expression of genes with a pectoral fin phenotype (FDR < 1%).
The “weight” algorithm of the topGO package was used to decorrelate the structure of the ontology.
| organId | organName | annotated | significant | expected | foldEnrichment | pValue | FDR |
|---|---|---|---|---|---|---|---|
| UBERON:0004357 | paired limb/fin
bud |
144 | 41 | 7.15 | 5.7 | 1.6E-22 | 1.4E-19 |
| UBERON:0000151 | pectoral fin | 420 | 70 | 20.85 | 3.4 | 1.0E-18 | 4.6E-16 |
| UBERON:2000040 | median fin
fold |
51 | 18 | 2.53 | 7.1 | 7.2E-12 | 2.1E-09 |
| UBERON:0003051 | ear vesicle | 304 | 41 | 15.09 | 2.7 | 3.1E-10 | 7.0E-08 |
| UBERON:0005729 | pectoral
appendage field |
16 | 10 | 0.79 | 12.7 | 4.0E-10 | 7.1E-08 |
| UBERON:0007390 | pectoral
appendage cartilage tissue |
17 | 9 | 0.84 | 10.7 | 2.4E-08 | 3.6E-06 |
| UBERON:0011610 | ceratohyal
cartilage |
29 | 11 | 1.44 | 7.6 | 4.8E-08 | 6.1E-06 |
| UBERON:0004376 | fin bone | 28 | 9 | 1.39 | 6.5 | 4.3E-06 | 4.8E-04 |
| UBERON:0003351 | pharyngeal
epithelium |
70 | 14 | 3.48 | 4.0 | 4.9E-06 | 4.8E-04 |
| UBERON:0002513 | endochondral
bone |
37 | 10 | 1.84 | 5.4 | 7.1E-06 | 6.3E-04 |
| UBERON:0008001 | irregular bone | 30 | 9 | 1.49 | 6.0 | 8.2E-06 | 6.6E-04 |
| UBERON:0008907 | dermal bone | 46 | 11 | 2.28 | 4.8 | 8.9E-06 | 6.6E-04 |
| UBERON:0002539 | pharyngeal
arch |
518 | 61 | 25.72 | 2.4 | 1.1E-05 | 7.1E-04 |
| UBERON:0000089 | hypoblast
(generic) |
85 | 15 | 4.22 | 3.6 | 1.1E-05 | 7.1E-04 |
| UBERON:0002541 | germ ring | 94 | 15 | 4.67 | 3.2 | 3.9E-05 | 2.3E-03 |
| UBERON:0001003 | skin
epidermis |
109 | 16 | 5.41 | 3.0 | 6.2E-05 | 3.5E-03 |
| UBERON:0004375 | bone of free
limb or fin |
23 | 7 | 1.14 | 6.1 | 8.0E-05 | 4.2E-03 |
| UBERON:0000165 | mouth | 97 | 21 | 4.82 | 4.4 | 1.0E-04 | 4.8E-03 |
| UBERON:0011152 | dorsal hyoid
arch skeleton |
24 | 7 | 1.19 | 5.9 | 1.1E-04 | 4.8E-03 |
| UBERON:0000925 | endoderm | 126 | 17 | 6.26 | 2.7 | 1.1E-04 | 4.8E-03 |
| UBERON:0003128 | cranium | 283 | 31 | 14.05 | 2.2 | 1.3E-04 | 5.5E-03 |
| UBERON:0010312 | immature eye | 447 | 41 | 22.19 | 1.8 | 1.9E-04 | 7.7E-03 |
Conclusion
In summary, the BgeeDB package serves as a bridge between data from the Bgee database and the R/Bioconductor environment, facilitating access to high-quality curated and re-analyzed gene expression datasets, and significantly reducing time for downstream analyses of the datasets. Moreover, it provides access to TopAnat, a new enrichment that makes sense of lists of genes by uncovering their preferential localization of expression in anatomical structures. The TopAnat workflow is straightforward; for users already using topGO in their analysis pipelines, performing a TopAnat analysis on the same gene list only requires 6 additional lines of code.
Software availability
Software available from: http://www.bioconductor.org/packages/BgeeDB/
Latest source code: https://github.com/BgeeDB/BgeeDB_R
Archived source code as at the time of publication: https://doi.org/10.5281/zenodo.163768 54
Funding Statement
This work was supported by SIB Swiss Institute of Bioinformatics project Bgee, Swiss National Science Foundation grant 31003A_153341, SystemsX.ch project AgingX, and Etat de Vaud.
[version 1; referees: 1 approved
Supplementary material
R markdown file including code from the paper.
PDF file including the results of execution of the code from File S1.
References
- 1. Rung J, Brazma A: Reuse of public genome-wide gene expression data. Nat Rev Genet. 2013;14(2):89–99. 10.1038/nrg3394 [DOI] [PubMed] [Google Scholar]
- 2. Ioannidis JP, Allison DB, Ball CA, et al. : Repeatability of published microarray gene expression analyses. Nat Genet. 2009;41(2):149–55. 10.1038/ng.295 [DOI] [PubMed] [Google Scholar]
- 3. Wan X, Pavlidis P: Sharing and reusing gene expression profiling data in neuroscience. Neuroinformatics. 2007;5(3):161–75. 10.1007/s12021-007-0012-5 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4. R Development Core Team: R: A Language and Environment for Statistical Computing.Vienna, Austria: R Foundation for Statistical Computing;2007. Reference Source [Google Scholar]
- 5. Huber W, Carey VJ, Gentleman R, et al. : Orchestrating high-throughput genomic analysis with Bioconductor. Nat Methods. 2015;12(2):115–21. 10.1038/nmeth.3252 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6. Gentleman RC, Carey VJ, Bates DM, et al. : Bioconductor: open software development for computational biology and bioinformatics. Genome Biol. 2004;5(10):R80. 10.1186/gb-2004-5-10-r80 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7. Kauffmann A, Rayner TF, Parkinson H, et al. : Importing ArrayExpress datasets into R/Bioconductor. Bioinformatics. 2009;25(16):2092–4. 10.1093/bioinformatics/btp354 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8. Davis S, Meltzer PS: GEOquery: a bridge between the Gene Expression Omnibus (GEO) and BioConductor. Bioinformatics. 2007;23(14):1846–7. 10.1093/bioinformatics/btm254 [DOI] [PubMed] [Google Scholar]
- 9. Zhu Y, Stephens RM, Meltzer PS, et al. : SRAdb: query and use public next-generation sequencing data from within R. BMC Bioinformatics. 2013;14(1):19. 10.1186/1471-2105-14-19 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10. Kolesnikov N, Hastings E, Keays M, et al. : ArrayExpress update--simplifying data submissions. Nucleic Acids Res. 2015;43(Database issue):D1113–6. 10.1093/nar/gku1057 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11. Barrett T, Wilhite SE, Ledoux P, et al. : NCBI GEO: archive for functional genomics data sets--update. Nucleic Acids Res. 2013;41(Database issue):D991–5. 10.1093/nar/gks1193 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12. Leinonen R, Sugawara H, Shumway M, et al. : The sequence read archive. Nucleic Acids Res. 2011;39(Database issue):D19–21. 10.1093/nar/gkq1019 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.BrainStars Bioconductor package.Reference Source [Google Scholar]
- 14. Kasukawa T, Masumoto KH, Nikaido I, et al. : Quantitative expression profile of distinct functional regions in the adult mouse brain. PLoS One. 2011;6(8):e23228. 10.1371/journal.pone.0023228 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.ImmuneSpaceR Bioconductor package.Reference Source [Google Scholar]
- 16.ExpressionAtlas Bioconductor package.Reference Source [Google Scholar]
- 17. Petryszak R, Keays M, Tang YA, et al. : Expression Atlas update--an integrated database of gene and protein expression in humans, animals and plants. Nucleic Acids Res. 2016;44(D1):D746–52. 10.1093/nar/gkv1045 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18. Collado-Torres L, Nellore A, Kammers K, et al. : recount: A large-scale resource of analysis-ready RNA-seq expression data. bioRxiv. 2016. 10.1101/068478 [DOI] [Google Scholar]
- 19. Frazee AC, Langmead B, Leek JT: ReCount: A multi-experiment resource of analysis-ready RNA-seq gene count datasets. BMC Bioinformatics. 2011;12(1):449. 10.1186/1471-2105-12-449 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.recount Bioconductor package. Reference Source [Google Scholar]
- 21. Bastian F, Parmentier G, Roux J, et al. : Bgee: Integrating and Comparing Heterogeneous Transcriptome Data Among Species. Data Integr Life Sci. 2008;5109:124–31. 10.1007/978-3-540-69828-9_12 [DOI] [Google Scholar]
- 22. GTEx Consortium: Human genomics. The Genotype-Tissue Expression (GTEx) pilot analysis: Multitissue gene regulation in humans. Science. 2015;348(6235):648–60. 10.1126/science.1262110 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23. Melé M, Ferreira PG, Reverter F, et al. : Human genomics. The human transcriptome across tissues and individuals. Science. 2015;348(6235):660–5. 10.1126/science.aaa0355 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24. Alexa A, Rahnenführer J, Lengauer T: Improved scoring of functional groups from gene expression data by decorrelating GO graph structure. Bioinformatics. 2006;22(13):1600–7. 10.1093/bioinformatics/btl140 [DOI] [PubMed] [Google Scholar]
- 25.topGO Bioconductor package.Reference Source [Google Scholar]
- 26. Rhee YS, Wood V, Dolinski K, et al. : Use and misuse of the gene ontology annotations. Nat Rev Genet. 2008;9(7):509–15. 10.1038/nrg2363 [DOI] [PubMed] [Google Scholar]
- 27. Ashburner M, Ball CA, Blake JA, et al. : Gene ontology: tool for the unification of biology. The Gene Ontology Consortium. Nat Genet. 2000;25(1):25–9. 10.1038/75556 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28. Dessimoz C, Škunca N.editors: The Gene Ontology Handbook.Humana Press;2017; XII, 305. 10.1007/978-1-4939-3743-1 [DOI] [Google Scholar]
- 29. Mungall CJ, Torniai C, Gkoutos GV, et al. : Uberon, an integrative multi-species anatomy ontology. Genome Biol. 2012;13(1):R5. 10.1186/gb-2012-13-1-r5 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 30. Haendel MA, Balhoff JP, Bastian FB, et al. : Unification of multi-species vertebrate anatomy ontologies for comparative biology in Uberon. J Biomed Semantics. 2014;5(1):21. 10.1186/2041-1480-5-21 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 31. Wang QT, Piotrowska K, Ciemerych MA, et al. : A genome-wide study of gene activity reveals developmental signaling pathways in the preimplantation mouse embryo. Dev Cell. 2004;6(1):133–44. 10.1016/S1534-5807(03)00404-0 [DOI] [PubMed] [Google Scholar]
- 32. Wu Z, Irizarry RA, Gentleman R, et al. : A Model-Based Background Adjustment for Oligonucleotide Expression Arrays. J Am Stat Assoc. 2004;99(468):909–17. 10.1198/016214504000000683 [DOI] [Google Scholar]
- 33. Yates A, Akanni W, Amode MR, et al. : Ensembl 2016. Nucleic Acids Res. 2016;44(D1):D710–6. 10.1093/nar/gkv1157 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34. Merkin J, Russell C, Chen P, et al. : Evolutionary dynamics of gene and isoform regulation in Mammalian tissues. Science. 2012;338(6114):1593–9. 10.1126/science.1228186 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35. Brawand D, Soumillon M, Necsulea A, et al. : The evolution of gene expression levels in mammalian organs. Nature. 2011;478(7369):343–8. 10.1038/nature10532 [DOI] [PubMed] [Google Scholar]
- 36. Wagner GP, Kin K, Lynch VJ: Measurement of mRNA abundance using RNA-seq data: RPKM measure is inconsistent among samples. Theory Biosci. 2012;131(4):281–5. 10.1007/s12064-012-0162-3 [DOI] [PubMed] [Google Scholar]
- 37. Li B, Dewey CN: RSEM: accurate transcript quantification from RNA-Seq data with or without a reference genome. BMC Bioinformatics. 2011;12:323. 10.1186/1471-2105-12-323 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38. Bray NL, Pimentel H, Melsted P, et al. : Near-optimal probabilistic RNA-seq quantification. Nat Biotechnol. 2016;34(5):525–7. 10.1038/nbt.3519 [DOI] [PubMed] [Google Scholar]
- 39. Roux J, Rosikiewicz M, Robinson-Rechavi M: What to compare and how: Comparative transcriptomics for Evo-Devo. J Exp Zool B Mol Dev Evol. 2015;324(4):372–82. 10.1002/jez.b.22618 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40. Gilad Y, Mizrahi-Man O: A reanalysis of mouse ENCODE comparative gene expression data [version 1; referees: 3 approved, 1 approved with reservations]. F1000Res. 2015;4:121. 10.12688/f1000research.6536.1 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41. Leek JT, Scharpf RB, Bravo HC, et al. : Tackling the widespread and critical impact of batch effects in high-throughput data. Nat Rev Genet. 2010;11(10):733–9. 10.1038/nrg2825 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42. Akey JM, Biswas S, Leek JT, et al. : On the design and analysis of gene expression studies in human populations. Nat Genet. 2007;39(7):807–8. 10.1038/ng0707-807 [DOI] [PubMed] [Google Scholar]
- 43. Deane CM, Salwiński Ł, Xenarios I, et al. : Protein Interactions: Two Methods for Assessment of the Reliability of High Throughput Observations. Mol Cell Proteomics. 2002;1(5):349–56. 10.1074/mcp.M100037-MCP200 [DOI] [PubMed] [Google Scholar]
- 44. Kotlyar M, Pastrello C, Sheahan N, et al. : Integrated interactions database: tissue-specific view of the human and model organism interactomes. Nucleic Acids Res. 2016;44(D1):D536–D41. 10.1093/nar/gkv1115 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 45. Futschik ME, Carlisle B: Noise-robust soft clustering of gene expression time-course data. J Bioinform Comput Biol. 2005;3(4):965–88. 10.1142/S0219720005001375 [DOI] [PubMed] [Google Scholar]
- 46. Mfuzz Bioconductor package. Reference Source [Google Scholar]
- 47. Robinson MD, McCarthy DJ, Smyth GK: edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics. 2010;26(1):139–40. 10.1093/bioinformatics/btp616 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48. eedgeR Bioconductor package. Reference Source [Google Scholar]
- 49. Howe DG, Bradford YM, Conlin T, et al. : ZFIN, the Zebrafish Model Organism Database: increased support for mutants and transgenics. Nucleic Acids Res. 2013;41(Database issue):D854–60. 10.1093/nar/gks938 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 50. Spudich GM, Fernández-Suárez XM: Disease and Phenotype Data at Ensembl. Curr Protoc Hum Genet. 2011;Chapter 6:Unit 6.11. 10.1002/0471142905.hg0611s69 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 51. biomaRt Bioconductor package. Reference Source [Google Scholar]
- 52. Timmons JA, Szkop KJ, Gallagher IJ: Multiple sources of bias confound functional enrichment analysis of global -omics data. Genome Biol. 2015;16(1):186. 10.1186/s13059-015-0761-7 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53. Benjamini Y, Hochberg Y: Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. J R Stat Soc Series B Stat Methodol. 1995;57(1):289–300. Reference Source [Google Scholar]
- 54. Komljenovic A, Roux J, Robinson-Rechavi M, et al. : BgeeDB/BgeeDB_R: Bgee R package release 2.0.0. Zenodo. 2016. 10.5281/zenodo.163768 [DOI]


