TabulaMurisData 1.18.0
The TabulaMurisData data package provides access to the 10x and SmartSeq2
single-cell RNA-seq data sets from
the Tabula Muris Consortium.
The contents of the package can be seen by querying the ExperimentHub for the
package name.
suppressPackageStartupMessages({
    library(ExperimentHub)
    library(SingleCellExperiment)
    library(TabulaMurisData)
})
#> Warning: replacing previous import 'utils::findMatches' by
#> 'S4Vectors::findMatches' when loading 'AnnotationDbi'
eh <- ExperimentHub()
query(eh, "TabulaMurisData")
#> ExperimentHub with 2 records
#> # snapshotDate(): 2023-04-24
#> # $dataprovider: Tabula Muris Consortium
#> # $species: Mus musculus
#> # $rdataclass: SingleCellExperiment
#> # additional mcols(): taxonomyid, genome, description,
#> #   coordinate_1_based, maintainer, rdatadateadded, preparerclass, tags,
#> #   rdatapath, sourceurl, sourcetype 
#> # retrieve records with, e.g., 'object[["EH1617"]]' 
#> 
#>            title               
#>   EH1617 | TabulaMurisDroplet  
#>   EH1618 | TabulaMurisSmartSeq2The individual data sets can be accessed using either their ExperimentHub accession number, or the convenience functions provided in this package. For example, for the 10x data:
droplet <- eh[["EH1617"]]
#> see ?TabulaMurisData and browseVignettes('TabulaMurisData') for documentation
#> loading from cache
droplet
#> class: SingleCellExperiment 
#> dim: 23341 70118 
#> metadata(0):
#> assays(1): counts
#> rownames(23341): 0610005C13Rik 0610007C21Rik ... Zzef1 Zzz3
#> rowData names(2): ID Symbol
#> colnames(70118): 10X_P4_0_AAACCTGAGATTACCC 10X_P4_0_AAACCTGAGTGCCAGA
#>   ... 10X_P8_15_TTTGTCATCTTACCGC 10X_P8_15_TTTGTCATCTTGTTTG
#> colData names(10): cell channel ... cell_ontology_id free_annotation
#> reducedDimNames(0):
#> mainExpName: NULL
#> altExpNames(0):
droplet <- TabulaMurisDroplet()
#> see ?TabulaMurisData and browseVignettes('TabulaMurisData') for documentation
#> loading from cache
droplet
#> class: SingleCellExperiment 
#> dim: 23341 70118 
#> metadata(0):
#> assays(1): counts
#> rownames(23341): 0610005C13Rik 0610007C21Rik ... Zzef1 Zzz3
#> rowData names(2): ID Symbol
#> colnames(70118): 10X_P4_0_AAACCTGAGATTACCC 10X_P4_0_AAACCTGAGTGCCAGA
#>   ... 10X_P8_15_TTTGTCATCTTACCGC 10X_P8_15_TTTGTCATCTTGTTTG
#> colData names(10): cell channel ... cell_ontology_id free_annotation
#> reducedDimNames(0):
#> mainExpName: NULL
#> altExpNames(0):iSEEEach data set is provided in the form of a SingleCellExperiment object. To
gain further insights into the contents of the data sets, they can be explored
using, e.g., the iSEE package. For the purposes of this vignette,
we first subsample a small subset of the cells in the 10x data set, to reduce
the run time.
set.seed(1234)
se <- droplet[, sample(seq_len(ncol(droplet)), 250, replace = FALSE)]
se
#> class: SingleCellExperiment 
#> dim: 23341 250 
#> metadata(0):
#> assays(1): counts
#> rownames(23341): 0610005C13Rik 0610007C21Rik ... Zzef1 Zzz3
#> rowData names(2): ID Symbol
#> colnames(250): 10X_P8_12_ACGGGCTGTCAGAGGT 10X_P7_10_CGTCCATGTTATGCGT
#>   ... 10X_P7_9_TGACAACGTGTAAGTA 10X_P8_14_GATCTAGCACGGCCAT
#> colData names(10): cell channel ... cell_ontology_id free_annotation
#> reducedDimNames(0):
#> mainExpName: NULL
#> altExpNames(0):Next, we calculate size factors and normalize the data using the scran and scater packages, and perform dimension reduction using PCA and t-SNE.
se <- scran::computeSumFactors(se)
se <- scater::logNormCounts(se)
se <- scater::runPCA(se)
se <- scater::runTSNE(se)Finally, we call iSEE with the subsampled SingleCellExperiment object. This
opens up an instance of iSEE containing the provided data set.
if (require(iSEE)) {
    iSEE(se)
}sessionInfo()
#> R version 4.3.0 RC (2023-04-13 r84269)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.17-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_GB              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       
#> 
#> time zone: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] TabulaMurisData_1.18.0      SingleCellExperiment_1.22.0
#>  [3] SummarizedExperiment_1.30.0 Biobase_2.60.0             
#>  [5] GenomicRanges_1.52.0        GenomeInfoDb_1.36.0        
#>  [7] IRanges_2.34.0              S4Vectors_0.38.0           
#>  [9] MatrixGenerics_1.12.0       matrixStats_0.63.0         
#> [11] ExperimentHub_2.8.0         AnnotationHub_3.8.0        
#> [13] BiocFileCache_2.8.0         dbplyr_2.3.2               
#> [15] BiocGenerics_0.46.0         BiocStyle_2.28.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] DBI_1.1.3                     bitops_1.0-7                 
#>   [3] gridExtra_2.3                 rlang_1.1.0                  
#>   [5] magrittr_2.0.3                scater_1.28.0                
#>   [7] compiler_4.3.0                RSQLite_2.3.1                
#>   [9] DelayedMatrixStats_1.22.0     png_0.1-8                    
#>  [11] vctrs_0.6.2                   pkgconfig_2.0.3              
#>  [13] crayon_1.5.2                  fastmap_1.1.1                
#>  [15] XVector_0.40.0                ellipsis_0.3.2               
#>  [17] scuttle_1.10.0                utf8_1.2.3                   
#>  [19] promises_1.2.0.1              rmarkdown_2.21               
#>  [21] ggbeeswarm_0.7.1              purrr_1.0.1                  
#>  [23] bit_4.0.5                     xfun_0.39                    
#>  [25] bluster_1.10.0                zlibbioc_1.46.0              
#>  [27] cachem_1.0.7                  beachmat_2.16.0              
#>  [29] jsonlite_1.8.4                blob_1.2.4                   
#>  [31] later_1.3.0                   DelayedArray_0.26.0          
#>  [33] BiocParallel_1.34.0           interactiveDisplayBase_1.38.0
#>  [35] irlba_2.3.5.1                 parallel_4.3.0               
#>  [37] cluster_2.1.4                 R6_2.5.1                     
#>  [39] bslib_0.4.2                   limma_3.56.0                 
#>  [41] jquerylib_0.1.4               Rcpp_1.0.10                  
#>  [43] bookdown_0.33                 knitr_1.42                   
#>  [45] httpuv_1.6.9                  Matrix_1.5-4                 
#>  [47] igraph_1.4.2                  tidyselect_1.2.0             
#>  [49] viridis_0.6.2                 yaml_2.3.7                   
#>  [51] codetools_0.2-19              curl_5.0.0                   
#>  [53] lattice_0.21-8                tibble_3.2.1                 
#>  [55] shiny_1.7.4                   withr_2.5.0                  
#>  [57] KEGGREST_1.40.0               Rtsne_0.16                   
#>  [59] evaluate_0.20                 Biostrings_2.68.0            
#>  [61] pillar_1.9.0                  BiocManager_1.30.20          
#>  [63] filelock_1.0.2                generics_0.1.3               
#>  [65] RCurl_1.98-1.12               ggplot2_3.4.2                
#>  [67] BiocVersion_3.17.1            munsell_0.5.0                
#>  [69] scales_1.2.1                  sparseMatrixStats_1.12.0     
#>  [71] xtable_1.8-4                  glue_1.6.2                   
#>  [73] metapod_1.8.0                 tools_4.3.0                  
#>  [75] BiocNeighbors_1.18.0          ScaledMatrix_1.8.0           
#>  [77] locfit_1.5-9.7                scran_1.28.0                 
#>  [79] grid_4.3.0                    colorspace_2.1-0             
#>  [81] AnnotationDbi_1.62.0          edgeR_3.42.0                 
#>  [83] GenomeInfoDbData_1.2.10       beeswarm_0.4.0               
#>  [85] BiocSingular_1.16.0           vipor_0.4.5                  
#>  [87] cli_3.6.1                     rsvd_1.0.5                   
#>  [89] rappdirs_0.3.3                fansi_1.0.4                  
#>  [91] viridisLite_0.4.1             dplyr_1.1.2                  
#>  [93] gtable_0.3.3                  sass_0.4.5                   
#>  [95] digest_0.6.31                 ggrepel_0.9.3                
#>  [97] dqrng_0.3.0                   memoise_2.0.1                
#>  [99] htmltools_0.5.5               lifecycle_1.0.3              
#> [101] httr_1.4.5                    statmod_1.5.0                
#> [103] mime_0.12                     bit64_4.0.5