scaeData User Guide
scaeData 1.4.0
scaeData is a complementary package to the Bioconductor package SingleCellAlleleExperiment. It contains three datasets to be used when testing functions in SingleCellAlleleExperiment. These are:
The raw FASTQs for all three datasets were sourced from publicly accessible datasets provided by 10x Genomics.
After downloading the raw data, the scIGD Snakemake workflow was utilized to perform HLA allele-typing processes and generate allele-specific quantification from scRNA-seq data using donor-specific references.
From Bioconductor:
if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")
BiocManager::install("scaeData")Alternatively, a development version is available on GitHub and can be installed via:
if (!require("devtools", quietly = TRUE))
    install.packages("devtools")
devtools::install_github("AGImkeller/scaeData", build_vignettes = TRUE)The datasets within scaeData are accessible using the scaeDataGet() function:
library("scaeData")pbmc_5k <- scaeDataGet("pbmc_5k")
pbmc_10k <- scaeDataGet("pbmc_10k")For example, we can view pbmc_20k:
pbmc_20k <- scaeDataGet("pbmc_20k")## Retrieving barcode identifiers for **pbmc 20k** dataset...DONE## Retrieving feature identifiers for **pbmc 20k** dataset...DONE## Retrieving quantification matrix for **pbmc 20k** dataset...DONEpbmc_20k## $dir
## [1] "/home/biocbuild/.cache/R/ExperimentHub/"
## 
## $barcodes
## [1] "26d3127167ce29_9525"
## 
## $features
## [1] "26d3122d4fef02_9526"
## 
## $matrix
## [1] "26d31261f53f8a_9527"cells.dir <- file.path(pbmc_20k$dir, pbmc_20k$barcodes)
features.dir <- file.path(pbmc_20k$dir, pbmc_20k$features)
mat.dir <- file.path(pbmc_20k$dir, pbmc_20k$matrix)
cells <- utils::read.csv(cells.dir, sep = "", header = FALSE)
features <- utils::read.delim(features.dir, header = FALSE)
mat <- Matrix::readMM(mat.dir)
rownames(mat) <- cells$V1
colnames(mat) <- features$V1
head(mat)## 6 x 62760 sparse Matrix of class "dgTMatrix"##   [[ suppressing 34 column names 'ENSG00000279928.2', 'ENSG00000228037.1', 'ENSG00000142611.17' ... ]]##                                                                               
## AAACCCAAGAAACACT . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
## AAACCCAAGAAACTCA . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
## AAACCCAAGAAATTGC . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
## AAACCCAAGAACAAGG . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
## AAACCCAAGAACAGGA . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
## AAACCCAAGAACCGCA . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . .
##                              
## AAACCCAAGAAACACT . . . ......
## AAACCCAAGAAACTCA . . . ......
## AAACCCAAGAAATTGC . . . ......
## AAACCCAAGAACAAGG . . . ......
## AAACCCAAGAACAGGA . . . ......
## AAACCCAAGAACCGCA . . . ......
## 
##  .....suppressing 62726 columns in show(); maybe adjust options(max.print=, width=)
##  ..............................A SingleCellAlleleExperiment object, scae for short, can be generated using the read_allele_counts() function retrieved from the SingleCellAlleleExperiment package.
A lookup table corresponding to each dataset, facilitating the creation of relevant additional data layers during object generation, can be accessed from the package’s extdata:
lookup <- read.csv(system.file("extdata", "pbmc_20k_lookup_table.csv", package="scaeData"))
library("SingleCellAlleleExperiment")## Loading required package: SingleCellExperiment## Loading required package: SummarizedExperiment## Loading required package: MatrixGenerics## Loading required package: matrixStats## 
## Attaching package: 'MatrixGenerics'## The following objects are masked from 'package:matrixStats':
## 
##     colAlls, colAnyNAs, colAnys, colAvgsPerRowSet, colCollapse,
##     colCounts, colCummaxs, colCummins, colCumprods, colCumsums,
##     colDiffs, colIQRDiffs, colIQRs, colLogSumExps, colMadDiffs,
##     colMads, colMaxs, colMeans2, colMedians, colMins, colOrderStats,
##     colProds, colQuantiles, colRanges, colRanks, colSdDiffs, colSds,
##     colSums2, colTabulates, colVarDiffs, colVars, colWeightedMads,
##     colWeightedMeans, colWeightedMedians, colWeightedSds,
##     colWeightedVars, rowAlls, rowAnyNAs, rowAnys, rowAvgsPerColSet,
##     rowCollapse, rowCounts, rowCummaxs, rowCummins, rowCumprods,
##     rowCumsums, rowDiffs, rowIQRDiffs, rowIQRs, rowLogSumExps,
##     rowMadDiffs, rowMads, rowMaxs, rowMeans2, rowMedians, rowMins,
##     rowOrderStats, rowProds, rowQuantiles, rowRanges, rowRanks,
##     rowSdDiffs, rowSds, rowSums2, rowTabulates, rowVarDiffs, rowVars,
##     rowWeightedMads, rowWeightedMeans, rowWeightedMedians,
##     rowWeightedSds, rowWeightedVars## Loading required package: GenomicRanges## Loading required package: stats4## Loading required package: BiocGenerics## Loading required package: generics## 
## Attaching package: 'generics'## The following objects are masked from 'package:base':
## 
##     as.difftime, as.factor, as.ordered, intersect, is.element, setdiff,
##     setequal, union## 
## Attaching package: 'BiocGenerics'## The following objects are masked from 'package:stats':
## 
##     IQR, mad, sd, var, xtabs## The following objects are masked from 'package:base':
## 
##     Filter, Find, Map, Position, Reduce, anyDuplicated, aperm, append,
##     as.data.frame, basename, cbind, colnames, dirname, do.call,
##     duplicated, eval, evalq, get, grep, grepl, is.unsorted, lapply,
##     mapply, match, mget, order, paste, pmax, pmax.int, pmin, pmin.int,
##     rank, rbind, rownames, sapply, saveRDS, table, tapply, unique,
##     unsplit, which.max, which.min## Loading required package: S4Vectors## 
## Attaching package: 'S4Vectors'## The following object is masked from 'package:utils':
## 
##     findMatches## The following objects are masked from 'package:base':
## 
##     I, expand.grid, unname## Loading required package: IRanges## Loading required package: GenomeInfoDb## Loading required package: Biobase## Welcome to Bioconductor
## 
##     Vignettes contain introductory material; view with
##     'browseVignettes()'. To cite Bioconductor, see
##     'citation("Biobase")', and for packages 'citation("pkgname")'.## 
## Attaching package: 'Biobase'## The following object is masked from 'package:MatrixGenerics':
## 
##     rowMedians## The following objects are masked from 'package:matrixStats':
## 
##     anyMissing, rowMediansscae_20k <- read_allele_counts(pbmc_20k$dir,
                               sample_names = "example_data",
                               filter_mode = "no",
                               lookup_file = lookup,
                               barcode_file = pbmc_20k$barcodes,
                               gene_file = pbmc_20k$features,
                               matrix_file = pbmc_20k$matrix,
                               verbose = TRUE)## Filtering performed on default value at 0 UMI counts.## Data Read_in completed##   Generating SCAE object: Extending rowData with new classifiers##   Generating SCAE object: Filtering at 0 UMI counts.##   Generating SCAE object: Aggregating alleles corresponding to the same gene##   Generating SCAE object: Aggregating genes corresponding to the same functional groups## SingleCellAlleleExperiment object completedscae_20k## class: SingleCellAlleleExperiment 
## dim: 62772 1746519 
## metadata(0):
## assays(1): counts
## rownames(62772): ENSG00000279928.2 ENSG00000228037.1 ... HLA_class_I
##   HLA_class_II
## rowData names(3): Ensembl_ID NI_I Quant_type
## colnames(1746519): AAACCCAAGAAACACT AAACCCAAGAAACTCA ...
##   TTTGTTGTCTTTGCTA TTTGTTGTCTTTGGAG
## colData names(2): Sample Barcode
## reducedDimNames(0):
## mainExpName: NULL
## altExpNames(0):
## ---------------
## Including a total of 29 immune related features:
## Allele-level information (17): A*02:01:01:01 A*24:02:01:01 ...
##   DPB1*03:01:01:01 DPB1*11:01:01:01
## Immune genes (10): HLA-A HLA-B ... HLA-DPA1 HLA-DPB1
## Functional level information (2): HLA_class_I HLA_class_IIPlease refer to the vignette and documentation of SingleCellAlleleExperiment to further work with this kind of data container.
sessionInfo()## R version 4.5.0 RC (2025-04-04 r88126)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.21-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.0  LAPACK version 3.12.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] SingleCellAlleleExperiment_1.4.0 SingleCellExperiment_1.30.0     
##  [3] SummarizedExperiment_1.38.0      Biobase_2.68.0                  
##  [5] GenomicRanges_1.60.0             GenomeInfoDb_1.44.0             
##  [7] IRanges_2.42.0                   S4Vectors_0.46.0                
##  [9] BiocGenerics_0.54.0              generics_0.1.3                  
## [11] MatrixGenerics_1.20.0            matrixStats_1.5.0               
## [13] scaeData_1.4.0                   BiocStyle_2.36.0                
## 
## loaded via a namespace (and not attached):
##  [1] KEGGREST_1.48.0         xfun_0.52               bslib_0.9.0            
##  [4] lattice_0.22-7          vctrs_0.6.5             tools_4.5.0            
##  [7] parallel_4.5.0          curl_6.2.2              tibble_3.2.1           
## [10] AnnotationDbi_1.70.0    RSQLite_2.3.9           blob_1.2.4             
## [13] pkgconfig_2.0.3         Matrix_1.7-3            dbplyr_2.5.0           
## [16] lifecycle_1.0.4         GenomeInfoDbData_1.2.14 compiler_4.5.0         
## [19] Biostrings_2.76.0       codetools_0.2-20        htmltools_0.5.8.1      
## [22] sass_0.4.10             yaml_2.3.10             pillar_1.10.2          
## [25] crayon_1.5.3            jquerylib_0.1.4         BiocParallel_1.42.0    
## [28] DelayedArray_0.34.0     cachem_1.1.0            abind_1.4-8            
## [31] mime_0.13               ExperimentHub_2.16.0    AnnotationHub_3.16.0   
## [34] tidyselect_1.2.1        digest_0.6.37           dplyr_1.1.4            
## [37] purrr_1.0.4             bookdown_0.43           BiocVersion_3.21.1     
## [40] fastmap_1.2.0           grid_4.5.0              SparseArray_1.8.0      
## [43] cli_3.6.4               magrittr_2.0.3          S4Arrays_1.8.0         
## [46] withr_3.0.2             filelock_1.0.3          UCSC.utils_1.4.0       
## [49] rappdirs_0.3.3          bit64_4.6.0-1           rmarkdown_2.29         
## [52] XVector_0.48.0          httr_1.4.7              bit_4.6.0              
## [55] png_0.1-8               memoise_2.0.1           evaluate_1.0.3         
## [58] knitr_1.50              BiocFileCache_2.16.0    rlang_1.1.6            
## [61] glue_1.8.0              DBI_1.2.3               BiocManager_1.30.25    
## [64] jsonlite_2.0.0          R6_2.6.1