Location via proxy:   [ UP ]  
[Report a bug]   [Manage cookies]                
ALL Metrics
-
Views
-
Downloads
Get PDF
Get XML
Cite
Export
Track
Software Tool Article

BgeeDB, an R package for retrieval of curated expression datasets and for gene list expression localization enrichment tests

[version 1; peer review: 1 approved, 1 approved with reservations, 1 not approved]
* Equal contributors
PUBLISHED 23 Nov 2016
Author details Author details
OPEN PEER REVIEW
REVIEWER STATUS

This article is included in the Bioconductor gateway.

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 questions13.

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 environment4 has now become a standard for bioinformatics and statistical analysis of gene expression data, through the Bioconductor framework and its many open source packages5,6. It is thus desirable to provide access to gene expression datasets programmatically and directly in R. For example, the Bioconductor packages ArrayExpress7, GEOquery8 and SRAdb9 provide access to the reference databases ArrayExpress10, GEO11 and SRA12 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 databases1. 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 project13,14. The ImmuneSpaceR Bioconductor package allows access to the gene expression data generated by the Human Immunology Project Consortium15. 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 archives1. 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 reprocessed16,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/)1820.

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 project22,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 package24,25, modified to use Bgee data (A. Alexa, personal communication). TopAnat is similar to the widely used Gene Ontology enrichment test2628. 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 ontology29,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 colleagues31, 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 gcRMA32 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 IDs33 (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 GSE4163734 and GSE3035235 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 software38.

Presence/absence calls retrieval. It is often difficult to compare expression levels across species39, and even within species, across datasets generated by different experimenters or laboratories4042. 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 tests26, 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 tissues43,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 package45,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.

81dc0534-4533-42d5-ac82-5315fdfef5ea_figure1.gif

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 edgeR47,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.

81dc0534-4533-42d5-ac82-5315fdfef5ea_figure2.gif

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 database49 and integrated into the Ensembl database50. We thus retrieve the targeted genes using the biomaRt51 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 tests52. 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 details25. 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 (FDR53) 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.

organIdorganNameannotatedsignificantexpectedfoldEnrichmentpValueFDR
UBERON:0004357paired limb/fin
bud
144417.155.71.6E-221.4E-19
UBERON:0000151pectoral fin4207020.853.41.0E-184.6E-16
UBERON:2000040median fin
fold
51182.537.17.2E-122.1E-09
UBERON:0003051ear vesicle3044115.092.73.1E-107.0E-08
UBERON:0005729pectoral
appendage
field
16100.7912.74.0E-107.1E-08
UBERON:0007390pectoral
appendage
cartilage
tissue
1790.8410.72.4E-083.6E-06
UBERON:0011610ceratohyal
cartilage
29111.447.64.8E-086.1E-06
UBERON:0004376fin bone2891.396.54.3E-064.8E-04
UBERON:0003351pharyngeal
epithelium
70143.484.04.9E-064.8E-04
UBERON:0002513endochondral
bone
37101.845.47.1E-066.3E-04
UBERON:0008001irregular bone3091.496.08.2E-066.6E-04
UBERON:0008907dermal bone46112.284.88.9E-066.6E-04
UBERON:0002539pharyngeal
arch
5186125.722.41.1E-057.1E-04
UBERON:0000089hypoblast
(generic)
85154.223.61.1E-057.1E-04
UBERON:0002541germ ring94154.673.23.9E-052.3E-03
UBERON:0001003skin
epidermis
109165.413.06.2E-053.5E-03
UBERON:0004375bone of free
limb or fin
2371.146.18.0E-054.2E-03
UBERON:0000165mouth97214.824.41.0E-044.8E-03
UBERON:0011152dorsal hyoid
arch skeleton
2471.195.91.1E-044.8E-03
UBERON:0000925endoderm126176.262.71.1E-044.8E-03
UBERON:0003128cranium2833114.052.21.3E-045.5E-03
UBERON:0010312immature eye4474122.191.81.9E-047.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.16376854

Comments on this article Comments (0)

Version 2
VERSION 2 PUBLISHED 23 Nov 2016
Comment
Author details Author details
Competing interests
Grant information
Copyright
Download
 
Export To
metrics
Views Downloads
F1000Research - -
PubMed Central
Data from PMC are received and updated monthly.
- -
Citations
CITE
how to cite this article
Komljenovic A, Roux J, Robinson-Rechavi M and Bastian FB. BgeeDB, an R package for retrieval of curated expression datasets and for gene list expression localization enrichment tests [version 1; peer review: 1 approved, 1 approved with reservations, 1 not approved] F1000Research 2016, 5:2748 (https://doi.org/10.12688/f1000research.9973.1)
NOTE: it is important to ensure the information in square brackets after the title is included in all citations of this article.
track
receive updates on this article
Track an article to receive email alerts on any updates to this article.

Open Peer Review

Current Reviewer Status: ?
Key to Reviewer Statuses VIEW
ApprovedThe paper is scientifically sound in its current form and only minor, if any, improvements are suggested
Approved with reservations A number of small changes, sometimes more significant revisions are required to address specific details and improve the papers academic merit.
Not approvedFundamental flaws in the paper seriously undermine the findings and conclusions
Version 1
VERSION 1
PUBLISHED 23 Nov 2016
Views
120
Cite
Reviewer Report 16 Dec 2016
Leonardo Collado-Torres, Lieber Institute for Brain Development, Baltimore, MD, USA 
Not Approved
VIEWS 120
In this manuscript the authors describe the BgeeDB Bioconductor package and show how to use it (as of Bioconductor 3.4) to interact with Bgee1 in order to get the data from Bgee into your R session. This allows users to then ... Continue reading
CITE
CITE
HOW TO CITE THIS REPORT
Collado-Torres L. Reviewer Report For: BgeeDB, an R package for retrieval of curated expression datasets and for gene list expression localization enrichment tests [version 1; peer review: 1 approved, 1 approved with reservations, 1 not approved]. F1000Research 2016, 5:2748 (https://doi.org/10.5256/f1000research.10748.r17980)
NOTE: it is important to ensure the information in square brackets after the title is included in all citations of this article.
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
    My main concern with the manuscript in its current form and the BgeeDB package itself is the lack of clarity on how the data has been processed and how the ... Continue reading
COMMENTS ON THIS REPORT
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
    My main concern with the manuscript in its current form and the BgeeDB package itself is the lack of clarity on how the data has been processed and how the ... Continue reading
Views
53
Cite
Reviewer Report 14 Dec 2016
Daniel S. Himmelstein, Systems Pharmacology and Translational Therapeutics, Perelman School of Medicine, University of Pennsylvania, Philadelphia, PA, USA 
Approved with Reservations
VIEWS 53
This study describes the BgeeDB R package, which provides a programmatic interface for accessing Bgee gene expression data. Bgee is a valuable resource because it integrates gene expression results across many experiments. Previously, I've used Bgee for its presence/absence of expression ... Continue reading
CITE
CITE
HOW TO CITE THIS REPORT
Himmelstein DS. Reviewer Report For: BgeeDB, an R package for retrieval of curated expression datasets and for gene list expression localization enrichment tests [version 1; peer review: 1 approved, 1 approved with reservations, 1 not approved]. F1000Research 2016, 5:2748 (https://doi.org/10.5256/f1000research.10748.r18221)
NOTE: it is important to ensure the information in square brackets after the title is included in all citations of this article.
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
    In my opinion, Bgee's ability to provide a genome-wide profile of expression for a given species, developmental stage, and anatomical structure is its most powerful capability. It was not clear ... Continue reading
COMMENTS ON THIS REPORT
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
    In my opinion, Bgee's ability to provide a genome-wide profile of expression for a given species, developmental stage, and anatomical structure is its most powerful capability. It was not clear ... Continue reading
Views
55
Cite
Reviewer Report 07 Dec 2016
Virag Sharma, Max Planck Institute of Molecular Cell Biology and Genetics (MPI-CBG), Dresden, Germany;  Max Planck Institute for the Physics of Complex Systems, Dresden, Germany 
Approved
VIEWS 55
In the manuscript, Komljenovic et al. present BgeeDB which is an R package for retrieval of expression datasets which have been curated. Additionally, they also provide a method (TopAnat) to determine tissue-specific enrichments for a given list of genes and ... Continue reading
CITE
CITE
HOW TO CITE THIS REPORT
Sharma V. Reviewer Report For: BgeeDB, an R package for retrieval of curated expression datasets and for gene list expression localization enrichment tests [version 1; peer review: 1 approved, 1 approved with reservations, 1 not approved]. F1000Research 2016, 5:2748 (https://doi.org/10.5256/f1000research.10748.r17925)
NOTE: it is important to ensure the information in square brackets after the title is included in all citations of this article.
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
     The authors should include some details about how they have reprocessed the gene expression datasets that are a part of BgeeDB. At the moment, it is rather unclear how this ... Continue reading
COMMENTS ON THIS REPORT
  • Author Response 07 Aug 2018
    Frederic Bastian, SIB Swiss Institute of Bioinformatics, Lausanne, Switzerland
    07 Aug 2018
    Author Response
     The authors should include some details about how they have reprocessed the gene expression datasets that are a part of BgeeDB. At the moment, it is rather unclear how this ... Continue reading

Comments on this article Comments (0)

Version 2
VERSION 2 PUBLISHED 23 Nov 2016
Comment
Alongside their report, reviewers assign a status to the article:
Approved - the paper is scientifically sound in its current form and only minor, if any, improvements are suggested
Approved with reservations - A number of small changes, sometimes more significant revisions are required to address specific details and improve the papers academic merit.
Not approved - fundamental flaws in the paper seriously undermine the findings and conclusions