--- output: html_document bibliography: ref.bib --- # Feature selection, redux {#more-hvgs} ## Overview [Basic Chapter 3](http://bioconductor.org/books/3.13/OSCA.basic/feature-selection.html#feature-selection) introduced the principles and methodology for feature selection in scRNA-seq data. This chapter provides some commentary on some additional options at each step, including the fine-tuning of the fitted trend in `modelGeneVar()`, how to handle more uninteresting factors of variation with linear models, and the use of coefficient of variation to quantify variation. We also got through a number of other HVG selection strategies that may be of use. ## Fine-tuning the fitted trend The trend fit has several useful parameters (see `?fitTrendVar`) that can be tuned for a more appropriate fit. For example, the defaults can occasionally yield an overfitted trend when the few high-abundance genes are also highly variable. In such cases, users can reduce the contribution of those high-abundance genes by turning off density weights, as demonstrated in Figure \@ref(fig:trend-plot-seger-noweight) with a single donor from the @segerstolpe2016singlecell dataset.
```r #--- loading ---# library(scRNAseq) sce.seger <- SegerstolpePancreasData() #--- gene-annotation ---# library(AnnotationHub) edb <- AnnotationHub()[["AH73881"]] symbols <- rowData(sce.seger)$symbol ens.id <- mapIds(edb, keys=symbols, keytype="SYMBOL", column="GENEID") ens.id <- ifelse(is.na(ens.id), symbols, ens.id) # Removing duplicated rows. keep <- !duplicated(ens.id) sce.seger <- sce.seger[keep,] rownames(sce.seger) <- ens.id[keep] #--- sample-annotation ---# emtab.meta <- colData(sce.seger)[,c("cell type", "disease", "individual", "single cell well quality")] colnames(emtab.meta) <- c("CellType", "Disease", "Donor", "Quality") colData(sce.seger) <- emtab.meta sce.seger$CellType <- gsub(" cell", "", sce.seger$CellType) sce.seger$CellType <- paste0( toupper(substr(sce.seger$CellType, 1, 1)), substring(sce.seger$CellType, 2)) #--- quality-control ---# low.qual <- sce.seger$Quality == "low quality cell" library(scater) stats <- perCellQCMetrics(sce.seger) qc <- quickPerCellQC(stats, percent_subsets="altexps_ERCC_percent", batch=sce.seger$Donor, subset=!sce.seger$Donor %in% c("HP1504901", "HP1509101")) sce.seger <- sce.seger[,!(qc$discard | low.qual)] #--- normalization ---# library(scran) clusters <- quickCluster(sce.seger) sce.seger <- computeSumFactors(sce.seger, clusters=clusters) sce.seger <- logNormCounts(sce.seger) ```
```r library(scran) sce.seger <- sce.seger[,sce.seger$Donor=="HP1507101"] dec.default <- modelGeneVar(sce.seger) dec.noweight <- modelGeneVar(sce.seger, density.weights=FALSE) fit.default <- metadata(dec.default) plot(fit.default$mean, fit.default$var, xlab="Mean of log-expression", ylab="Variance of log-expression") curve(fit.default$trend(x), col="dodgerblue", add=TRUE, lwd=2) fit.noweight <- metadata(dec.noweight) curve(fit.noweight$trend(x), col="red", add=TRUE, lwd=2) legend("topleft", col=c("dodgerblue", "red"), legend=c("Default", "No weight"), lwd=2) ```
Variance in the Segerstolpe pancreas data set as a function of the mean. Each point represents a gene while the lines represent the trend fitted to all genes with default parameters (blue) or without weights (red).

(\#fig:trend-plot-seger-noweight)Variance in the Segerstolpe pancreas data set as a function of the mean. Each point represents a gene while the lines represent the trend fitted to all genes with default parameters (blue) or without weights (red).

## Handling covariates with linear models For experiments with multiple batches, the use of block-specific trends with `block=` in `modelGeneVar()` is the recommended approach for avoiding unwanted variation. However, this is not possible for experimental designs involving multiple unwanted factors of variation and/or continuous covariates. In such cases, we can use the `design=` argument to specify a design matrix with uninteresting factors of variation. This fits a linear model to the expression values for each gene to obtain the residual variance. We illustrate again with the 416B data set, blocking on the plate of origin and oncogene induction. (The same argument is available in `modelGeneVar()` when spike-ins are not available.)
```r #--- loading ---# library(scRNAseq) sce.416b <- LunSpikeInData(which="416b") sce.416b$block <- factor(sce.416b$block) #--- gene-annotation ---# library(AnnotationHub) ens.mm.v97 <- AnnotationHub()[["AH73905"]] rowData(sce.416b)$ENSEMBL <- rownames(sce.416b) rowData(sce.416b)$SYMBOL <- mapIds(ens.mm.v97, keys=rownames(sce.416b), keytype="GENEID", column="SYMBOL") rowData(sce.416b)$SEQNAME <- mapIds(ens.mm.v97, keys=rownames(sce.416b), keytype="GENEID", column="SEQNAME") library(scater) rownames(sce.416b) <- uniquifyFeatureNames(rowData(sce.416b)$ENSEMBL, rowData(sce.416b)$SYMBOL) #--- quality-control ---# mito <- which(rowData(sce.416b)$SEQNAME=="MT") stats <- perCellQCMetrics(sce.416b, subsets=list(Mt=mito)) qc <- quickPerCellQC(stats, percent_subsets=c("subsets_Mt_percent", "altexps_ERCC_percent"), batch=sce.416b$block) sce.416b <- sce.416b[,!qc$discard] #--- normalization ---# library(scran) sce.416b <- computeSumFactors(sce.416b) sce.416b <- logNormCounts(sce.416b) ```
```r design <- model.matrix(~factor(block) + phenotype, colData(sce.416b)) dec.design.416b <- modelGeneVarWithSpikes(sce.416b, "ERCC", design=design) dec.design.416b[order(dec.design.416b$bio, decreasing=TRUE),] ``` ``` ## DataFrame with 46604 rows and 6 columns ## mean total tech bio p.value FDR ## ## Lyz2 6.61097 8.90513 1.50405 7.40107 1.78185e-172 1.28493e-169 ## Ccnb2 5.97776 9.54373 2.24180 7.30192 7.77223e-77 1.44497e-74 ## Gem 5.90225 9.54358 2.35175 7.19183 5.49587e-68 8.12330e-66 ## Cenpa 5.81349 8.65622 2.48792 6.16830 2.08035e-45 1.52796e-43 ## Idh1 5.99343 8.32113 2.21965 6.10148 2.42819e-55 2.41772e-53 ## ... ... ... ... ... ... ... ## Gm5054 2.90434 0.463698 6.77000 -6.30630 1 1 ## Gm12191 3.55920 0.170709 6.53285 -6.36214 1 1 ## Gm7429 3.45394 0.248351 6.63458 -6.38623 1 1 ## Gm16378 2.83987 0.208215 6.74663 -6.53841 1 1 ## Rps2-ps2 3.11324 0.202307 6.78484 -6.58253 1 1 ``` This strategy is simple but somewhat inaccurate as it does not consider the mean expression in each blocking level. To illustrate, assume we have an experiment with two equally-sized batches where the mean-variance trend in each batch is the same as that observed in Figure \@ref(fig:trend-plot-seger-noweight). Imagine that we have two genes with variances lying on this trend; the first gene has an average expression of 0 in one batch and 6 in the other batch, while the second gene with an average expression of 3 in both batches. Both genes would have the same mean across all cells but quite different variances, making it difficult to fit a single mean-variance trend - despite both genes following the mean-variance trend in each of their respective batches! The `block=` approach is safer as it handles the trend fitting and decomposition within each batch, and should be preferred in all situations where it is applicable. ## Using the coefficient of variation An alternative approach to quantification uses the squared coefficient of variation (CV^2^) of the normalized expression values prior to log-transformation. The CV^2^ is a widely used metric for describing variation in non-negative data and is closely related to the dispersion parameter of the negative binomial distribution in packages like *[edgeR](https://bioconductor.org/packages/3.13/edgeR)* and *[DESeq2](https://bioconductor.org/packages/3.13/DESeq2)*. We compute the CV^2^ for each gene in the PBMC dataset using the `modelGeneCV2()` function, which provides a robust implementation of the approach described by @brennecke2013accounting.
```r #--- loading ---# library(DropletTestFiles) raw.path <- getTestFile("tenx-2.1.0-pbmc4k/1.0.0/raw.tar.gz") out.path <- file.path(tempdir(), "pbmc4k") untar(raw.path, exdir=out.path) library(DropletUtils) fname <- file.path(out.path, "raw_gene_bc_matrices/GRCh38") sce.pbmc <- read10xCounts(fname, col.names=TRUE) #--- gene-annotation ---# library(scater) rownames(sce.pbmc) <- uniquifyFeatureNames( rowData(sce.pbmc)$ID, rowData(sce.pbmc)$Symbol) library(EnsDb.Hsapiens.v86) location <- mapIds(EnsDb.Hsapiens.v86, keys=rowData(sce.pbmc)$ID, column="SEQNAME", keytype="GENEID") #--- cell-detection ---# set.seed(100) e.out <- emptyDrops(counts(sce.pbmc)) sce.pbmc <- sce.pbmc[,which(e.out$FDR <= 0.001)] #--- quality-control ---# stats <- perCellQCMetrics(sce.pbmc, subsets=list(Mito=which(location=="MT"))) high.mito <- isOutlier(stats$subsets_Mito_percent, type="higher") sce.pbmc <- sce.pbmc[,!high.mito] #--- normalization ---# library(scran) set.seed(1000) clusters <- quickCluster(sce.pbmc) sce.pbmc <- computeSumFactors(sce.pbmc, cluster=clusters) sce.pbmc <- logNormCounts(sce.pbmc) ```
```r dec.cv2.pbmc <- modelGeneCV2(sce.pbmc) ``` This allows us to model the mean-variance relationship when considering the relevance of each gene (Figure \@ref(fig:cv2-pbmc)). Again, our assumption is that most genes contain random noise and that the trend captures mostly technical variation. Large CV^2^ values that deviate strongly from the trend are likely to represent genes affected by biological structure. If spike-ins are available, we can also fit the trend to the spike-ins via the `modelGeneCV2WithSpikes()` function. ```r fit.cv2.pbmc <- metadata(dec.cv2.pbmc) plot(fit.cv2.pbmc$mean, fit.cv2.pbmc$cv2, log="xy") curve(fit.cv2.pbmc$trend(x), col="dodgerblue", add=TRUE, lwd=2) ```
CV^2^ in the PBMC data set as a function of the mean. Each point represents a gene while the blue line represents the fitted trend.

(\#fig:cv2-pbmc)CV^2^ in the PBMC data set as a function of the mean. Each point represents a gene while the blue line represents the fitted trend.

For each gene, we quantify the deviation from the trend in terms of the ratio of its CV^2^ to the fitted value of trend at its abundance. This is more appropriate than the directly subtracting the trend from the CV^2^, as the magnitude of the ratio is not affected by the mean. ```r dec.cv2.pbmc[order(dec.cv2.pbmc$ratio, decreasing=TRUE),] ``` ``` ## DataFrame with 33694 rows and 6 columns ## mean total trend ratio p.value FDR ## ## PPBP 2.2437397 132.364 0.803689 164.696 0 0 ## PRTFDC1 0.0658743 3197.564 20.266829 157.773 0 0 ## HIST1H2AC 1.3731487 175.035 1.176934 148.721 0 0 ## FAM81B 0.0477082 3654.419 27.902078 130.973 0 0 ## PF4 1.8333127 109.451 0.935484 116.999 0 0 ## ... ... ... ... ... ... ... ## AC023491.2 0 NaN Inf NaN NaN NaN ## AC233755.2 0 NaN Inf NaN NaN NaN ## AC233755.1 0 NaN Inf NaN NaN NaN ## AC213203.1 0 NaN Inf NaN NaN NaN ## FAM231B 0 NaN Inf NaN NaN NaN ``` We can then select HVGs based on the largest ratios using `getTopHVGs()`. ```r hvg.pbmc.cv2 <- getTopHVGs(dec.cv2.pbmc, var.field="ratio", n=1000) str(hvg.pbmc.cv2) ``` ``` ## chr [1:1000] "PPBP" "PRTFDC1" "HIST1H2AC" "FAM81B" "PF4" "GNG11" ... ``` Both the CV^2^ and the variance of log-counts are effective metrics for quantifying variation in gene expression. The CV^2^ tends to give higher rank to low-abundance HVGs driven by upregulation in rare subpopulations, for which the increase in variance on the raw scale is stronger than that on the log-scale. However, the variation described by the CV^2^ is less directly relevant to downstream procedures operating on the log-counts, and the reliance on the ratio can assign high rank to uninteresting genes with low absolute variance. As such, we prefer to use the variance of log-counts for feature selection, though many of the same principles apply to procedures based on the CV^2^. ## More HVG selection strategies ### Keeping all genes above the trend {#feature-selection-positive} Here, the aim is to only remove the obviously uninteresting genes with variances below the trend. By doing so, we avoid the need to make any judgement calls regarding what level of variation is interesting enough to retain. This approach represents one extreme of the bias-variance trade-off where bias is minimized at the cost of maximizing noise. For `modelGeneVar()`, it equates to keeping all positive biological components: ```r dec.pbmc <- modelGeneVar(sce.pbmc) hvg.pbmc.var.3 <- getTopHVGs(dec.pbmc, var.threshold=0) length(hvg.pbmc.var.3) ``` ``` ## [1] 12745 ``` For `modelGeneCV2()`, this involves keeping all ratios above 1: ```r hvg.pbmc.cv2.3 <- getTopHVGs(dec.cv2.pbmc, var.field="ratio", var.threshold=1) length(hvg.pbmc.cv2.3) ``` ``` ## [1] 6643 ``` By retaining all potential biological signal, we give secondary population structure the chance to manifest. This is most useful for rare subpopulations where the relevant markers will not exhibit strong overdispersion owing to the small number of affected cells. It will also preserve a weak but consistent effect across many genes with small biological components; admittedly, though, this is not of major interest in most scRNA-seq studies given the difficulty of experimentally validating population structure in the absence of strong marker genes. The obvious cost is that more noise is also captured, which can reduce the resolution of otherwise well-separated populations and mask the secondary signal that we were trying to preserve. The use of more genes also introduces more computational work in each downstream step. This strategy is thus best suited to very heterogeneous populations containing many different cell types (possibly across many datasets that are to be merged, as in [Multi-sample Chapter 1](http://bioconductor.org/books/3.13/OSCA.multisample/integrating-datasets.html#integrating-datasets)) where there is a justified fear of ignoring marker genes for low-abundance subpopulations under a competitive top $X$ approach. ### Based on significance Another approach to feature selection is to set a fixed threshold of one of the metrics. This is most commonly done with the (adjusted) $p$-value reported by each of the above methods. The $p$-value for each gene is generated by testing against the null hypothesis that the variance is equal to the trend. For example, we might define our HVGs as all genes that have adjusted $p$-values below 0.05. ```r hvg.pbmc.var.2 <- getTopHVGs(dec.pbmc, fdr.threshold=0.05) length(hvg.pbmc.var.2) ``` ``` ## [1] 813 ``` This approach is simple to implement and - if the test holds its size - it controls the false discovery rate (FDR). That is, it returns a subset of genes where the proportion of false positives is expected to be below the specified threshold. This can occasionally be useful in applications where the HVGs themselves are of interest. For example, if we were to use the list of HVGs in further experiments to verify the existence of heterogeneous expression for some of the genes, we would want to control the FDR in that list. The downside of this approach is that it is less predictable than the top $X$ strategy. The number of genes returned depends on the type II error rate of the test and the severity of the multiple testing correction. One might obtain no genes or every gene at a given FDR threshold, depending on the circumstances. Moreover, control of the FDR is usually not helpful at this stage of the analysis. We are not interpreting the individual HVGs themselves but are only using them for feature selection prior to downstream steps. There is no reason to think that a 5% threshold on the FDR yields a more suitable compromise between bias and noise compared to the top $X$ selection. As an aside, we might consider ranking genes by the $p$-value instead of the biological component for use in a top $X$ approach. This results in some counterintuitive behavior due to the nature of the underlying hypothesis test, which is based on the ratio of the total variance to the expected technical variance. Ranking based on $p$-value tends to prioritize HVGs that are more likely to be true positives but, at the same time, less likely to be biologically interesting. Many of the largest ratios are observed in high-abundance genes and are driven by very low technical variance; the total variance is typically modest for such genes, and they do not contribute much to population heterogeneity in absolute terms. (Note that the same can be said of the ratio of CV^2^ values, as briefly discussed above.) ### Selecting _a priori_ genes of interest {#apriori-hvgs} A blunt yet effective feature selection strategy is to use pre-defined sets of interesting genes. The aim is to focus on specific aspects of biological heterogeneity that may be masked by other factors when using unsupervised methods for HVG selection. One example application lies in the dissection of transcriptional changes during the earliest stages of cell fate commitment [@messmer2019transcriptional], which may be modest relative to activity in other pathways (e.g., cell cycle, metabolism). Indeed, if our aim is to show that there is no meaningful heterogeneity in a given pathway, we would - at the very least - be obliged to repeat our analysis using only the genes in that pathway to maximize power for detecting such heterogeneity. Using scRNA-seq data in this manner is conceptually equivalent to a fluorescence activated cell sorting (FACS) experiment, with the convenience of being able to (re)define the features of interest at any time. For example, in the PBMC dataset, we might use some of the C7 immunologic signatures from MSigDB [@godec2016compendium] to improve resolution of the various T cell subtypes. We stress that there is no shame in leveraging prior biological knowledge to address specific hypotheses in this manner. We say this because a common refrain in genomics is that the data analysis should be "unbiased", i.e., free from any biological preconceptions. This is admirable but such "biases" are already present at every stage, starting with experimental design and ending with the interpretation of the data. ```r library(msigdbr) c7.sets <- msigdbr(species = "Homo sapiens", category = "C7") head(unique(c7.sets$gs_name)) ``` ``` ## [1] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_1DY_DN" ## [2] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_1DY_UP" ## [3] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_3DY_DN" ## [4] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_3DY_UP" ## [5] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_6HR_DN" ## [6] "ANDERSON_BLOOD_CN54GP140_ADJUVANTED_WITH_GLA_AF_AGE_18_45YO_6HR_UP" ``` ```r # Using the Goldrath sets to distinguish CD8 subtypes cd8.sets <- c7.sets[grep("GOLDRATH", c7.sets$gs_name),] cd8.genes <- rowData(sce.pbmc)$Symbol %in% cd8.sets$human_gene_symbol summary(cd8.genes) ``` ``` ## Mode FALSE TRUE ## logical 32869 825 ``` ```r # Using GSE11924 to distinguish between T helper subtypes th.sets <- c7.sets[grep("GSE11924", c7.sets$gs_name),] th.genes <- rowData(sce.pbmc)$Symbol %in% th.sets$human_gene_symbol summary(th.genes) ``` ``` ## Mode FALSE TRUE ## logical 31786 1908 ``` ```r # Using GSE11961 to distinguish between B cell subtypes b.sets <- c7.sets[grep("GSE11961", c7.sets$gs_name),] b.genes <- rowData(sce.pbmc)$Symbol %in% b.sets$human_gene_symbol summary(b.genes) ``` ``` ## Mode FALSE TRUE ## logical 28203 5491 ``` Of course, the downside of focusing on pre-defined genes is that it will limit our capacity to detect novel or unexpected aspects of variation. Thus, this kind of focused analysis should be complementary to (rather than a replacement for) the unsupervised feature selection strategies discussed previously. Alternatively, we can invert this reasoning to remove genes that are unlikely to be of interest prior to downstream analyses. This eliminates unwanted variation that could mask relevant biology and interfere with interpretation of the results. Ribosomal protein genes or mitochondrial genes are common candidates for removal, especially in situations with varying levels of cell damage within a population. For immune cell subsets, we might also be inclined to remove immunoglobulin genes and T cell receptor genes for which clonal expression introduces (possibly irrelevant) population structure. ```r # Identifying ribosomal proteins: ribo.discard <- grepl("^RP[SL]\\d+", rownames(sce.pbmc)) sum(ribo.discard) ``` ``` ## [1] 99 ``` ```r # A more curated approach for identifying ribosomal protein genes: c2.sets <- msigdbr(species = "Homo sapiens", category = "C2") ribo.set <- c2.sets[c2.sets$gs_name=="KEGG_RIBOSOME",]$human_gene_symbol ribo.discard <- rownames(sce.pbmc) %in% ribo.set sum(ribo.discard) ``` ``` ## [1] 87 ``` ```r library(AnnotationHub) edb <- AnnotationHub()[["AH73881"]] anno <- select(edb, keys=rowData(sce.pbmc)$ID, keytype="GENEID", columns="TXBIOTYPE") # Removing immunoglobulin variable chains: igv.set <- anno$GENEID[anno$TXBIOTYPE %in% c("IG_V_gene", "IG_V_pseudogene")] igv.discard <- rowData(sce.pbmc)$ID %in% igv.set sum(igv.discard) ``` ``` ## [1] 326 ``` ```r # Removing TCR variable chains: tcr.set <- anno$GENEID[anno$TXBIOTYPE %in% c("TR_V_gene", "TR_V_pseudogene")] tcr.discard <- rowData(sce.pbmc)$ID %in% tcr.set sum(tcr.discard) ``` ``` ## [1] 138 ``` In practice, we tend to err on the side of caution and abstain from preemptive filtering on biological function until these genes are demonstrably problematic in downstream analyses. ## Session Info {-}
``` R version 4.1.0 (2021-05-18) Platform: x86_64-pc-linux-gnu (64-bit) Running under: Ubuntu 20.04.2 LTS Matrix products: default BLAS: /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so LAPACK: /home/biocbuild/bbs-3.13-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] ensembldb_2.16.0 AnnotationFilter_1.16.0 [3] GenomicFeatures_1.44.0 AnnotationDbi_1.54.0 [5] AnnotationHub_3.0.0 BiocFileCache_2.0.0 [7] dbplyr_2.1.1 msigdbr_7.4.1 [9] scran_1.20.0 scuttle_1.2.0 [11] SingleCellExperiment_1.14.0 SummarizedExperiment_1.22.0 [13] Biobase_2.52.0 GenomicRanges_1.44.0 [15] GenomeInfoDb_1.28.0 IRanges_2.26.0 [17] S4Vectors_0.30.0 BiocGenerics_0.38.0 [19] MatrixGenerics_1.4.0 matrixStats_0.58.0 [21] BiocStyle_2.20.0 rebook_1.2.0 loaded via a namespace (and not attached): [1] rjson_0.2.20 ellipsis_0.3.2 [3] bluster_1.2.0 XVector_0.32.0 [5] BiocNeighbors_1.10.0 bit64_4.0.5 [7] interactiveDisplayBase_1.30.0 fansi_0.4.2 [9] codetools_0.2-18 sparseMatrixStats_1.4.0 [11] cachem_1.0.5 knitr_1.33 [13] jsonlite_1.7.2 Rsamtools_2.8.0 [15] cluster_2.1.2 png_0.1-7 [17] graph_1.70.0 shiny_1.6.0 [19] BiocManager_1.30.15 compiler_4.1.0 [21] httr_1.4.2 dqrng_0.3.0 [23] lazyeval_0.2.2 assertthat_0.2.1 [25] Matrix_1.3-3 fastmap_1.1.0 [27] limma_3.48.0 later_1.2.0 [29] BiocSingular_1.8.0 prettyunits_1.1.1 [31] htmltools_0.5.1.1 tools_4.1.0 [33] rsvd_1.0.5 igraph_1.2.6 [35] glue_1.4.2 GenomeInfoDbData_1.2.6 [37] dplyr_1.0.6 rappdirs_0.3.3 [39] Rcpp_1.0.6 jquerylib_0.1.4 [41] vctrs_0.3.8 Biostrings_2.60.0 [43] babelgene_21.4 rtracklayer_1.52.0 [45] DelayedMatrixStats_1.14.0 xfun_0.23 [47] stringr_1.4.0 beachmat_2.8.0 [49] mime_0.10 lifecycle_1.0.0 [51] irlba_2.3.3 restfulr_0.0.13 [53] statmod_1.4.36 XML_3.99-0.6 [55] edgeR_3.34.0 zlibbioc_1.38.0 [57] ProtGenerics_1.24.0 hms_1.1.0 [59] promises_1.2.0.1 yaml_2.2.1 [61] curl_4.3.1 memoise_2.0.0 [63] sass_0.4.0 biomaRt_2.48.0 [65] stringi_1.6.2 RSQLite_2.2.7 [67] BiocVersion_3.13.1 highr_0.9 [69] BiocIO_1.2.0 ScaledMatrix_1.0.0 [71] filelock_1.0.2 BiocParallel_1.26.0 [73] rlang_0.4.11 pkgconfig_2.0.3 [75] bitops_1.0-7 evaluate_0.14 [77] lattice_0.20-44 purrr_0.3.4 [79] GenomicAlignments_1.28.0 CodeDepends_0.6.5 [81] bit_4.0.4 tidyselect_1.1.1 [83] magrittr_2.0.1 bookdown_0.22 [85] R6_2.5.0 generics_0.1.0 [87] metapod_1.0.0 DelayedArray_0.18.0 [89] DBI_1.1.1 withr_2.4.2 [91] pillar_1.6.1 KEGGREST_1.32.0 [93] RCurl_1.98-1.3 tibble_3.1.2 [95] dir.expiry_1.0.0 crayon_1.4.1 [97] utf8_1.2.1 rmarkdown_2.8 [99] progress_1.2.2 locfit_1.5-9.4 [101] grid_4.1.0 blob_1.2.1 [103] digest_0.6.27 xtable_1.8-4 [105] httpuv_1.6.1 bslib_0.2.5.1 ```