The HighlyReplicatedRNASeq package provides functions to access the count matrix from bulk RNA-seq studies with many replicates. For example,the study from Schurch et al. (2016) has data on 86 samples of S. cerevisiae in two conditions.
To load the dataset, call the Schurch16() function. It returns a SummarizedExperiment:
schurch_se <- HighlyReplicatedRNASeq::Schurch16()
#> snapshotDate(): 2021-05-05
#> see ?HighlyReplicatedRNASeq and browseVignettes('HighlyReplicatedRNASeq') for documentation
#> loading from cache
#> see ?HighlyReplicatedRNASeq and browseVignettes('HighlyReplicatedRNASeq') for documentation
#> loading from cache
schurch_se
#> class: SummarizedExperiment 
#> dim: 7126 86 
#> metadata(0):
#> assays(1): counts
#> rownames(7126): 15S_rRNA 21S_rRNA ... tY(GUA)O tY(GUA)Q
#> rowData names(0):
#> colnames(86): wildtype_01 wildtype_02 ... knockout_47 knockout_48
#> colData names(4): file_name condition replicate nameAn alternative approach that achieves exactly the same is to load the data directly from ExperimentHub
library(ExperimentHub)
eh <- ExperimentHub()
#> snapshotDate(): 2021-05-05
records <- query(eh, "HighlyReplicatedRNASeq")
records[1]           ## display the metadata for the first resource
#> ExperimentHub with 1 record
#> # snapshotDate(): 2021-05-05
#> # names(): EH3315
#> # package(): HighlyReplicatedRNASeq
#> # $dataprovider: Geoff Barton's group on GitHub
#> # $species: Saccharomyces cerevisiae BY4741
#> # $rdataclass: matrix
#> # $rdatadateadded: 2020-04-03
#> # $title: Schurch S. cerevesiae Highly Replicated Bulk RNA-Seq Counts
#> # $description: Count matrix for bulk RNA-sequencing dataset from 86 S. cere...
#> # $taxonomyid: 1247190
#> # $genome: Ensembl release 68
#> # $sourcetype: tar.gz
#> # $sourceurl: https://github.com/bartongroup/profDGE48
#> # $sourcesize: NA
#> # $tags: c("ExperimentHub", "ExperimentData", "ExpressionData",
#> #   "SequencingData", "RNASeqData") 
#> # retrieve record with 'object[["EH3315"]]'
count_matrix <- records[["EH3315"]]  ## load the count matrix by ID
#> see ?HighlyReplicatedRNASeq and browseVignettes('HighlyReplicatedRNASeq') for documentation
#> loading from cache
count_matrix[1:10, 1:5]
#>          wildtype_01 wildtype_02 wildtype_03 wildtype_04 wildtype_05
#> 15S_rRNA           2          12          31           8          21
#> 21S_rRNA          20          76         101          99         128
#> HRA1               3           2           2           2           3
#> ICR1              75         123         107         157          98
#> LSR1              60         163         233         163         193
#> NME1              13          14          23          13          29
#> PWR1               0           0           0           0           0
#> Q0010              0           0           0           0           0
#> Q0017              0           0           0           0           0
#> Q0032              0           0           0           0           0It has 7126 genes and 86 samples. The counts are between 0 and 467,000.
summary(c(assay(schurch_se, "counts")))
#>    Min. 1st Qu.  Median    Mean 3rd Qu.    Max. 
#>       0      89     386    1229     924  467550To make the data easier to work with, I will “normalize” the data. First I divide it by the mean of each sample to account for the differential sequencing depth. Then, I apply the log() transformation and add a small number to avoid taking the logarithm of 0.
norm_counts <- assay(schurch_se, "counts")
norm_counts <- log(norm_counts / colMeans(norm_counts) + 0.001)The histogram of the transformed data looks very smooth:
hist(norm_counts, breaks = 100)Finally, let us take a look at the MA-plot of the data and the volcano plot:
wt_mean <- rowMeans(norm_counts[, schurch_se$condition == "wildtype"])
ko_mean <- rowMeans(norm_counts[, schurch_se$condition == "knockout"])
plot((wt_mean+ ko_mean) / 2, wt_mean - ko_mean,
     pch = 16, cex = 0.4, col = "#00000050", frame.plot = FALSE)
abline(h = 0)
pvalues <- sapply(seq_len(nrow(norm_counts)), function(idx){
  tryCatch(
    t.test(norm_counts[idx, schurch_se$condition == "wildtype"], 
         norm_counts[idx, schurch_se$condition == "knockout"])$p.value,
  error = function(err) NA)
})
plot(wt_mean - ko_mean, - log10(pvalues),
     pch = 16, cex = 0.5, col = "#00000050", frame.plot = FALSE)sessionInfo()
#> R version 4.1.0 (2021-05-18)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 20.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so
#> LAPACK: /home/biocbuild/bbs-3.13-bioc/R/lib/libRlapack.so
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=C              
#>  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
#>  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
#>  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
#> [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
#> 
#> attached base packages:
#> [1] parallel  stats4    stats     graphics  grDevices utils     datasets 
#> [8] methods   base     
#> 
#> other attached packages:
#>  [1] HighlyReplicatedRNASeq_1.4.0 ExperimentHub_2.0.0         
#>  [3] AnnotationHub_3.0.0          BiocFileCache_2.0.0         
#>  [5] dbplyr_2.1.1                 SummarizedExperiment_1.22.0 
#>  [7] Biobase_2.52.0               GenomicRanges_1.44.0        
#>  [9] GenomeInfoDb_1.28.0          IRanges_2.26.0              
#> [11] S4Vectors_0.30.0             BiocGenerics_0.38.0         
#> [13] MatrixGenerics_1.4.0         matrixStats_0.58.0          
#> [15] BiocStyle_2.20.0            
#> 
#> loaded via a namespace (and not attached):
#>  [1] httr_1.4.2                    sass_0.4.0                   
#>  [3] bit64_4.0.5                   jsonlite_1.7.2               
#>  [5] bslib_0.2.5.1                 shiny_1.6.0                  
#>  [7] assertthat_0.2.1              interactiveDisplayBase_1.30.0
#>  [9] highr_0.9                     BiocManager_1.30.15          
#> [11] blob_1.2.1                    GenomeInfoDbData_1.2.6       
#> [13] yaml_2.2.1                    BiocVersion_3.13.1           
#> [15] lattice_0.20-44               pillar_1.6.1                 
#> [17] RSQLite_2.2.7                 glue_1.4.2                   
#> [19] digest_0.6.27                 promises_1.2.0.1             
#> [21] XVector_0.32.0                htmltools_0.5.1.1            
#> [23] httpuv_1.6.1                  Matrix_1.3-3                 
#> [25] pkgconfig_2.0.3               magick_2.7.2                 
#> [27] bookdown_0.22                 zlibbioc_1.38.0              
#> [29] purrr_0.3.4                   xtable_1.8-4                 
#> [31] later_1.2.0                   tibble_3.1.2                 
#> [33] KEGGREST_1.32.0               generics_0.1.0               
#> [35] ellipsis_0.3.2                withr_2.4.2                  
#> [37] cachem_1.0.5                  magrittr_2.0.1               
#> [39] crayon_1.4.1                  mime_0.10                    
#> [41] memoise_2.0.0                 evaluate_0.14                
#> [43] fansi_0.4.2                   tools_4.1.0                  
#> [45] lifecycle_1.0.0               stringr_1.4.0                
#> [47] DelayedArray_0.18.0           AnnotationDbi_1.54.0         
#> [49] Biostrings_2.60.0             compiler_4.1.0               
#> [51] jquerylib_0.1.4               rlang_0.4.11                 
#> [53] grid_4.1.0                    RCurl_1.98-1.3               
#> [55] rappdirs_0.3.3                bitops_1.0-7                 
#> [57] rmarkdown_2.8                 DBI_1.1.1                    
#> [59] curl_4.3.1                    R6_2.5.0                     
#> [61] knitr_1.33                    dplyr_1.0.6                  
#> [63] fastmap_1.1.0                 bit_4.0.4                    
#> [65] utf8_1.2.1                    filelock_1.0.2               
#> [67] stringi_1.6.2                 Rcpp_1.0.6                   
#> [69] vctrs_0.3.8                   png_0.1-7                    
#> [71] tidyselect_1.1.1              xfun_0.23