if (!requireNamespace("BiocManager", quietly = TRUE))
    install.packages("BiocManager")
BiocManager::install("SingleCellMultiModal")library(SingleCellMultiModal)
library(MultiAssayExperiment)SCoPE2 is a mass spectrometry (MS)-based single-cell proteomics protocol to quantify the proteome of single-cells in an untargeted fashion. It was initially developed by Specht et al. (2020).
The user can see the available data set by using the default options.
SCoPE2("macrophage_differentiation", 
       mode = "*", 
       version = "1.0.0", 
       dry.run = TRUE)## snapshotDate(): 2020-10-27##    ah_id       mode file_size           rdataclass rdatadateadded
## 1 EH4694    protein   33.1 Mb SingleCellExperiment     2020-09-24
## 2 EH4695 rna_assays   68.7 Mb           HDF5Matrix     2020-09-24
## 3 EH4696     rna_se    0.2 Mb SingleCellExperiment     2020-09-24
##   rdatadateremoved
## 1             <NA>
## 2             <NA>
## 3             <NA>Or by simply running:
SCoPE2("macrophage_differentiation")## snapshotDate(): 2020-10-27##    ah_id       mode file_size           rdataclass rdatadateadded
## 1 EH4694    protein   33.1 Mb SingleCellExperiment     2020-09-24
## 2 EH4695 rna_assays   68.7 Mb           HDF5Matrix     2020-09-24
## 3 EH4696     rna_se    0.2 Mb SingleCellExperiment     2020-09-24
##   rdatadateremoved
## 1             <NA>
## 2             <NA>
## 3             <NA>Currently, only the macrophage_differentiation is available.
You can use retrieve the actual data from ExperimentHub by setting
dry.run = FALSE. This example retrieves the complete data set
(transcriptome and proteome) for the macrophage_differentiation
project:
scope2 <- SCoPE2("macrophage_differentiation",
                 modes = "rna|protein",
                 dry.run = FALSE)
scope2## A MultiAssayExperiment object of 2 listed
##  experiments with user-defined names and respective classes.
##  Containing an ExperimentList class object of length 2:
##  [1] macrophage_protein: SingleCellExperiment with 3042 rows and 1490 columns
##  [2] macrophage_rna: SingleCellExperiment with 32738 rows and 20274 columns
## Functionality:
##  experiments() - obtain the ExperimentList instance
##  colData() - the primary/phenotype DataFrame
##  sampleMap() - the sample coordination DataFrame
##  `$`, `[`, `[[` - extract colData columns, subset, or experiment
##  *Format() - convert into a long or wide DataFrame
##  assays() - convert ExperimentList to a SimpleList of matrices
##  exportClass() - save all data to filesThis data set has been acquired by the Slavov Lab (Specht et al. (2020)). It contains single-cell proteomics and single-cell RNA sequencing data for macrophages and monocytes. The object of the research that lead to generate this data is to understand whether homogeneous monocytes differentiate in the absence of cytokines to macrophage with homogeneous or heterogeneous profiles. The transcriptomic and proteomic acquisitions are conducted on two separate subset of similar cells (same experimental design). The cell type of the samples are known only for the proteomics data. The proteomics data was retrieved from the authors’ website and the transcriptomic data was retrieved from the GEO database (accession id: GSE142392).
For more information on the protocol, see Specht et al. (2020).
Only version 1.0.0 is currently available.
The macrophage_differentiation data set in this package contains two
assays: macrophage_rna and macrophage_protein.
The single-cell proteomics data contains cell type annotation
(celltype), sample preparation batch (batch_digest and
batch_sort), chromatography batch (batch_chromatography), and the
MS acquisition run (batch_MS). The single-cell transcriptomics data
was acquired in two batches (batch_Chromium). Note that because the
cells that compose the two assays are distinct, there is no common
cell annotation available for both proteomics and transcriptomics. The
annotation were therefore filled with NAs accordingly.
colData(scope2)## DataFrame with 21764 rows and 6 columns
##                         celltype batch_digest  batch_sort batch_chromatography
##                      <character>  <character> <character>          <character>
## AAACCTGAGAAACCAT-1.1          NA           NA          NA                   NA
## AAACCTGAGACTAGGC-1.2          NA           NA          NA                   NA
## AAACCTGAGAGGTAGA-1.2          NA           NA          NA                   NA
## AAACCTGAGATGCGAC-1.1          NA           NA          NA                   NA
## AAACCTGAGGCTAGGT-1.1          NA           NA          NA                   NA
## ...                          ...          ...         ...                  ...
## i985                  Macrophage            Q          s8                LCA10
## i986                    Monocyte            Q          s8                LCA10
## i987                    Monocyte            Q          s8                LCA10
## i998                    Monocyte            R          s9                 LCB3
## i999                    Monocyte            R          s9                 LCB3
##                                    batch_MS batch_Chromium
##                                 <character>       <factor>
## AAACCTGAGAAACCAT-1.1                     NA              1
## AAACCTGAGACTAGGC-1.2                     NA              2
## AAACCTGAGAGGTAGA-1.2                     NA              2
## AAACCTGAGATGCGAC-1.1                     NA              1
## AAACCTGAGGCTAGGT-1.1                     NA              1
## ...                                     ...            ...
## i985                 X190321S_LCA10_X_FP9..             NA
## i986                 X190321S_LCA10_X_FP9..             NA
## i987                 X190321S_LCA10_X_FP9..             NA
## i998                 X190914S_LCB3_X_16pl..             NA
## i999                 X190914S_LCB3_X_16pl..             NAYou can extract and check the transcriptomic data through subsetting:
scope2[["rna"]]## NULLThe data is rather large and is therefore stored on-disk using the HDF5 backend. You can verify this by looking at the assay data matrix. Note that the counts are UMI counts.
assay(scope2[["rna"]])[1:5, 1:5]## NULLThe protein assay contains MS-based proteomic data.
The data have been passed sample and feature quality control,
normalized, log transformed, imputed and batch corrected. See
reference for more details about data processing. You can extract the
proteomic data similarly to the transcriptomic data:
scope2[["protein"]]## NULLIn this case, the protein data have reasonable size and are loaded
directly into memory. The data matrix is stored in logexprs. We
decided to not use the traditional logcounts because MS proteomics
measures intensities rather than counts as opposed to scRNA-Seq.
assay(scope2[["protein"]])[1:5, 1:5]## NULLsessionInfo()## R version 4.0.3 (2020-10-10)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.5 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.12-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.12-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] rhdf5_2.34.0                scater_1.18.3              
##  [3] ggplot2_3.3.3               scran_1.18.3               
##  [5] SingleCellExperiment_1.12.0 SingleCellMultiModal_1.2.4 
##  [7] MultiAssayExperiment_1.16.0 SummarizedExperiment_1.20.0
##  [9] Biobase_2.50.0              GenomicRanges_1.42.0       
## [11] GenomeInfoDb_1.26.2         IRanges_2.24.1             
## [13] S4Vectors_0.28.1            BiocGenerics_0.36.0        
## [15] MatrixGenerics_1.2.0        matrixStats_0.57.0         
## [17] BiocStyle_2.18.1           
## 
## loaded via a namespace (and not attached):
##   [1] SpatialExperiment_1.0.0       ggbeeswarm_0.6.0             
##   [3] colorspace_2.0-0              HCAMatrixBrowser_1.0.1       
##   [5] ellipsis_0.3.1                scuttle_1.0.4                
##   [7] bluster_1.0.0                 futile.logger_1.4.3          
##   [9] XVector_0.30.0                BiocNeighbors_1.8.2          
##  [11] farver_2.0.3                  bit64_4.0.5                  
##  [13] RSpectra_0.16-0               interactiveDisplayBase_1.28.0
##  [15] AnnotationDbi_1.52.0          codetools_0.2-18             
##  [17] sparseMatrixStats_1.2.0       cachem_1.0.1                 
##  [19] knitr_1.31                    jsonlite_1.7.2               
##  [21] dbplyr_2.0.0                  uwot_0.1.10                  
##  [23] HDF5Array_1.18.0              shiny_1.6.0                  
##  [25] BiocManager_1.30.10           compiler_4.0.3               
##  [27] httr_1.4.2                    dqrng_0.2.1                  
##  [29] assertthat_0.2.1              Matrix_1.3-2                 
##  [31] fastmap_1.1.0                 limma_3.46.0                 
##  [33] later_1.1.0.1                 BiocSingular_1.6.0           
##  [35] formatR_1.7                   htmltools_0.5.1.1            
##  [37] tools_4.0.3                   rsvd_1.0.3                   
##  [39] igraph_1.2.6                  gtable_0.3.0                 
##  [41] glue_1.4.2                    GenomeInfoDbData_1.2.4       
##  [43] dplyr_1.0.3                   rappdirs_0.3.2               
##  [45] Rcpp_1.0.6                    rapiclient_0.1.3             
##  [47] rhdf5filters_1.2.0            vctrs_0.3.6                  
##  [49] ExperimentHub_1.16.0          DelayedMatrixStats_1.12.2    
##  [51] AnVIL_1.2.0                   xfun_0.20                    
##  [53] stringr_1.4.0                 beachmat_2.6.4               
##  [55] mime_0.9                      lifecycle_0.2.0              
##  [57] irlba_2.3.3                   statmod_1.4.35               
##  [59] AnnotationHub_2.22.0          edgeR_3.32.1                 
##  [61] zlibbioc_1.36.0               scales_1.1.1                 
##  [63] promises_1.1.1                lambda.r_1.2.4               
##  [65] yaml_2.2.1                    curl_4.3                     
##  [67] memoise_2.0.0                 gridExtra_2.3                
##  [69] UpSetR_1.4.0                  stringi_1.5.3                
##  [71] RSQLite_2.2.3                 highr_0.8                    
##  [73] BiocVersion_3.12.0            BiocParallel_1.24.1          
##  [75] rlang_0.4.10                  pkgconfig_2.0.3              
##  [77] bitops_1.0-6                  evaluate_0.14                
##  [79] lattice_0.20-41               Rhdf5lib_1.12.1              
##  [81] purrr_0.3.4                   labeling_0.4.2               
##  [83] cowplot_1.1.1                 bit_4.0.4                    
##  [85] tidyselect_1.1.0              RcppAnnoy_0.0.18             
##  [87] plyr_1.8.6                    magrittr_2.0.1               
##  [89] bookdown_0.21                 R6_2.5.0                     
##  [91] magick_2.6.0                  generics_0.1.0               
##  [93] DelayedArray_0.16.1           DBI_1.1.1                    
##  [95] pillar_1.4.7                  withr_2.4.1                  
##  [97] RCurl_1.98-1.2                tibble_3.0.5                 
##  [99] crayon_1.3.4                  futile.options_1.0.1         
## [101] BiocFileCache_1.14.0          rmarkdown_2.6                
## [103] viridis_0.5.1                 locfit_1.5-9.4               
## [105] grid_4.0.3                    blob_1.2.1                   
## [107] digest_0.6.27                 xtable_1.8-4                 
## [109] httpuv_1.5.5                  munsell_0.5.0                
## [111] beeswarm_0.2.3                viridisLite_0.3.0            
## [113] vipor_0.4.5Specht, Harrison, Edward Emmott, Aleksandra A Petelski, R Gray Huffman, David H Perlman, Marco Serra, Peter Kharchenko, Antonius Koller, and Nikolai Slavov. 2020. “Single-Cell Proteomic and Transcriptomic Analysis of Macrophage Heterogeneity.” bioRxiv.