1 Overview

The batchelor package provides the batchCorrect() generic that dispatches on its PARAM argument. Users writing code using batchCorrect() can easily change one method for another by simply modifying the class of object supplied as PARAM. For example:

B1 <- matrix(rnorm(10000), ncol=50) # Batch 1 
B2 <- matrix(rnorm(10000), ncol=50) # Batch 2

# Switching easily between batch correction methods.
m.out <- batchCorrect(B1, B2, PARAM=ClassicMnnParam())
f.out <- batchCorrect(B1, B2, PARAM=FastMnnParam(d=20))
r.out <- batchCorrect(B1, B2, PARAM=RescaleParam(pseudo.count=0))

Developers of other packages can extend this further by adding their batch correction methods to this dispatch system. This improves interoperability across packages by allowing users to easily experiment with different methods.

2 Setting up

You will need to Imports: batchelor, methods in your DESCRIPTION file. You will also need to add import(methods), importFrom(batchelor, "batchCorrect") and importClassesFrom(batchelor, "BatchelorParam") in your NAMESPACE file.

Obviously, you will also need to have a function that implements your batch correction method. For demonstration purposes, we will use an identity function that simply returns the input values1 Not a very good correction, but that’s not the point right now.. This is implemented like so:

noCorrect <- function(...) 
# Takes a set of batches and returns them without modification. 
{
   do.call(cbind, list(...)) 
}

3 Deriving a BatchelorParam subclass

We need to define a new BatchelorParam subclass that instructs the batchCorrect() generic to dispatch to our new method. This is most easily done like so:

NothingParam <- setClass("NothingParam", contains="BatchelorParam")

Note that BatchelorParam itself is derived from a SimpleList and can be modified with standard list operators like $.

nothing <- NothingParam()
nothing
## NothingParam of length 0
nothing$some_value <- 1
nothing
## NothingParam of length 1
## names(1): some_value

If no parameters are set, the default values in the function will be used2 Here there are none in noCorrect(), but presumably your function is more complex than that.. Additional slots can be specified in the class definition if there are important parameters that need to be manually specified by the user.

4 Defining a batchCorrect method

4.1 Input

The batchCorrect() generic looks like this:

batchCorrect
## standardGeneric for "batchCorrect" defined from package "batchelor"
## 
## function (..., batch = NULL, restrict = NULL, subset.row = NULL, 
##     correct.all = FALSE, assay.type = NULL, PARAM) 
## standardGeneric("batchCorrect")
## <bytecode: 0x55f105d8c428>
## <environment: 0x55f105d7f110>
## Methods may be defined for arguments: PARAM
## Use  showMethods(batchCorrect)  for currently available ones.

Any implemented method must accept one or more matrix-like objects containing single-cell gene expression matrices in .... Rows are assumed to be genes and columns are assumed to be cells. If only one object is supplied, batch must be specified to indicate the batches to which each cell belongs.

Alternatively, one or more SingleCellExperiment objects can be supplied, containing the gene expression matrix in the assay.type assay. These should not be mixed with matrix-like objects, i.e., if one object is a SingleCellExperiment, all objects should be SingleCellExperiments.

The subset.row= argument specifies a subset of genes on which to perform the correction. The correct.all= argument specifies whether corrected values should be returned for all genes, by “extrapolating” from the results for the genes that were used3 If your method cannot support this option, setting it to TRUE should raise an error.. See the Output section below for the expected output from each combination of these settings.

The restrict= argument allows users to compute the correction using only a subset of cells in each batch (e.g., from cell controls). The correction is then “extrapolated” to all cells in the batch4 Again, if your method cannot support this, any non-NULL value of restrict should raise an error., such that corrected values are returned for all cells.

4.2 Output

Any implemented method must return a SingleCellExperiment where the first assay contains corrected gene expression values for all genes. Corrected values should be returned for all genes if correct.all=TRUE or subset.row=NULL. If correct.all=FALSE and subset.row is not NULL, values should only be returned for the selected genes.

Cells should be reported in the same order that they are supplied in .... In cases with multiple batches, the cell identities are simply concatenated from successive objects in their specified order, i.e., all cells from the first object (in their provided order), then all cells from the second object, and so on. If there is only a single batch, the order of cells in that batch should be preserved.

The output object should have row names equal to the row names of the input objects. Column names should be equivalent to the concatenated column names of the input objects, unless all are NULL, in which case the column names in the output can be NULL. In situations where some input objects have column names, and others are NULL, those missing column names should be filled in with empty strings. This represents the expected behaviour when cbinding multiple matrices together.

Finally, the colData slot should contain ‘batch’, a vector specifying the batch of origin for each cell.

4.3 Demonstration

Finally, we define a method that calls our noCorrect function while satisfying all of the above input/output requirements. To be clear, it is not mandatory to lay out the code as shown below; this is simply one way that all the requirements can be satisfied. We have used some internal batchelor functions for brevity - please contact us if you find these useful and want them to be exported.

setMethod("batchCorrect", "NothingParam", function(..., batch = NULL, 
    restrict=NULL, subset.row = NULL, correct.all = FALSE, 
    assay.type = "logcounts", PARAM) 
{
    batches <- list(...)
    checkBatchConsistency(batches)

    # Pulling out information from the SCE objects.        
    is.sce <- checkIfSCE(batches)
    if (any(is.sce)) {
        batches[is.sce] <- lapply(batches[is.sce], assay, i=assay.type)
    }

    # Subsetting by 'batch', if only one object is supplied. 
    do.split <- length(batches)==1L
    if (do.split) {
        divided <- divideIntoBatches(batches[[1]], batch=batch, restrict=restrict)
        batches <- divided$batches
        restrict <- divided$restricted
    } 

    # Subsetting by row.
    # This is a per-gene "method", so correct.all=TRUE will ignore subset.row.
    # More complex methods will need to handle this differently.
    if (correct.all) {
        subset.row <- NULL
    } else if (!is.null(subset.row)) {
        subset.row <- normalizeSingleBracketSubscript(originals[[1]], subset.row)
        batches <- lapply(batches, "[", i=subset.row, , drop=FALSE)
    }

    # Don't really need to consider restrict!=NULL here, as this function
    # doesn't do anything with the cells anyway.
    output <- do.call(noCorrect, batches)

    # Reordering the output for correctness if it was previously split.
    if (do.split) {
        d.reo <- divided$reorder
        output <- output[,d.reo,drop=FALSE]
    }

    ncells.per.batch <- vapply(batches, FUN=ncol, FUN.VALUE=0L)
    batch.names <- names(batches)
    if (is.null(batch.names)) {
        batch.names <- seq_along(batches)
    }
    
    SingleCellExperiment(list(corrected=output), 
        colData=DataFrame(batch=rep(batch.names, ncells.per.batch)))
})

And it works5 In a strictly programming sense, as the method itself does no correction at all.:

n.out <- batchCorrect(B1, B2, PARAM=NothingParam())
n.out
## class: SingleCellExperiment 
## dim: 200 100 
## metadata(0):
## assays(1): corrected
## rownames: NULL
## rowData names(0):
## colnames: NULL
## colData names(1): batch
## reducedDimNames(0):
## mainExpName: NULL
## altExpNames(0):

Remember to export both the new method and the NothingParam class and constructor.

5 Session information

sessionInfo()
## R version 4.3.2 Patched (2023-11-13 r85521)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.18-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] scater_1.30.1               ggplot2_3.4.4              
##  [3] scran_1.30.0                scuttle_1.12.0             
##  [5] scRNAseq_2.16.0             batchelor_1.18.1           
##  [7] SingleCellExperiment_1.24.0 SummarizedExperiment_1.32.0
##  [9] Biobase_2.62.0              GenomicRanges_1.54.1       
## [11] GenomeInfoDb_1.38.4         IRanges_2.36.0             
## [13] S4Vectors_0.40.2            BiocGenerics_0.48.1        
## [15] MatrixGenerics_1.14.0       matrixStats_1.2.0          
## [17] knitr_1.45                  BiocStyle_2.30.0           
## 
## loaded via a namespace (and not attached):
##   [1] jsonlite_1.8.8                magrittr_2.0.3               
##   [3] magick_2.8.2                  ggbeeswarm_0.7.2             
##   [5] GenomicFeatures_1.54.1        farver_2.1.1                 
##   [7] rmarkdown_2.25                BiocIO_1.12.0                
##   [9] zlibbioc_1.48.0               vctrs_0.6.5                  
##  [11] memoise_2.0.1                 Rsamtools_2.18.0             
##  [13] DelayedMatrixStats_1.24.0     RCurl_1.98-1.13              
##  [15] htmltools_0.5.7               S4Arrays_1.2.0               
##  [17] progress_1.2.3                AnnotationHub_3.10.0         
##  [19] curl_5.2.0                    BiocNeighbors_1.20.1         
##  [21] SparseArray_1.2.3             sass_0.4.8                   
##  [23] bslib_0.6.1                   cachem_1.0.8                 
##  [25] ResidualMatrix_1.12.0         GenomicAlignments_1.38.0     
##  [27] igraph_1.6.0                  mime_0.12                    
##  [29] lifecycle_1.0.4               pkgconfig_2.0.3              
##  [31] rsvd_1.0.5                    Matrix_1.6-4                 
##  [33] R6_2.5.1                      fastmap_1.1.1                
##  [35] GenomeInfoDbData_1.2.11       shiny_1.8.0                  
##  [37] digest_0.6.33                 colorspace_2.1-0             
##  [39] AnnotationDbi_1.64.1          dqrng_0.3.2                  
##  [41] irlba_2.3.5.1                 ExperimentHub_2.10.0         
##  [43] RSQLite_2.3.4                 beachmat_2.18.0              
##  [45] labeling_0.4.3                filelock_1.0.3               
##  [47] fansi_1.0.6                   httr_1.4.7                   
##  [49] abind_1.4-5                   compiler_4.3.2               
##  [51] bit64_4.0.5                   withr_2.5.2                  
##  [53] BiocParallel_1.36.0           viridis_0.6.4                
##  [55] DBI_1.2.0                     highr_0.10                   
##  [57] biomaRt_2.58.0                rappdirs_0.3.3               
##  [59] DelayedArray_0.28.0           rjson_0.2.21                 
##  [61] bluster_1.12.0                tools_4.3.2                  
##  [63] vipor_0.4.7                   beeswarm_0.4.0               
##  [65] interactiveDisplayBase_1.40.0 httpuv_1.6.13                
##  [67] glue_1.6.2                    restfulr_0.0.15              
##  [69] promises_1.2.1                grid_4.3.2                   
##  [71] Rtsne_0.17                    cluster_2.1.6                
##  [73] generics_0.1.3                gtable_0.3.4                 
##  [75] ensembldb_2.26.0              hms_1.1.3                    
##  [77] metapod_1.10.1                BiocSingular_1.18.0          
##  [79] ScaledMatrix_1.10.0           xml2_1.3.6                   
##  [81] utf8_1.2.4                    XVector_0.42.0               
##  [83] ggrepel_0.9.4                 BiocVersion_3.18.1           
##  [85] pillar_1.9.0                  stringr_1.5.1                
##  [87] limma_3.58.1                  later_1.3.2                  
##  [89] dplyr_1.1.4                   BiocFileCache_2.10.1         
##  [91] lattice_0.22-5                rtracklayer_1.62.0           
##  [93] bit_4.0.5                     tidyselect_1.2.0             
##  [95] locfit_1.5-9.8                Biostrings_2.70.1            
##  [97] gridExtra_2.3                 bookdown_0.37                
##  [99] ProtGenerics_1.34.0           edgeR_4.0.3                  
## [101] xfun_0.41                     statmod_1.5.0                
## [103] stringi_1.8.3                 lazyeval_0.2.2               
## [105] yaml_2.3.8                    evaluate_0.23                
## [107] codetools_0.2-19              tibble_3.2.1                 
## [109] BiocManager_1.30.22           cli_3.6.2                    
## [111] xtable_1.8-4                  munsell_0.5.0                
## [113] jquerylib_0.1.4               Rcpp_1.0.11                  
## [115] dbplyr_2.4.0                  png_0.1-8                    
## [117] XML_3.99-0.16                 parallel_4.3.2               
## [119] ellipsis_0.3.2                blob_1.2.4                   
## [121] prettyunits_1.2.0             AnnotationFilter_1.26.0      
## [123] sparseMatrixStats_1.14.0      bitops_1.0-7                 
## [125] viridisLite_0.4.2             scales_1.3.0                 
## [127] purrr_1.0.2                   crayon_1.5.2                 
## [129] rlang_1.1.2                   cowplot_1.1.2                
## [131] KEGGREST_1.42.0