recount
Bioconductor package. This workflow explains in detail how to use the recount
package and how to integrate it with other Bioconductor packages for several analyses that can be carried out with the recount2 resource. In particular, we describe how the coverage count matrices were computed in recount2 as well as different ways of obtaining public metadata, which can facilitate downstream analyses. Step-by-step directions show how to do a gene-level differential expression analysis, visualize base-level genome coverage data, and perform an analyses at multiple feature levels. This workflow thus provides further information to understand the data in recount2 and a compendium of R code to use the data.
R version: R version 3.5.2 (2018-12-20)
Bioconductor version: 3.8
Package: 1.4.2
RNA sequencing (RNA-seq) is now the most widely used high-throughput assay for measuring gene expression. In a typical RNA-seq experiment, several million reads are sequenced per sample. The reads are often aligned to the reference genome using a splice-aware aligner to identify where reads originated. Resulting alignment files are then used to compute count matrices for several analyses such as identifying differentially expressed genes. The Bioconductor project (1) has many contributed packages that specialize in analyzing this type of data and previous workflows have explained how to use them (2–4). Initial steps are typically focused on generating the count matrices. Some pre-computed matrices have been made available via the ReCount project (5) or Bioconductor Experiment data packages such as the airway
dataset (6). The pre-computed count matrices in ReCount have been useful to RNA-seq methods developers and to researchers seeking to avoid the computationally intensive process of creating these matrices. In the years since ReCount was published, hundreds of new RNA-seq projects have been carried out, and researchers have shared the data publicly.
We recently uniformly processed over 70,000 publicly available human RNA-seq samples, and made the data available via the recount2 resource (7) at jhubiostatistics.shinyapps.io/recount/. Samples in recount2 are grouped by project (over 2,000) originating from the Sequence Read Archive, the Genotype-Tissue Expression study (GTEx) and the Cancer Genome Atlas (TCGA). The processed data can be accessed via the recount
Bioconductor package available at bioconductor.org/packages/recount. Together, recount2 and the recount
Bioconductor package should be considered a successor to ReCount.
Due to space constraints, the recount2 publication (7) did not cover how to use the recount
package and other useful information for carrying out analyses with recount2 data. We describe how the count matrices in recount2 were generated. We also review the R code necessary for using the recount2 data, whose details are important because some of this code involves multiple Bioconductor packages and changing default options. We further show: (a) how to augment metadata that comes with datasets with metadata learned from natural language processing of associated papers as well as expression data (b) how to perform differential expression analyses, and (c) how to visualize the base-pair data available from recount2.
The recount2 resource provides expression data summarized at different feature levels to enable novel cross-study analyses. Generally when investigators use the term expression, they think about gene expression. But more information can be extracted from RNA-seq data. Once RNA-seq reads have been aligned to the reference genome it is possible to determine the number of aligned reads overlapping each base-pair resulting in the genome base-pair coverage curve as shown in Figure 1. In the example shown in Figure 1, most of the reads overlap known exons from a gene. Those reads can be used to compute a count matrix at the exon or gene feature levels. Some reads span exon-exon junctions (jx) and while most match the annotation, some do not (jx 3 and 4). An exon-exon junction count matrix can be used to identify differentially expressed junctions, which can show which isoforms are differentially expressed given sufficient coverage. For example, junctions 2 and 5 are unique to isoform 2, while junction 6 is unique to isoform 1. The genome base-pair coverage data can be used with derfinder
(8) to identify expressed regions; some of them could be unannotated exons, which together with the exon-exon junction data could help establish new isoforms.
recount2 provides gene, exon, and exon-exon junction count matrices both in text format and RangedSummarizedExperiment objects (rse) (9) as shown in Figure 2. These rse objects provide information about the expression features (for example gene IDs) and the samples. In this workflow we will explain how to add metadata to the rse objects in recount2 in order to ask biological questions. recount2 also provides coverage data in the form of bigWig files. All four features can be accessed with the recount
Bioconductor package (7). recount
also allows sending queries to snaptron
(10) to search for specific exon-exon junctions.
In this workflow we will use several Bioconductor packages. To reproduce the entirety of this workflow, install the packages using the following code after installing R 3.4.x from CRAN in order to use Bioconductor version 3.5 or newer.
## Install packages from Bioconductor
install.packages("BiocManager")
BiocManager::install(c("recount", "GenomicRanges", "limma", "edgeR", "DESeq2",
"regionReport", "clusterProfiler", "org.Hs.eg.db", "gplots",
"derfinder", "rtracklayer", "GenomicFeatures", "bumphunter",
"derfinderPlot", "sessioninfo"))
Once they are installed, load all the packages with the following code.
library("recount")
library("GenomicRanges")
library("limma")
library("edgeR")
library("DESeq2")
library("regionReport")
library("clusterProfiler")
library("org.Hs.eg.db")
library("gplots")
library("derfinder")
library("rtracklayer")
library("GenomicFeatures")
library("bumphunter")
library("derfinderPlot")
library("sessioninfo")
The most accessible features are the gene, exon and exon-exon junction count matrices. This section explains them in greater detail. Figure 3 shows 16 RNA-seq reads, each 3 base-pairs long, and a reference genome.
Reads in the recount2 resource were aligned with the splice-aware Rail-RNA aligner (11). Figure 4 shows the reads aligned to the reference genome. Some of the reads are split as they span an exon-exon junction. Two of the reads were soft clipped meaning that just a portion of the reads aligned (top left in purple).
In order to compute the gene and exon count matrices we first have to process the annotation, which for recount2 is Gencode v25 (CHR regions) with hg38 coordinates. Although recount
can generate count matrices for other annotations using hg38 coordinates. Figure 5 shows two isoforms for a gene composed of 3 different exons.
The coverage curve is at base-pair resolution, so if we are interested in gene counts we have to be careful not to double count base-pairs 1 through 5 that are shared by exons 1 and 3 (Figure 5). Using the function disjoin()
from GenomicRanges
(12) we identified the distinct exonic sequences (disjoint exons). The following code defines the exon coordinates that match Figure 5 and the resulting disjoint exons for our example gene. The resulting disjoint exons are shown in Figure 6.
library("GenomicRanges")
exons <- GRanges("seq", IRanges(start = c(1, 1, 13), end = c(5, 8, 15)))
exons
## GRanges object with 3 ranges and 0 metadata columns:
## seqnames ranges strand
## <Rle> <IRanges> <Rle>
## [1] seq 1-5 *
## [2] seq 1-8 *
## [3] seq 13-15 *
## -------
## seqinfo: 1 sequence from an unspecified genome; no seqlengths
disjoin(exons)
## GRanges object with 3 ranges and 0 metadata columns:
## seqnames ranges strand
## <Rle> <IRanges> <Rle>
## [1] seq 1-5 *
## [2] seq 6-8 *
## [3] seq 13-15 *
## -------
## seqinfo: 1 sequence from an unspecified genome; no seqlengths
Now that we have disjoint exons, we can compute the base-pair coverage for each of them as shown in Figure 7. That is, for each base-pair that corresponds to exonic sequence, we compute the number of reads overlapping that given base-pair. For example, the first base-pair is covered by 3 different reads and it does not matter whether the reads themselves were soft clipped. Not all reads or bases of a read contribute information to this step, as some do not overlap known exonic sequence (light pink in Figure 7).
With base-pair coverage for the exonic sequences computed, the coverage count for each distinct exon is simply the sum of the base-pair coverage for each base in a given distinct exon. For example, the coverage count for disjoint exon 2 is \(2 + 2 + 3 = 7\) as shown in Figure 8. The gene coverage count is then \(\sum_i^n \texttt{coverage}_i\) where \(n\) is the number of exonic base-pairs for the gene and is equal to the sum of the coverage counts for its disjoint exons as shown in Figure 8.
For the exons, recount2 provides the disjoint exons coverage count matrix. It is possible to reconstruct the exon coverage count matrix by summing the coverage count for the disjoint exons that compose each exon. For example, the coverage count for exon 1 would be the sum of the coverage counts for disjoint exons 1 and 2, that is \(19 + 7 = 26\). Some methods might assume that double counting of the shared base-pairs was performed while others assume or recommend the opposite.
The coverage counts described previously are the ones actually included in the rse objects in recount2 instead of typical read count matrices. This is an important difference to keep in mind as most methods were developed for read count matrices. Part of the sample metadata available from recount2 includes the read length and number of mapped reads. Given a target library size (40 million reads by default), the coverage counts in recount2 can be scaled to read counts for a given library size as shown in Equation (1). Note that the resulting scaled read counts are not necessarily integers so it might be necessary to round them if a differential expression (DE) method assumes integer data.
\[\begin{equation} \frac{\sum_i^n \text{coverage}_i }{\text{Read Length}} * \frac{\text{target}}{\text{mapped}} = \text{scaled read counts} \tag{1} \end{equation}\]From Figure 4 we know that Rail-RNA soft clipped some reads, so a more precise measure than the denominator of Equation (1) is the area under coverage (AUC) which is the sum of the coverage for all base-pairs of the genome, regardless of the annotation as shown in Figure 9. Without soft clipping reads, the AUC would be equal to the number of reads mapped multiplied by the read length. So for our example gene, the scaled counts for a library size of 20 reads would be \(\frac{36}{45} * 20 = 16\) and in general calculated with Equation (2). The following code shows how to compute the AUC given a set of aligned reads and reproduce a portion of Figure 9.
\[\begin{equation} \frac{\sum_i^n \text{coverage}_i }{\text{AUC}} * \text{target} = \text{scaled read counts} \tag{2} \end{equation}\]## Take the example and translate it to R code
library("GenomicRanges")
reads <- GRanges("seq", IRanges(
start = rep(
c(1, 2, 3, 4, 5, 7, 8, 9, 10, 13, 14),
c(3, 1, 2, 1, 2, 1, 2, 1, 2, 4, 1)
), width = rep(
c(1, 3, 2, 3, 1, 2, 1, 3, 2, 3, 2, 1, 3),
c(1, 4, 1, 2, 1, 1, 2, 2, 1, 1, 2, 1, 1)
)
))
## Get the base-level genome coverage curve
cov <- as.integer(coverage(reads)$seq)
## AUC
sum(cov)
## [1] 45
## Code for reproducing the bottom portion of Figure 8.
pdf("base_pair_coverage.pdf", width = 20)
par(mar = c(5, 6, 4, 2) + 0.1)
plot(cov, type = "o", col = "violetred1", lwd = 10, ylim = c(0, 5),
xlab = "Genome", ylab = "Coverage", cex.axis = 2, cex.lab = 3,
bty = "n")
polygon(c(1, seq_len(length(cov)), length(cov)), c(0, cov, 0),
border = NA, density = -1, col = "light blue")
points(seq_len(length(cov)), cov, col = "violetred1", type = "o",
lwd = 10)
dev.off()
The recount
function scale_counts()
computes the scaled read counts for a target library size of 40 million reads and we highly recommend using it before doing other analyses. The following code shows how to use scale_counts()
and that the resulting read counts per sample can be lower than the target size (40 million). This happens when not all mapped reads overlap known exonic base-pairs of the genome. In our example, the gene has a scaled count of 16 reads for a library size of 20 reads, meaning that 4 reads did not overlap exonic sequences.
## Check that the number of reads is less than or equal to 40 million
## after scaling.
library("recount")
rse_scaled <- scale_counts(rse_gene_SRP009615, round = FALSE)
summary(colSums(assays(rse_scaled)$counts)) / 1e6
## Min. 1st Qu. Median Mean 3rd Qu. Max.
## 22.62 29.97 34.00 31.96 34.86 36.78
Data in recount2 can be used for annotation-agnostic analyses and enriching the known annotation. Just like exon and gene coverage count matrices, recount2 provides exon-exon junction count matrices. These matrices can be used to identify new isoforms (Figure 10) or identify differentially expressed isoforms. For example, exon-exon junctions 2, 5 and 6 in Figure 1 are only present in one annotated isoform. Snaptron
(10) allows programatic and high-level queries of the exon-exon junction information and its graphical user interface is specially useful for visualizing this data. Inside R, the recount
function snaptron_query()
can be used for searching specific exon-exon junctions in recount2.
The base-pair coverage data from recount2 can be used together with derfinder
(8) to identify expressed regions of the genome, providing another annotation-agnostic analysis of the expression data. Using the function expressed_regions()
we can identify regions of expression based on a given data set in recount2. These regions might overlap known exons but can also provide information about intron retention events (Figure 11), improve detection of exon boundaries (Figure 12), and help identify new exons (Fig 1) or expressed sequences in intergenic regions. Using coverage_matrix()
we can compute a coverage matrix based on the expressed regions or another set of genomic intervals. The resulting matrix can then be used for a DE analysis, just like the exon, gene and exon-exon junction matrices.
Having reviewed how the coverage counts in recount2 were produced, we can now do a DE analysis. We will use data from 72 individuals spanning the human lifespan, split into 6 age groups with SRA accession SRP045638 (13). The function download_study()
requires a SRA accession which can be found using abstract_search()
. download_study()
can then be used to download the gene coverage count data as well as other expression features. The files are saved in a directory named after the SRA accession, in this case SRP045638.
library("recount")
## Find the project ID by searching abstracts of studies
abstract_search("human brain development by age")
## number_samples species
## 1296 72 human
## abstract
## 1296 RNAseq data of 36 samples across human brain development by age group from LIBD
## project
## 1296 SRP045638
## Download the data if it is not there
if(!file.exists(file.path("SRP045638", "rse_gene.Rdata"))) {
download_study("SRP045638", type = "rse-gene")
}
## 2019-03-01 11:58:30 downloading file rse_gene.Rdata to SRP045638
## Check that the file was downloaded
file.exists(file.path("SRP045638", "rse_gene.Rdata"))
## [1] TRUE
## Load the data
load(file.path("SRP045638", "rse_gene.Rdata"))
The coverage count matrices are provided as RangedSummarizedExperiment objects (rse) (9). These objects store information at the feature level, the samples and the actual count matrix as shown in Figure 1 of Love et al., 2016 (3). Figure 2 shows the actual rse objects provided by recount2 and how to access the different portions of the data. Using a unique sample ID such as the SRA Run ID it is possible to expand the sample metadata. This can be done using the predicted phenotype provided by add_predictions()
(14), pulling information from GEO via find_geo()
and geo_characteristics()
, or with custom code.
Using the colData()
function we can access sample metadata. More information on these metadata is provided in the supplementary material of the recount2 paper (7), and we provide a brief review here. The rse objects for SRA data sets include 21 columns with mostly technical information. The GTEx and TCGA rse objects include additional metadata as available from the raw sources. In particular, we compiled metadata for GTEx using the v6 phenotype information available at gtexportal.org, and we put together a large table of TCGA case and sample information by combining information accumulated across Seven Bridges’ Cancer Genomics Cloud and TCGAbiolinks
(15).
## One row per sample, one column per phenotype variable
dim(colData(rse_gene))
## [1] 72 21
## Mostly technical variables are included
colnames(colData(rse_gene))
## [1] "project"
## [2] "sample"
## [3] "experiment"
## [4] "run"
## [5] "read_count_as_reported_by_sra"
## [6] "reads_downloaded"
## [7] "proportion_of_reads_reported_by_sra_downloaded"
## [8] "paired_end"
## [9] "sra_misreported_paired_end"
## [10] "mapped_read_count"
## [11] "auc"
## [12] "sharq_beta_tissue"
## [13] "sharq_beta_cell_type"
## [14] "biosample_submission_date"
## [15] "biosample_publication_date"
## [16] "biosample_update_date"
## [17] "avg_read_length"
## [18] "geo_accession"
## [19] "bigwig_file"
## [20] "title"
## [21] "characteristics"
Several of these technical variables include the number of reads as reported by SRA, the actual number of reads Rail-RNA was able to download (which might be lower in some cases), the number of reads mapped by Rail-RNA, whether the sample is paired-end or not, the coverage AUC and the average read length (times 2 for paired-end samples). Note that the sample with SRA Run ID SRR2071341 has about 240.8 million reads as reported by SRA, while it has 120.4 million spots reported in https://trace.ncbi.nlm.nih.gov/Traces/sra/?run=SRR2071341; that is because it is a paired-end sample (2 reads per spot). These details are important for those interested in writing alternative scaling functions to scale_counts()
.
## Input reads: number reported by SRA might be larger than number
## of reads Rail-RNA downloaded
colData(rse_gene)[,
c("read_count_as_reported_by_sra", "reads_downloaded")]
## DataFrame with 72 rows and 2 columns
## read_count_as_reported_by_sra reads_downloaded
## <integer> <integer>
## SRR2071341 240797206 240797206
## SRR2071345 82266652 82266652
## SRR2071346 132911310 132911310
## SRR2071347 74051302 74051302
## SRR2071348 250259914 250259914
## ... ... ...
## SRR1554541 186250218 162403466
## SRR1554554 140038024 121793680
## SRR1554535 106244496 91185969
## SRR1554558 200687480 170754145
## SRR1554553 90579486 51803404
summary(
colData(rse_gene)$proportion_of_reads_reported_by_sra_downloaded
)
## Min. 1st Qu. Median Mean 3rd Qu. Max.
## 0.5719 0.9165 0.9788 0.9532 1.0000 1.0000
## AUC information used by scale_counts() by default
head(colData(rse_gene)$auc)
## [1] 22950214241 7553726235 12018044330 7041243857 24062460144 45169026301
## Alternatively, scale_scounts() can use the number of mapped reads
## and other information
colData(rse_gene)[, c("mapped_read_count", "paired_end",
"avg_read_length")]
## DataFrame with 72 rows and 3 columns
## mapped_read_count paired_end avg_read_length
## <integer> <logical> <integer>
## SRR2071341 232970536 TRUE 200
## SRR2071345 78431778 TRUE 200
## SRR2071346 124493632 TRUE 200
## SRR2071347 71742875 TRUE 200
## SRR2071348 242992735 TRUE 200
## ... ... ... ...
## SRR1554541 162329325 TRUE 174
## SRR1554554 121738246 TRUE 173
## SRR1554535 91120421 TRUE 171
## SRR1554558 170648458 TRUE 170
## SRR1554553 51684462 TRUE 114
Other metadata variables included provide more biological information, such as the SHARQ beta tissue and cell type predictions, which are based on processing the abstract of papers. This information is available for some of the SRA projects.
## SHARQ tissue predictions: not present for all studies
head(colData(rse_gene)$sharq_beta_tissue)
## [1] NA NA NA NA NA NA
head(colData(rse_gene_SRP009615)$sharq_beta_tissue)
## [1] "blood" "blood" "blood" "blood" "blood" "blood"
For some data sets we were able to find the GEO accession IDs, which we then used to create the title
and characteristics
variables. If present, the characteristics
information can be used to create additional metadata variables by parsing the CharacterList
in which it is stored. Since the input is free text, sometimes more than one type of wording is used to describe the same information, meaning that we might have to process that information in order to build a more convenient variable, such as a factor vector.
## GEO information was absent for the SRP045638 data set
colData(rse_gene)[, c("geo_accession", "title", "characteristics")]
## DataFrame with 72 rows and 3 columns
## geo_accession title characteristics
## <character> <character> <CharacterList>
## SRR2071341 NA NA NA
## SRR2071345 NA NA NA
## SRR2071346 NA NA NA
## SRR2071347 NA NA NA
## SRR2071348 NA NA NA
## ... ... ... ...
## SRR1554541 NA NA NA
## SRR1554554 NA NA NA
## SRR1554535 NA NA NA
## SRR1554558 NA NA NA
## SRR1554553 NA NA NA
## GEO information for the SRP009615 data set
head(colData(rse_gene_SRP009615)$geo_accession)
## [1] "GSM836270" "GSM836271" "GSM836272" "GSM836273" "GSM847561" "GSM847562"
head(colData(rse_gene_SRP009615)$title, 2)
## [1] "K562 cells with shRNA targeting SRF gene cultured with no doxycycline (uninduced - UI), rep1."
## [2] "K562 cells with shRNA targeting SRF gene cultured with doxycycline for 48 hours (48 hr), rep1."
head(colData(rse_gene_SRP009615)$characteristics, 2)
## CharacterList of length 2
## [[1]] cells: K562 shRNA expression: no treatment: Puromycin
## [[2]] cells: K562 shRNA expression: yes, targeting SRF treatment: Puromycin, doxycycline
## Similar but not exactly the same wording used for two different samples
colData(rse_gene_SRP009615)$characteristics[[1]]
## [1] "cells: K562" "shRNA expression: no" "treatment: Puromycin"
colData(rse_gene_SRP009615)$characteristics[[11]]
## [1] "cell line: K562"
## [2] "shRNA expression: no shRNA expression"
## [3] "treatment: Puromycin"
## Extract the target information
target <- sapply(colData(rse_gene_SRP009615)$characteristics, "[", 2)
target
## [1] "shRNA expression: no"
## [2] "shRNA expression: yes, targeting SRF"
## [3] "shRNA expression: no"
## [4] "shRNA expression: yes targeting SRF"
## [5] "shRNA expression: no shRNA expression"
## [6] "shRNA expression: expressing shRNA targeting EGR1"
## [7] "shRNA expression: no shRNA expression"
## [8] "shRNA expression: expressing shRNA targeting EGR1"
## [9] "shRNA expression: no shRNA expression"
## [10] "shRNA expression: expressing shRNA targeting ATF3"
## [11] "shRNA expression: no shRNA expression"
## [12] "shRNA expression: expressing shRNA targeting ATF3"
## Build a useful factor vector, set the reference level and append the result
## to the colData() slot
target_factor <- sapply(strsplit(target, "targeting "), "[", 2)
target_factor[is.na(target_factor)] <- "none"
target_factor <- factor(target_factor)
target_factor <- relevel(target_factor, "none")
target_factor
## [1] none SRF none SRF none EGR1 none EGR1 none ATF3 none ATF3
## Levels: none ATF3 EGR1 SRF
colData(rse_gene_SRP009615)$target_factor <- target_factor
As shown in Figure 2, we can expand the biological metadata information by adding predictions based on RNA-seq data (14). The predictions include information about sex, sample source (cell line vs tissue), tissue and the sequencing strategy used. To add the predictions, simply use the function add_predictions()
to expand the colData()
slot.
## Before adding predictions
dim(colData(rse_gene))
## [1] 72 21
## Add the predictions
rse_gene <- add_predictions(rse_gene)
## 2019-03-01 11:58:33 downloading the predictions to /tmp/Rtmp2EyYwm/PredictedPhenotypes_v0.0.06.rda
## Loading objects:
## PredictedPhenotypes
## After adding the predictions
dim(colData(rse_gene))
## [1] 72 33
## Explore the variables
colData(rse_gene)[, 22:ncol(colData(rse_gene))]
## DataFrame with 72 rows and 12 columns
## reported_sex predicted_sex accuracy_sex
## <factor> <factor> <numeric>
## SRR2071341 female female 0.862637362637363
## SRR2071345 male male 0.862637362637363
## SRR2071346 male male 0.862637362637363
## SRR2071347 female female 0.862637362637363
## SRR2071348 female female 0.862637362637363
## ... ... ... ...
## SRR1554541 male male 0.862637362637363
## SRR1554554 female female 0.862637362637363
## SRR1554535 male male 0.862637362637363
## SRR1554558 female female 0.862637362637363
## SRR1554553 male male 0.862637362637363
## reported_samplesource predicted_samplesource
## <factor> <factor>
## SRR2071341 NA tissue
## SRR2071345 NA tissue
## SRR2071346 NA tissue
## SRR2071347 NA tissue
## SRR2071348 NA tissue
## ... ... ...
## SRR1554541 NA tissue
## SRR1554554 NA tissue
## SRR1554535 NA tissue
## SRR1554558 NA tissue
## SRR1554553 NA tissue
## accuracy_samplesource reported_tissue predicted_tissue
## <numeric> <factor> <factor>
## SRR2071341 NA NA Brain
## SRR2071345 0.892349726775956 NA Brain
## SRR2071346 NA NA Brain
## SRR2071347 NA NA Brain
## SRR2071348 NA NA Brain
## ... ... ... ...
## SRR1554541 NA NA Brain
## SRR1554554 NA NA Brain
## SRR1554535 NA NA Brain
## SRR1554558 NA NA Brain
## SRR1554553 0.892349726775956 NA Brain
## accuracy_tissue reported_sequencingstrategy
## <numeric> <factor>
## SRR2071341 0.518824712322645 PAIRED
## SRR2071345 0.518824712322645 PAIRED
## SRR2071346 0.518824712322645 PAIRED
## SRR2071347 0.518824712322645 PAIRED
## SRR2071348 0.518824712322645 PAIRED
## ... ... ...
## SRR1554541 0.518824712322645 PAIRED
## SRR1554554 0.518824712322645 PAIRED
## SRR1554535 0.518824712322645 PAIRED
## SRR1554558 0.518824712322645 PAIRED
## SRR1554553 0.518824712322645 PAIRED
## predicted_sequencingstrategy accuracy_sequencingstrategy
## <factor> <numeric>
## SRR2071341 PAIRED 0.908574650610174
## SRR2071345 PAIRED 0.908574650610174
## SRR2071346 PAIRED 0.908574650610174
## SRR2071347 PAIRED 0.908574650610174
## SRR2071348 PAIRED 0.908574650610174
## ... ... ...
## SRR1554541 PAIRED 0.908574650610174
## SRR1554554 PAIRED 0.908574650610174
## SRR1554535 PAIRED 0.908574650610174
## SRR1554558 PAIRED 0.908574650610174
## SRR1554553 PAIRED 0.908574650610174
Ultimately, more sample metadata information could be available elsewhere, which can be useful for analyses. This information might be provided in the paper describing the data, the SRA Run Selector or other sources. As shown in Figure 2, it is possible to append information to the colData()
slot as long as there is a unique sample identifier such as the SRA Run ID.
For our example use case, project SRP045638 has a few extra biologically relevant variables via the SRA Run selector https://trace.ncbi.nlm.nih.gov/Traces/study/?acc=SRP045638. We can download that information into text file named SraRunTable.txt
by default, then load it into R, sort it appropriately and then append it to the colData()
slot. Below we do so for the SRP045638 project.
## Save the information from
## https://trace.ncbi.nlm.nih.gov/Traces/study/?acc=SRP045638
## to a table. We saved the file as SRP045638/SraRunTable.txt.
file.exists(file.path("SRP045638", "SraRunTable.txt"))
## [1] TRUE
## Read the table
sra <- read.table(file.path("SRP045638", "SraRunTable.txt"),
header = TRUE, sep = "\t")
## Explore it
head(sra)
## AssemblyName_s AvgSpotLen_l BioSample_s Experiment_s
## 1 GRCh37 179 SAMN02731372 SRX683791
## 2 GRCh37 179 SAMN02731373 SRX683792
## 3 GRCh37 171 SAMN02999518 SRX683793
## 4 GRCh37 184 SAMN02999519 SRX683794
## 5 GRCh37 182 SAMN02999520 SRX683795
## 6 GRCh37 185 SAMN02999521 SRX683796
## Library_Name_s LoadDate_s MBases_l MBytes_l RIN_s
## 1 R2835_DLPFC_polyA_RNAseq_total 2014-08-21 6452 3571 8.3
## 2 R2857_DLPFC_polyA_RNAseq_total 2014-08-21 6062 2879 8.4
## 3 R2869_DLPFC_polyA_RNAseq_total 2014-08-21 8696 4963 8.7
## 4 R3098_DLPFC_polyA_RNAseq_total 2014-08-21 4479 2643 5.3
## 5 R3452_DLPFC_polyA_RNAseq_total 2014-08-21 11634 6185 9.6
## 6 R3462_DLPFC_polyA_RNAseq_total 2014-08-21 14050 7157 6.4
## ReleaseDate_s Run_s SRA_Sample_s Sample_Name_s age_s disease_s
## 1 2014-11-13 SRR1554533 SRS686961 R2835_DLPFC 67.7800 Control
## 2 2014-11-13 SRR1554534 SRS686962 R2857_DLPFC 40.4200 Control
## 3 2014-11-13 SRR1554535 SRS686963 R2869_DLPFC 41.5800 control
## 4 2014-11-13 SRR1554536 SRS686964 R3098_DLPFC 44.1700 control
## 5 2014-11-13 SRR1554537 SRS686965 R3452_DLPFC -0.3836 control
## 6 2014-11-13 SRR1554538 SRS686966 R3462_DLPFC -0.4027 control
## isolate_s race_s sex_s Assay_Type_s BioProject_s BioSampleModel_s
## 1 DLPFC AA female RNA-Seq PRJNA245228 Human
## 2 DLPFC AA male RNA-Seq PRJNA245228 Human
## 3 R2869 AA male RNA-Seq PRJNA245228 Human
## 4 R3098 AA female RNA-Seq PRJNA245228 Human
## 5 R3452 AA female RNA-Seq PRJNA245228 Human
## 6 R3462 AA female RNA-Seq PRJNA245228 Human
## Consent_s Fraction_s InsertSize_l Instrument_s LibraryLayout_s
## 1 public total 0 Illumina HiSeq 2000 PAIRED
## 2 public total 0 Illumina HiSeq 2000 PAIRED
## 3 public total 0 Illumina HiSeq 2000 PAIRED
## 4 public total 0 Illumina HiSeq 2000 PAIRED
## 5 public total 0 Illumina HiSeq 2000 PAIRED
## 6 public total 0 Illumina HiSeq 2000 PAIRED
## LibrarySelection_s LibrarySource_s Organism_s Platform_s SRA_Study_s
## 1 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## 2 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## 3 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## 4 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## 5 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## 6 cDNA TRANSCRIPTOMIC Homo sapiens ILLUMINA SRP045638
## biomaterial_provider_s tissue_s
## 1 LIBD DLPFC
## 2 LIBD DLPFC
## 3 LIBD DLPFC
## 4 LIBD DLPFC
## 5 LIBD DLPFC
## 6 LIBD DLPFC
## We will remove some trailing '_s' from the variable names
colnames(sra) <- gsub("_s$", "", colnames(sra))
## Choose some variables we want to add
sra_vars <- c("sex", "race", "RIN", "age", "isolate", "disease",
"tissue")
## Re-organize the SRA table based on the SRA Run IDs we have
sra <- sra[match(colData(rse_gene)$run, sra$Run), ]
## Double check the order
identical(colData(rse_gene)$run, as.character(sra$Run))
## [1] TRUE
## Append the variables of interest
colData(rse_gene) <- cbind(colData(rse_gene), sra[, sra_vars])
## Final dimensions
dim(colData(rse_gene))
## [1] 72 40
## Explore result
colData(rse_gene)[, 34:ncol(colData(rse_gene))]
## DataFrame with 72 rows and 7 columns
## sex race RIN age isolate disease tissue
## <factor> <factor> <numeric> <numeric> <factor> <factor> <factor>
## SRR2071341 female AA 8.3 67.78 DLPFC Control DLPFC
## SRR2071345 male AA 8.4 40.42 DLPFC Control DLPFC
## SRR2071346 male AA 8.7 41.58 R2869 control DLPFC
## SRR2071347 female AA 5.3 44.17 R3098 control DLPFC
## SRR2071348 female AA 9.6 -0.3836 R3452 control DLPFC
## ... ... ... ... ... ... ... ...
## SRR1554541 male AA 5.7 -0.3836 R3485 control DLPFC
## SRR1554554 female AA 8.1 0.3041 R3669 control DLPFC
## SRR1554535 male AA 8.7 41.58 R2869 control DLPFC
## SRR1554558 female CAUC 9.1 16.7 R4028 control DLPFC
## SRR1554553 male CAUC 8.4 0.3918 R3652 control DLPFC
Since we have the predicted sex as well as the reported sex via the SRA Run Selector, we can check whether they match.
table("Predicted" = colData(rse_gene)$predicted_sex,
"Observed" = colData(rse_gene)$sex)
## Observed
## Predicted female male
## female 24 4
## male 0 44
## Unassigned 0 0
Now that we have all the metadata available we can perform a DE analysis. The original study for project SRP045638 (13) looked at differences between 6 age groups: prenatal, infant, child, teen, adult and late life. The following code creates these six age groups.
## Create the original 6 age groups
age_bins <- cut( colData(rse_gene)$age, c(-1, 0, 1, 10, 20, 50, Inf),
include.lowest=TRUE )
levels( age_bins ) <- c("prenatal", "infant", "child", "teen", "adult",
"late life")
colData(rse_gene)$age_group <- age_bins
Most of the DE signal from the original study was between the prenatal and postnatal samples. To simplify the analysis, we will focus on this comparison.
## Create prenatal factor
colData(rse_gene)$prenatal <- factor(
ifelse(colData(rse_gene)$age_group == "prenatal", "prenatal",
"postnatal"),
levels = c("prenatal", "postnatal"))
As we saw earlier in Figure 9, it is important to scale the coverage counts to read counts. To highlight the fact that we scaled the counts, we will use a new object name and delete the previous one. However, in practice we would simply overwrite the rse
object with the output of scale_counts(rse)
.
## Scale counts
rse_gene_scaled <- scale_counts(rse_gene)
## To highlight that we scaled the counts
rm(rse_gene)
Having scaled the counts, we then filter out genes that are lowly expressed and extract the count matrix.
## Extract counts and filter out lowly expressed geens
counts <- assays(rse_gene_scaled)$counts
filter <- rowMeans(counts) > 0.5
Now that we have scaled the counts, there are multiple DE packages we could use, as described elsewhere (2,3). Since we have 12 samples per group, which is a moderate number, we will use limma-voom
(16) due to its speed. The model we use tests for DE between prenatal and postnatal samples adjusting for sex and RIN, which is a measure of quality of the input sample. We check the data with multi-dimensional scaling plots (Figures 13 and 14) as well as the mean-variance plot (Figure 15). In a real use case we might have to explore the results with different models and perform sensitivity analyses.
library("limma")
library("edgeR")
## Build DGEList object
dge <- DGEList(counts = counts[filter, ])
## Calculate normalization factors
dge <- calcNormFactors(dge)
## Explore the data
plotMDS(dge, labels = substr(colData(rse_gene_scaled)$prenatal, 1, 2) )