1.0 Overview of gCrisprTools

Competitive screening experiments, in which bulk cell cultures infected with a heterogeneous viral library are experimentally manipulated to identify guide RNAs or shRNAs that influence cell viability, are conceptually straightforward but often challenging to implement. Here, we present gCrisprTools, an R/Bioconductor analysis suite facilitating quality assessment, target prioritization, and interpretation of arbitrarily complex competitive screening experiments. gCrisprTools provides functionalities for detailed and principled analysis of diverse aspects of these experiments both as a standalone pipeline or as an extension to alternative analytical approaches.

1.1 Installation

Install gCrisprTools in the usual way:

if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")
BiocManager::install("gCrisprTools")

1.4 Explore the Vignettes Folder

This vignette is only one of the resources provided in gCrisprTools to help you understand, analyse, and explore pooled screening data. As appropriate, please see the /vignettes subdirectory for additional documentation describing example code, and the /inst directory for more information about algorithm implementation and package layout.

1.3 Dependencies

gCrisprTools uses the existing Biobase framework for data storage and manipulation and consequently depends heavily on the Biobase and limma packages.

library(Biobase)
library(limma)
library(gCrisprTools)

2.0 Inputs

2.1 Counting Cassettes from Sequencing Data

To use the various methods available in this package, you will first need to conform your screen data into an ExpressionSet object containing cassette abundance counts in the assayData slot, retrievable with exprs(). This package assumes that end users are familiar enough with the R/Bioconductor framework and their own sequencing pipelines to extract raw cassette counts from FASTQ files and to compose them into an ExpressionSet. For newer users read counting may be facilitated with cutadapt or other software designed for these purposes; details about composition of ExpressionSet objects can be found in the Biobase vignette.

2.2 An ExpressionSet of Cassette Counts

Raw cassette counts should be contained within an ExpressionSet object, with the counts retrievable withexprs(). The column names (colnames()) should correspond to unique sample identifiers, and the row names (row.names()) should correspond to identifiers uniquely specifying each cassette of interest.

data("es", package = "gCrisprTools")
es
## ExpressionSet (storageMode: lockedEnvironment)
## assayData: 17214 features, 9 samples 
##   element names: exprs 
## protocolData: none
## phenoData
##   sampleNames: SAMPLE_1 SAMPLE_2 ... SAMPLE_9 (9 total)
##   varLabels: TREATMENT_NAME sizeFactor.crispr-gRNA REPLICATE_POOL
##   varMetadata: labelDescription
## featureData: none
## experimentData: use 'experimentData(object)'
## Annotation:
head(exprs(es))
##               SAMPLE_1 SAMPLE_2  SAMPLE_3  SAMPLE_4  SAMPLE_5  SAMPLE_6
## Target2089_b  24.59438 104.1006  96.22297  27.21276  25.58658  21.98717
## Target1377_d 316.78926 270.2105 284.81543 266.70571 325.01514 351.33774
## Target495_g  160.72282 152.7520 150.99799 148.32776 191.17965 143.76385
## Target160_d  201.28634 201.4035 203.69294 151.06483 238.81601 221.95001
## Target162_e  228.78704 177.7728 173.18534 174.32986 100.44372 227.48532
## Target1684_c 310.60160 212.5238 189.82585 266.70571 372.65150 261.38905
##              SAMPLE_7 SAMPLE_8   SAMPLE_9
## Target2089_b 134.0666 121.5973   37.25687
## Target1377_d 269.6764 359.5304  238.62684
## Target495_g  100.6858 216.9096  527.12806
## Target160_d  177.8790 263.5223  228.94559
## Target162_e  182.0516 237.0853   97.28061
## Target1684_c 154.9297 269.0880 1011.19049
2.3 An Annotation Object

gCrisprTools requires an annotation object mapping the individual cassettes to genes or other genomic features for most applications. The annotation object should be provided as a named data.frame, with columns describing the 'geneID' and 'geneSymbol' of the target elements to which each cassette is annotated. These columns should contain character vectors with elements that uniquely describe the targets in the screen; by convention, the geneID field contains an official identifier that unambiguously describes each target element in a manner suitable for external software (e.g., an Entrez ID). The geneSymbol column indicates a more human-readable descriptor, such as a gene symbol.

The annotation object may optionally contain other columns with additional information about the corresponding cassettes.

data("ann", package = "gCrisprTools")
head(ann)
##                        ID              target geneID chr end start strand size
## Target2089_b Target2089_b CTCAGAGTTGGTCGACTTT  12579 chr   1     1      *   19
## Target1377_d Target1377_d GCCAAAGTACAGCTTGCCC  13395 chr   1     1      *   19
## Target495_g   Target495_g ACGGTACTTGGTCCTCAAT 227733 chr   1     1      *   19
## Target160_d   Target160_d TTGAGAATCTACAATCACG 381813 chr   1     1      *   19
## Target162_e   Target162_e GACAGACACATAAGAAAGG  18391 chr   1     1      *   19
## Target1684_c Target1684_c CAGTCTCTGGCTGTTACGG  20937 chr   1     1      *   19
##              geneSymbol
## Target2089_b Target2089
## Target1377_d Target1377
## Target495_g   Target495
## Target160_d   Target160
## Target162_e   Target162
## Target1684_c Target1684

2.4 A Sample Key

Many gCrisprTools functions require or are enhanced by a sample key detailing the experimental groups of the functions included in the study. This key should be provided as a named factor, with names perfectly matching the colnames of the ExpressionSet. The first level of the sample key should correspond to the 'control' condition, indexing samples whose cassette distributions are expected to be the minimally distorted by experimental treatments.

sk <- relevel(as.factor(pData(es)$TREATMENT_NAME), "ControlReference")
names(sk) <- row.names(pData(es))
sk
##         SAMPLE_1         SAMPLE_2         SAMPLE_3         SAMPLE_4 
## ControlExpansion ControlReference ControlReference ControlExpansion 
##         SAMPLE_5         SAMPLE_6         SAMPLE_7         SAMPLE_8 
##   DeathExpansion ControlExpansion   DeathExpansion ControlReference 
##         SAMPLE_9 
##   DeathExpansion 
## Levels: ControlReference ControlExpansion DeathExpansion

2.5 Alignment Statistics

Users may provide a matrix of alignment statistics to enhance some applications, including QC reporting. These should be provided as a numeric matrix in which rows correspond to targets (reads containing a target cassette), nomatch (reads containing a cassette sequence but not a known target sequence), rejections (reads not containg a cassette sequence), and double_match (reads derived from multiple cassettes). The column names should exactly match the colnames() of the ExpressionSet object. Simple charting functionality is also provided to inspect the alignment rates of each sample.

data("aln", package = "gCrisprTools")
head(aln)
##              SAMPLE_1 SAMPLE_2 SAMPLE_3 SAMPLE_4 SAMPLE_5 SAMPLE_6 SAMPLE_7
## targets       7004519  6183983  5738954  6309065  6615134  6156333  7792838
## nomatch        743882   607080   561278   667729   540513   648896   652940
## rejections    1428342  1122692  1148612  1232306  1145034   963777  1336762
## double_match    32428    18729    16854    23830    22156    27811    32852
##              SAMPLE_8 SAMPLE_9
## targets       7934066  5646518
## nomatch        786835   470447
## rejections    1591687  1006863
## double_match    23152    25757
ct.alignmentChart(aln, sk)

plot of chunk unnamed-chunk-6

3.0 Preprocess Raw Data

gCrisprTools provides tools for common data preprocessing steps, including eliminating underinfected or contaminant cassettes and sample-level normalization.

3.1 ct.filterReads

Low abundance cassettes can be removed by specifying a minimum number of counts or a level relative to the trimmed distribution maximum.

es.floor <- ct.filterReads(es, read.floor = 30, sampleKey = sk)
## Using the supplied minimum threshold of 30 reads for each guide.

plot of chunk unnamed-chunk-7

es <- ct.filterReads(es, trim = 1000, log2.ratio = 4, sampleKey = sk)

plot of chunk unnamed-chunk-7

##Convenience function for conforming the annotation object to exclude the trimmed gRNAs
ann <- ct.prepareAnnotation(ann, es, controls = "NoTarget")
## 307 elements defined in the annotation file are not present in row names of the specified object. Omitting.
3.2 ct.normalizeGuides

A suite of normalization tools are provided with the ct.normalizeGuides() wrapper function; see the relevant manual pages for further details about these methods.

es <- ct.normalizeGuides(es, 'scale', annotation = ann, sampleKey = sk, plot.it = TRUE)

plot of chunk unnamed-chunk-8

es.norm <- ct.normalizeGuides(es, 'slope', annotation = ann, sampleKey = sk, plot.it = TRUE)

plot of chunk unnamed-chunk-8

es.norm <- ct.normalizeGuides(es, 'controlScale', annotation = ann, sampleKey = sk, plot.it = TRUE, geneSymb = 'NoTarget')

plot of chunk unnamed-chunk-8

es.norm <- ct.normalizeGuides(es, 'controlSpline', annotation = ann, sampleKey = sk, plot.it = TRUE, geneSymb = 'NoTarget')

plot of chunk unnamed-chunk-8

3.3 ct.makeQCReport

For convenience, experiment-level dynamics and the effects of various preprocessing steps may be automatically summarized in the form of a report. The following code isn't run as part of this vignette, but if run from the terminal path2QC will indicate the path to an html Quality Control report.

#Not run:
path2QC <- ct.makeQCReport(es,
                 trim = 1000,
                 log2.ratio = 0.05,
                 sampleKey = sk,
                 annotation = ann,
                 aln = aln,
                 identifier = 'Crispr_QC_Report',
                 lib.size = NULL
                 )

4.0 Quality Assessment

The gCrisprTools package provides a series of functions for assessing distributional and technical properties of sequencing libraries. Please see additional details about all of these methods on their respective manual pages.

4.1 ct.rawCountDensities

The raw cassette count distributions can be visualized to determine whether samples were inadequately sequenced or if PCR amplification artifacts might be present.

ct.rawCountDensities(es, sk)

plot of chunk unnamed-chunk-10

4.2 ct.gRNARankByReplicate

Aspects of cassette distributions are often better visualized with a 'waterfall' plot than a standard density estimate, which can clarify the ranking relationships in specific parts of the distribution.

ct.gRNARankByReplicate(es, sk)  #Visualization of gRNA abundance distribution

plot of chunk unnamed-chunk-11

These plots also enable explicit visualization of cassettes of interest in the context of the experimental distribution.

ct.gRNARankByReplicate(es, sk, annotation = ann, geneSymb = "Target1633")

plot of chunk unnamed-chunk-12

4.3 ct.viewControls

gCrisprTools provides tools for visualizing the behavior of control gRNAs across experimental conditions.

ct.viewControls(es, ann, sk, normalize = FALSE, geneSymb = 'NoTarget')

plot of chunk unnamed-chunk-13

4.4 ct.guideCDF

Depending on the screen in question, it can be useful to quantify the extent to which experimental libraries have been distorted by experimental treatments. gCrisprTools provides tools to estimate an empirical cumulative distribution function describing the cassettes or (targets) within a screen.

ct.guideCDF(es, sk, plotType = "gRNA")

plot of chunk unnamed-chunk-14

5.0 Identifying Candidate Targets

The core analytical machinery of gCrisprTools is built on the linear modelling framework implemented in the limma package. Specifically, users employ limma/voom to generate an experimental contrast of interest at the gRNA level. The model coefficent and P-value estimates may be subsequently processed with the infrastructure provided by gCrisprTools.

design <- model.matrix(~ 0 + REPLICATE_POOL + TREATMENT_NAME, pData(es))
colnames(design) <- gsub('TREATMENT_NAME', '', colnames(design))
contrasts <-makeContrasts(DeathExpansion - ControlExpansion, levels = design)

vm <- voom(exprs(es), design)

fit <- lmFit(vm, design)
fit <- contrasts.fit(fit, contrasts)
fit <- eBayes(fit)
5.1 ct.generateResults

After generating a fit object (class MArrayLM) for a contrast of interest, we may summarize the signals from the various cassettes annotated to each target via RRA\(\alpha\) aggregation. The core algorithm is described in detail in the original publication on Robust Rank Aggregation[1] and has been implemented according to the \(\alpha\) thresholding modification proposed by Li et al.[2] Briefly, gRNA signals contained in the specified fit object are ranked and normalized, and these ranks are grouped by the associated target and assigned a score (\(\rho\)) on the basis of the skewness of the gRNA signal ranks. The statistical significance of each target-level score is then assessed by permutation of the gRNA target assignments. Q-values are computed directly from the resulting P-value distributions using the FDR approach described by Benjamini and Hochberg.[3]

A more extensive treatment of RRA\(\alpha\) and comparisons to MAGeCK may be found in inst/Mageck_&_gCrisprTools.html.

resultsDF <-
  ct.generateResults(
    fit,
    annotation = ann,
    RRAalphaCutoff = 0.1,
    permutations = 1000,
    scoring = "combined"
  )

The resulting dataframe contains columns passing some of the information from the fit and annotation objects, as well as a number of statistics describing the evidence for a target's depletion or enrichment within the context of the screen. These include the Target-level P and Q values quantifying the evidence for enrichment or depletion, the median log2 fold change of all of the gRNAs associated with each target, and the rankings of the target-level \(/rho\) statistics (gene-level scores may be useful for ranking targets with equivalent P-values).

6.0 Visualization of Results

After identifying candidate targets, various aspects of the contrast may be visualized with gCrisprTools.

6.1 ct.topTargets

The ct.topTargets function enables simple visualization of the model effect estimates (log2 fold changes) and associated uncertainties of all cassettes associated with the top-ranking targets.

ct.topTargets(fit,
              resultsDF,
              ann,
              targets = 10,
              enrich = TRUE)

plot of chunk unnamed-chunk-17

6.2 ct.stackGuides

In some screens it can be useful to visualize the degree of library distortion associated with the strongest signals. Such an approach can supply additional confidence in a particular candidate of interest by showing that clear differences are evident outside of the linear modeling framework (which may be inaccurate in heavily distorted libraries).

ct.stackGuides(
  es,
  sk,
  plotType = "Target",
  annotation = ann,
  subset = names(sk)[grep('Expansion', sk)]
)
## Summarizing gRNA counts into targets.

plot of chunk unnamed-chunk-18

6.3 ct.viewGuides

gCrisprTools provides methods to visualize the behavior of individual cassettes annotated to target of interest, and positions these within the observed distribution of effect sizes across all cassettes within the experiment.

ct.viewGuides("Target1633", fit, ann)

plot of chunk unnamed-chunk-19

## [1] TRUE

6.4 ct.makeContrastReport and ct.makeReport

As with the Quality Control components of an individual screen, gCrisprTools provides functionality to automatically generate contrast-level reports.

#Not run:
path2Contrast <-
  ct.makeContrastReport(eset = es,
                        fit = fit,
                        sampleKey = sk,
                        results = resultsDF,
                        annotation = ann,
                        comparison.id = NULL,
                        identifier = 'Crispr_Contrast_Report')

If you wish, you can also make a single report encompassing both quality control and the contrast of interest.

#Not run:
path2report <-
  ct.makeReport(fit = fit,
                eset = es,
                sampleKey = sk,
                annotation = ann,
                results = resultsDF,
                aln = aln,
                outdir = ".")

7.0 Hypothesis Testing

In addition to identifying targets of interest within a screen, it may be worthwhile to ask more comprehensive questions about the targets identified. gCrisprTools provides a series of basic functions for determining the enrichment of known or unknown target groups within the context of a screen.

7.1 ct.PantherPathwayEnrichment

If a screen was performed with a library targeting genes, gCrisprTools can provide basic ontological enrichment testing. This function annotates Entrez gene IDs contained in the geneID column of the annotation object to pathways contained in the PANTHER database, and then checks for significant enrichment or depletion of these pathways using a hypergeometric test.

#Not run:
enrichmentResults <-
  ct.PantherPathwayEnrichment(
    resultsDF,
    pvalue.cutoff = 0.01,
    enrich = TRUE,
    organism = 'mouse'
  )

> head(enrichmentResults)   #Note: Pathway names have been edited for display purposes.
                         PATHWAY nGenes sigGenes expected     odds            p        FDR
1 EGF receptor signaling pathway    200       14 5.240550 3.332647 0.0004498023 0.03958260
2          FGF signaling pathway    230       14 5.949958 2.869779 0.0016284304 0.07165094
3     Insulin/MAP kinase cascade    138        9 3.714916 2.785331 0.0101632822 0.20272465
4          CCKR signaling map ST    331       15 8.211061 2.148459 0.0126368744 0.20272465
5               p38 MAPK pathway    145        9 3.891333 2.641968 0.0135928688 0.20272465
6              B cell activation    204       11 5.336192 2.368705 0.0146442541 0.20272465
7.2 ct.targetSetEnrichment, ct.ROC, and ct.PRC

In some cases, it may be useful to ask whether a set of known targets is disproportionately enriched or depleted within a screen. gCrisprTools provides functions for answering these sorts of questions with ct.ROC(), which generates Reciever-Operator Characteristics for a specified gene set within a screen, and ct.PRC(), which draws precision-recall curves. When called, both functions return the raw data necessary to reproduce or combine these results, along with appropriate statistics for assessing the significance of the overall signal within the specified target set (via a hypergeometric test).

data("essential.genes", package = "gCrisprTools")  #Artificial list created for demonstration
data("resultsDF", package = "gCrisprTools")
ROC <- ct.ROC(resultsDF, essential.genes, stat = "deplete.p")

plot of chunk unnamed-chunk-23

str(ROC)
## List of 6
##  $ sensitivity: num [1:871] 0.02 0.04 0.05 0.06 0.07 0.09 0.1 0.1 0.1 0.1 ...
##  $ specificity: num [1:871] 0.987 0.983 0.98 0.977 0.975 ...
##  $ AUC        : num 0.666
##  $ targets    : chr [1:100] "229791" "214230" "18198" "19024" ...
##  $ P.values   : num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"
##  $ Q.values   : num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"
PRC <- ct.PRC(resultsDF, essential.genes, stat = "deplete.p")

plot of chunk unnamed-chunk-24

str(PRC)
## List of 5
##  $ precision: num [1:873] 1 0.0714 0.1026 0.1111 0.1132 ...
##  $ recall   : num [1:873] 0 0.02 0.04 0.05 0.06 0.07 0.09 0.1 0.1 0.1 ...
##  $ targets  : chr [1:100] "229791" "214230" "18198" "19024" ...
##  $ P.values : num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"
##  $ Q.values : num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"

Alternatively, the significance of the enrichment within the target set may be assessed directly with ct.targetSetEnrichment.

targetsTest <- ct.targetSetEnrichment(resultsDF, essential.genes, enrich = FALSE)
str(targetsTest)
## List of 3
##  $ targets : chr [1:100] "229791" "214230" "18198" "19024" ...
##  $ P.values: num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"
##  $ Q.values: num [1:8, 1:3] 0e+00 1e-05 1e-04 1e-03 1e-02 1e-01 5e-01 1e+00 2e+00 2e+00 ...
##   ..- attr(*, "dimnames")=List of 2
##   .. ..$ : NULL
##   .. ..$ : chr [1:3] "Cutoff" "Sig" "Hypergeometric_P"

[1]: Kolde R, Laur S, Adler P, Vilo J. Robust rank aggregation for gene list integration and meta-analysis. Bioinformatics. 2012;28(4):573-80. PMID:22247279

[2]: Li W, Xu H, Xiao T, Cong L, Love MI, Zhang F, Irizarry RA, Liu JS, Brown M, Liu XS. MAGeCK enables robust identification of essential genes from genome-scale CRISPR/Cas9 knockout screens. Genome Biol. 2014;15(12):554. PMID:25476604

[3]:Benjamini Y, Hochberg Y. Controlling the false discovery rate: a practical and powerful approach to multiple testing. Journal of the Royal Statistical Society, Series B. 1995;57(1):289–300. MR 1325392.

sessionInfo()
## R version 4.0.0 (2020-04-24)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.11-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.11-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  stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
## [1] gCrisprTools_1.16.0 limma_3.44.0        Biobase_2.48.0     
## [4] BiocGenerics_0.34.0
## 
## loaded via a namespace (and not attached):
##  [1] Rcpp_1.0.4.6                  lattice_0.20-41              
##  [3] assertthat_0.2.1              digest_0.6.25                
##  [5] mime_0.9                      BiocFileCache_1.12.0         
##  [7] R6_2.4.1                      GenomeInfoDb_1.24.0          
##  [9] stats4_4.0.0                  RSQLite_2.2.0                
## [11] evaluate_0.14                 highr_0.8                    
## [13] httr_1.4.1                    ggplot2_3.3.0                
## [15] pillar_1.4.3                  zlibbioc_1.34.0              
## [17] rlang_0.4.5                   curl_4.3                     
## [19] blob_1.2.1                    S4Vectors_0.26.0             
## [21] Matrix_1.2-18                 rmarkdown_2.1                
## [23] labeling_0.3                  AnnotationHub_2.20.0         
## [25] PANTHER.db_1.0.10             stringr_1.4.0                
## [27] RCurl_1.98-1.2                bit_1.1-15.2                 
## [29] munsell_0.5.0                 DelayedArray_0.14.0          
## [31] shiny_1.4.0.2                 compiler_4.0.0               
## [33] httpuv_1.5.2                  xfun_0.13                    
## [35] pkgconfig_2.0.3               htmltools_0.4.0              
## [37] tidyselect_1.0.0              SummarizedExperiment_1.18.0  
## [39] tibble_3.0.1                  GenomeInfoDbData_1.2.3       
## [41] interactiveDisplayBase_1.26.0 matrixStats_0.56.0           
## [43] IRanges_2.22.0                crayon_1.3.4                 
## [45] dplyr_0.8.5                   dbplyr_1.4.3                 
## [47] later_1.0.0                   bitops_1.0-6                 
## [49] rappdirs_0.3.1                RobustRankAggreg_1.1         
## [51] grid_4.0.0                    xtable_1.8-4                 
## [53] gtable_0.3.0                  lifecycle_0.2.0              
## [55] DBI_1.1.0                     magrittr_1.5                 
## [57] scales_1.1.0                  stringi_1.4.6                
## [59] farver_2.0.3                  XVector_0.28.0               
## [61] promises_1.1.0                ellipsis_0.3.0               
## [63] vctrs_0.2.4                   tools_4.0.0                  
## [65] bit64_0.9-7                   glue_1.4.0                   
## [67] markdown_1.1                  purrr_0.3.4                  
## [69] BiocVersion_3.11.1            fastmap_1.0.1                
## [71] yaml_2.2.1                    AnnotationDbi_1.50.0         
## [73] colorspace_1.4-1              BiocManager_1.30.10          
## [75] GenomicRanges_1.40.0          memoise_1.1.0                
## [77] knitr_1.28