Contents

1 Overview

The muscData package contains a set of publicly available single-cell RNA sequencing (scRNA-seq) datasets with complex experimental designs, i.e., datasets that contain multiple samples (e.g., individuals) measured across multiple experimental conditions (e.g., treatments), formatted into SingleCellExperiment (SCE) Bioconductor objects. Data objects are hosted through Bioconductor’s ExperimentHub web resource.

2 Available datasets

The table below gives an overview of currently available datasets, including a unique identifier (ID) that can be used to load the data (see next section), a brief description, the original data source, and a reference. Dataset descriptions may also be viewed from within R via ?ID (e.g., ?Kang18_8vs8).

ID Description Availability Reference
Kang18_8vs8 10x droplet-based scRNA-seq PBMC data from 8 Lupus patients before and after 6h-treatment with INF-beta (16 samples in total) Gene Expression Ombnibus (GEO) accession GSE96583 Kang et al. (2018)
Crowell19_4vs4 Single-nuclei RNA-seq data of 8 CD-1 male mice, split into 2 groups with 4 animals each: vehicle and peripherally lipopolysaccharaide (LPS) treated mice Figshare DOI:10.6084/m9.figshare.8976473.v1 Crowell et al. (2019)

3 Loading the data

All datasets available within muscData may be loaded either via named functions that directly reffer to the object names, or by using the ExperimentHub interface. Both methods are demonstrated below.

3.1 Via accessor functions

The datasets listed above may be loaded into R by their ID. All provided SCEs contain unfiltered raw counts in their assay slot, and any available gene and cell metadata in the rowData and colData slots, respectively.

library(muscData)
Kang18_8vs8()
## class: SingleCellExperiment 
## dim: 35635 29065 
## metadata(0):
## assays(1): counts
## rownames(35635): MIR1302-10 FAM138A ... MT-ND6 MT-CYB
## rowData names(2): ENSEMBL SYMBOL
## colnames(29065): AAACATACAATGCC-1 AAACATACATTTCC-1 ... TTTGCATGGTTTGG-1
##   TTTGCATGTCTTAC-1
## colData names(5): ind stim cluster cell multiplets
## reducedDimNames(1): TSNE
## altExpNames(0):

3.2 Via ExperimentHub

Besides using an accession function as demonstrated above, we can browse ExperimentHub records (using query) or package specific records (using listResources), and then load the data of interest. The key differences between these approaches is that query will search all of ExperimentHub, while listResources facilitate data discovery within the specified package (here, muscData).

3.2.1 Using query

We first initialize a Hub instance to search for and load available data with the ExperimentHub function, and store the complete list of >2000 records in a variable eh. Using query, we then identify any records made available by muscData, as well as their accession IDs (EH1234). Finally, we can load the data into R via eh[[id]].

# create Hub instance
library(ExperimentHub)
eh <- ExperimentHub()
(q <- query(eh, "muscData"))
## ExperimentHub with 2 records
## # snapshotDate(): 2020-04-27
## # $dataprovider: GEO, F. Hoffmann-La Roche Ltd.
## # $species: Mus musculus, Homo sapiens
## # $rdataclass: SingleCellExperiment
## # additional mcols(): taxonomyid, genome, description,
## #   coordinate_1_based, maintainer, rdatadateadded, preparerclass, tags,
## #   rdatapath, sourceurl, sourcetype 
## # retrieve records with, e.g., 'object[["EH2259"]]' 
## 
##            title         
##   EH2259 | Kang18_8vs8   
##   EH3297 | Crowell19_4vs4
# load data via accession ID
eh[["EH2259"]]

3.2.2 Using list/loadResources

Alternatively, available records may be viewed via listResources. To then load a specific dataset or subset thereof using loadResources, we require a character vector of metadata search terms to filter by.

Available metadata can accessed from the ExperimentHub records found by query via mcols(), or viewed using the accessors shown above with option metadata = TRUE. In the example below, we use "PMBC" and "INF-beta" to select the Kang18_8vs8 dataset. However, note that any metadata keyword(s) that uniquely identify the data of interest could be used (e.g., "Lupus" or "GSE96583").

listResources(eh, "muscData")
## [1] "Kang18_8vs8"    "Crowell19_4vs4"
# view metadata
mcols(q)
Kang18_8vs8(metadata = TRUE)

# load data using metadata search terms
loadResources(eh, "muscData", c("PBMC", "INF-beta"))

4 Exploring the data

The scater (McCarthy et al. 2017) package provides an easy-to-use set of visualization tools for scRNA-seq data.

For interactive visualization, we recommend the iSEE (interactive SummerizedExperiment Explorer) package (Rue-Albrecht et al. 2018), which provides a Shiny-based graphical user interface for exploration of single-cell data in SummarizedExperiment format (installation instructions and user guides are available here).

When available, a great tool for interactive exploration and comparison of dimension-reduced embeddings is sleepwalk (Ovchinnikova and Anders 2019).

5 Session info

sessionInfo()
## R version 4.0.0 (2020-04-24)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.11-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.11-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] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] muscData_1.2.0              SingleCellExperiment_1.10.1
##  [3] SummarizedExperiment_1.18.1 DelayedArray_0.14.0        
##  [5] matrixStats_0.56.0          Biobase_2.48.0             
##  [7] GenomicRanges_1.40.0        GenomeInfoDb_1.24.0        
##  [9] IRanges_2.22.1              S4Vectors_0.26.0           
## [11] ExperimentHub_1.14.0        AnnotationHub_2.20.0       
## [13] BiocFileCache_1.12.0        dbplyr_1.4.3               
## [15] BiocGenerics_0.34.0         BiocStyle_2.16.0           
## 
## loaded via a namespace (and not attached):
##  [1] Rcpp_1.0.4.6                  lattice_0.20-41              
##  [3] assertthat_0.2.1              digest_0.6.25                
##  [5] mime_0.9                      R6_2.4.1                     
##  [7] RSQLite_2.2.0                 evaluate_0.14                
##  [9] httr_1.4.1                    pillar_1.4.4                 
## [11] zlibbioc_1.34.0               rlang_0.4.6                  
## [13] curl_4.3                      blob_1.2.1                   
## [15] Matrix_1.2-18                 rmarkdown_2.1                
## [17] stringr_1.4.0                 RCurl_1.98-1.2               
## [19] bit_1.1-15.2                  shiny_1.4.0.2                
## [21] compiler_4.0.0                httpuv_1.5.2                 
## [23] xfun_0.13                     pkgconfig_2.0.3              
## [25] htmltools_0.4.0               tidyselect_1.0.0             
## [27] tibble_3.0.1                  GenomeInfoDbData_1.2.3       
## [29] interactiveDisplayBase_1.26.0 bookdown_0.18                
## [31] crayon_1.3.4                  dplyr_0.8.5                  
## [33] later_1.0.0                   bitops_1.0-6                 
## [35] rappdirs_0.3.1                grid_4.0.0                   
## [37] xtable_1.8-4                  lifecycle_0.2.0              
## [39] DBI_1.1.0                     magrittr_1.5                 
## [41] stringi_1.4.6                 XVector_0.28.0               
## [43] promises_1.1.0                ellipsis_0.3.0               
## [45] vctrs_0.2.4                   tools_4.0.0                  
## [47] bit64_0.9-7                   glue_1.4.0                   
## [49] purrr_0.3.4                   BiocVersion_3.11.1           
## [51] fastmap_1.0.1                 yaml_2.2.1                   
## [53] AnnotationDbi_1.50.0          BiocManager_1.30.10          
## [55] memoise_1.1.0                 knitr_1.28

References

Crowell, Helena L, Charlotte Soneson, Pierre-Luc Germain, Daniela Calini, Ludovic Collin, Catarina Raposo, Dheeraj Malhotra, and Mark D Robinson. 2019. “On the Discovery of Population-Specific State Transitions from Multi-Sample Multi-Condition Single-Cell RNA Sequencing Data.” bioRxiv 713412.

Kang, Hyun Min, Meena Subramaniam, Sasha Targ, Michelle Nguyen, Lenka Maliskova, Elizabeth McCarthy, Eunice Wan, et al. 2018. “Multiplexed Droplet Single-Cell Rna-Sequencing Using Natural Genetic Variation.” Nat Biotechnol 36 (1):89–94. https://doi.org/10.1038/nbt.4042.

McCarthy, Davis J, Kieran R Campbell, Quin F Wills, and Aaron T L Lun. 2017. “Scater: Pre-Processing, Quality Control, Normalization and Visualization of Single-Cell RNA-Seq Data in R.” Bioinformatics 33 (8):1179–86. https://doi.org/10.1093/bioinformatics/btw777.

Ovchinnikova, Svetlana, and Simon Anders. 2019. “Exploring Dimension-Reduced Embeddings with Sleepwalk.” bioRxiv. Cold Spring Harbor Laboratory. https://doi.org/10.1101/603589.

Rue-Albrecht, Kévin, Federico Marini, Charlotte Soneson, and Aaron T L Lun. 2018. “ISEE: Interactive SummarizedExperiment Explorer.” F1000Res 7:741. https://doi.org/10.12688/f1000research.14966.1.