From 0d048210221eb56ea6b54abb4d82f8f5b50f2227 Mon Sep 17 00:00:00 2001 From: GitHub Actions Date: Fri, 3 May 2024 17:25:21 +0000 Subject: [PATCH] markdown source builds Auto-generated via {sandpaper} Source : 4162819d399e1ab2dedb4eee55655debf16a9f0b Branch : main Author : csmagnano Time : 2024-05-03 16:37:53 +0000 Message : Merge pull request #10 from ccb-hms/cosmetic-updates Updated further reading and heading levels in all lessons --- cell_type_annotation.md | 33 +- config.yaml | 83 + hca.md | 84 +- intro-sce.md | 22 +- large_data.md | 57 +- md5sum.txt | 10 +- multi-sample.md | 34 +- renv.lock | 3915 +++++++++++++++++++++++++++++++++++++++ 8 files changed, 4123 insertions(+), 115 deletions(-) create mode 100644 config.yaml create mode 100644 renv.lock diff --git a/cell_type_annotation.md b/cell_type_annotation.md index 1e07b5d..a8e68f5 100644 --- a/cell_type_annotation.md +++ b/cell_type_annotation.md @@ -23,7 +23,7 @@ exercises: 15 # Minutes of exercises in the lesson :::::::::::::::::::::::::::::::::::::::::::::::: -# Setup +## Setup ```r @@ -44,7 +44,7 @@ library(scater) library(scran) ``` -# Data retrieval +## Data retrieval ```r @@ -76,7 +76,7 @@ ind <- sample(ncol(sce), 1000) sce <- sce[,ind] ``` -# Preprocessing +## Preprocessing ```r @@ -84,7 +84,7 @@ sce <- logNormCounts(sce) sce <- runPCA(sce) ``` -# Clustering +## Clustering Clustering is an unsupervised learning procedure that is used to empirically define groups of cells with similar expression profiles. @@ -141,7 +141,7 @@ plotReducedDim(sce, "UMAP", color_by = "label") -# Marker gene detection +## Marker gene detection To interpret clustering results as obtained in the previous section, we identify the genes that drive separation between clusters. These marker genes allow us to @@ -246,7 +246,7 @@ plotExpression(sce, features = top.markers, x = "label", color_by = "label") -# Cell type annotation +## Cell type annotation The most challenging task in scRNA-seq data analysis is arguably the interpretation of the results. @@ -272,7 +272,7 @@ reference datasets where each sample or cell has already been annotated with its putative biological state by domain experts. Here, we will demonstrate both approaches on the wild-type chimera dataset. -## Assigning cell labels from reference data +### Assigning cell labels from reference data A conceptually straightforward annotation approach is to compare the single-cell expression profiles with previously annotated reference datasets. @@ -495,7 +495,7 @@ pheatmap(log2(tab + 10), color = colorRampPalette(c("white", "blue"))(101)) -## Assigning cell labels from gene sets +### Assigning cell labels from gene sets A related strategy is to explicitly identify sets of marker genes that are highly expressed in each individual cell. @@ -909,7 +909,7 @@ a fitted three-component mixture, and the grey curve represents a fitted normal distribution. Vertical lines represent threshold estimates corresponding to each estimate of the distribution. -# Session Info +## Session Info ```r @@ -1019,13 +1019,9 @@ loaded via a namespace (and not attached): [125] cowplot_1.1.3 KEGGREST_1.42.0 ``` -# Further Reading -* OSCA book, [Chapters 5-7](https://bioconductor.org/books/release/OSCA.basic/clustering.html) -* Assigning cell types with SingleR ([the book](https://bioconductor.org/books/release/SingleRBook/)). -* The [AUCell](https://bioconductor.org/packages/AUCell) package vignette. -# Exercises +## Exercises :::::::::::::::::::::::::::::::::: challenge @@ -1100,6 +1096,15 @@ TODO ::::::::::::::::::::::::::::::::::::::::::::: +:::::::::::::: checklist +## Further Reading + +* OSCA book, [Chapters 5-7](https://bioconductor.org/books/release/OSCA.basic/clustering.html) +* Assigning cell types with SingleR ([the book](https://bioconductor.org/books/release/SingleRBook/)). +* The [AUCell](https://bioconductor.org/packages/AUCell) package vignette. + +:::::::::::::: + ::::::::::::::::::::::::::::::::::::: keypoints - TODO diff --git a/config.yaml b/config.yaml new file mode 100644 index 0000000..2ec980d --- /dev/null +++ b/config.yaml @@ -0,0 +1,83 @@ +#------------------------------------------------------------ +# Values for this lesson. +#------------------------------------------------------------ + +# Which carpentry is this (swc, dc, lc, or cp)? +# swc: Software Carpentry +# dc: Data Carpentry +# lc: Library Carpentry +# cp: Carpentries (to use for instructor training for instance) +# incubator: The Carpentries Incubator +carpentry: 'incubator' + +# Overall title for pages. +title: 'Orchestrating Large-Scale Single-Cell Analysis with Bioconductor' + +# Date the lesson was created (YYYY-MM-DD, this is empty by default) +created: 2024-01-10 + +# Comma-separated list of keywords for the lesson +keywords: 'single-cell RNA-seq, The Carpentries, lesson, genomics, bioconductor' # FIXME + +# Life cycle stage of the lesson +# possible values: pre-alpha, alpha, beta, stable +life_cycle: 'pre-alpha' # FIXME + +# License of the lesson +license: 'CC-BY 4.0' + +# Link to the source repository for this lesson +source: 'https://github.com/ccb-hms/osca-carpentries' + +# Default branch of your lesson +branch: 'main' + +# Who to contact if there are any issues +contact: 'christopher_magnano@hms.harvard.edu' # TODO probably change to Ludwig + +# Navigation ------------------------------------------------ +# +# Use the following menu items to specify the order of +# individual pages in each dropdown section. Leave blank to +# include all pages in the folder. +# +# Example ------------- +# +# episodes: +# - introduction.md +# - first-steps.md +# +# learners: +# - setup.md +# +# instructors: +# - instructor-notes.md +# +# profiles: +# - one-learner.md +# - another-learner.md + +# Order of episodes in your lesson +episodes: +- intro-sce.Rmd +- eda_qc.Rmd +- cell_type_annotation.Rmd +- multi-sample.Rmd +- large_data.Rmd +- hca.Rmd + +# Information for Learners +learners: + +# Information for Instructors +instructors: + +# Learner Profiles +profiles: + +# Customisation --------------------------------------------- +# +# This space below is where custom yaml items (e.g. pinning +# sandpaper and varnish versions) should live + + diff --git a/hca.md b/hca.md index 2e2f9c3..e08abfa 100644 --- a/hca.md +++ b/hca.md @@ -18,7 +18,7 @@ exercises: 10 # Minutes of exercises in the lesson :::::::::::::::::::::::::::::::::::::::::::::::: -# HCA Project +## HCA Project The Human Cell Atlas (HCA) is a large project that aims to learn from and map every cell type in the human body. The project extracts spatial and molecular @@ -27,7 +27,7 @@ international collaborative that charts healthy cells in the human body at all ages. There are about 37.2 trillion cells in the human body. To read more about the project, head over to their website at https://www.humancellatlas.org. -# CELLxGENE +## CELLxGENE CELLxGENE is a database and a suite of tools that help scientists to find, download, explore, analyze, annotate, and publish single cell data. It includes @@ -35,7 +35,7 @@ several analytic and visualization tools to help you to discover single cell data patterns. To see the list of tools, browse to https://cellxgene.cziscience.com/. -# CELLxGENE | Census +## CELLxGENE | Census The Census provides efficient computational tooling to access, query, and analyze all single-cell RNA data from CZ CELLxGENE Discover. Using a new access @@ -44,7 +44,7 @@ through TileDB-SOMA, or get slices in AnnData or Seurat objects, thus accelerating your research by significantly minimizing data harmonization at https://chanzuckerberg.github.io/cellxgene-census/. -# The CuratedAtlasQueryR Project +## The CuratedAtlasQueryR Project To systematically characterize the immune system across tissues, demographics and multiple studies, single cell transcriptomics data was harmonized from the @@ -71,7 +71,7 @@ accessing atlas-level datasets programmatically and reproducibly. ![](figures/curatedAtlasQuery.png) -# Data Sources in R / Bioconductor +## Data Sources in R / Bioconductor There are a few options to access single cell data with R / Bioconductor. @@ -81,7 +81,7 @@ There are a few options to access single cell data with R / Bioconductor. | [cellxgenedp](https://bioconductor.org/packages/cellxgenedp) | [CellxGene](https://cellxgene.cziscience.com/) | Human and mouse SC data including HCA | | [CuratedAtlasQueryR](https://stemangiola.github.io/CuratedAtlasQueryR/) | [CellxGene](https://cellxgene.cziscience.com/) | fine-grained query capable CELLxGENE data including HCA | -# Installation +## Installation ```r @@ -91,7 +91,7 @@ if (!requireNamespace("BiocManager", quietly = TRUE)) BiocManager::install("CuratedAtlasQueryR") ``` -# Package load +## Package load ```r @@ -99,7 +99,7 @@ library(CuratedAtlasQueryR) library(dplyr) ``` -# HCA Metadata +## HCA Metadata The metadata allows the user to get a lay of the land of what is available via the package. In this example, we are using the sample database URL which @@ -135,7 +135,7 @@ $ sample_id_db "0c1d320a7d0cbbc281a535912722d272", $ `_sample_name` "BPH340PrSF_Via___transition zone of… ``` -# A note on the piping operator +## A note on the piping operator The vignette materials provided by `CuratedAtlasQueryR` show the use of the 'native' R pipe (implemented after R version `4.1.0`). For those not familiar @@ -164,7 +164,7 @@ iris |> 3 virginica 6.622449 2.983673 5.573469 2.0326531 ``` -# Summarizing the metadata +## Summarizing the metadata For each distinct tissue and dataset combination, count the number of datasets by tissue type. @@ -179,22 +179,22 @@ metadata |> ```{.output} # Source: SQL [?? x 2] # Database: DuckDB v0.10.2 [unknown@Linux 6.5.0-1018-azure:R 4.3.3/:memory:] - tissue n - - 1 pleural effusion 1 - 2 caudate lobe of liver 1 - 3 cortex of kidney 7 - 4 nose 1 - 5 thymus 4 - 6 epithelium of esophagus 1 - 7 transverse colon 1 - 8 liver 1 - 9 renal medulla 6 -10 caecum 1 + tissue n + + 1 blood 17 + 2 kidney 8 + 3 kidney blood vessel 4 + 4 lung parenchyma 2 + 5 respiratory airway 6 + 6 dorsolateral prefrontal cortex 1 + 7 renal pelvis 4 + 8 pigment epithelium of eye 1 + 9 mesenteric lymph node 1 +10 retina 1 # ℹ more rows ``` -# Columns available in the metadata +## Columns available in the metadata ```r @@ -205,7 +205,7 @@ head(names(metadata), 10) [1] "src" "lazy_query" ``` -# Available assays +## Available assays ```r @@ -219,20 +219,20 @@ metadata |> # Database: DuckDB v0.10.2 [unknown@Linux 6.5.0-1018-azure:R 4.3.3/:memory:] assay n - 1 10x 3' v3 21 - 2 Slide-seq 4 - 3 scRNA-seq 4 - 4 Seq-Well 2 - 5 Drop-seq 1 - 6 10x 5' v2 2 - 7 10x 3' v1 1 - 8 Smart-seq2 1 - 9 sci-RNA-seq 1 + 1 10x 5' v2 2 + 2 10x 3' v1 1 + 3 Smart-seq2 1 + 4 sci-RNA-seq 1 + 5 10x 3' v3 21 + 6 Slide-seq 4 + 7 scRNA-seq 4 + 8 Seq-Well 2 + 9 Drop-seq 1 10 10x 3' v2 27 # ℹ more rows ``` -# Available organisms +## Available organisms ```r @@ -249,14 +249,14 @@ metadata |> 1 Homo sapiens 63 ``` -## Download single-cell RNA sequencing counts +### Download single-cell RNA sequencing counts The data can be provided as either "counts" or counts per million "cpm" as given by the `assays` argument in the `get_single_cell_experiment()` function. By default, the `SingleCellExperiment` provided will contain only the 'counts' data. -### Query raw counts +#### Query raw counts ```r @@ -288,7 +288,7 @@ mainExpName: NULL altExpNames(0): ``` -### Query counts scaled per million +#### Query counts scaled per million This is helpful if just few genes are of interest, as they can be compared across samples. @@ -320,7 +320,7 @@ mainExpName: NULL altExpNames(0): ``` -### Extract only a subset of genes +#### Extract only a subset of genes ```r @@ -352,7 +352,7 @@ mainExpName: NULL altExpNames(0): ``` -### Extracting counts as a Seurat object +#### Extracting counts as a Seurat object If needed, the H5 `SingleCellExperiment` can be converted into a Seurat object. Note that it may take a long time and use a lot of memory depending on how many @@ -373,9 +373,9 @@ single_cell_counts <- single_cell_counts ``` -## Save your `SingleCellExperiment` +### Save your `SingleCellExperiment` -### Saving as HDF5 +#### Saving as HDF5 The recommended way of saving these `SingleCellExperiment` objects, if necessary, is to use `saveHDF5SummarizedExperiment` from the `HDF5Array` @@ -386,7 +386,7 @@ package. single_cell_counts |> saveHDF5SummarizedExperiment("single_cell_counts") ``` -# Exercises +## Exercises :::::::::::::::::::::::::::::::::: challenge diff --git a/intro-sce.md b/intro-sce.md index 28d5652..d95a0cf 100644 --- a/intro-sce.md +++ b/intro-sce.md @@ -20,7 +20,7 @@ exercises: 10 # Minutes of exercises in the lesson :::::::::::::::::::::::::::::::::::::::::::::::: -# Setup +## Setup ```r @@ -30,9 +30,9 @@ library(MouseGastrulationData) library(BiocStyle) ``` -# Bioconductor +## Bioconductor -## Overview +### Overview Within the R ecosystem, the Bioconductor project provides tools for the analysis and comprehension of high-throughput genomics data. The scope of the project covers microarray data, various forms of sequencing (RNA-seq, ChIP-seq, bisulfite, genotyping, etc.), proteomics, flow cytometry and more. @@ -40,7 +40,7 @@ One of Bioconductor's main selling points is the use of common data structures t allowing code written by different people (from different organizations, in different countries) to work together seamlessly in complex analyses. By extending R to genomics, Bioconductor serves as a powerful addition to the computational biologist's toolkit. -## Installing Bioconductor Packages +### Installing Bioconductor Packages The default repository for R packages is the [Comprehensive R Archive Network](https://cran.r-project.org/mirrors.html) (CRAN), which is home to over 13,000 different R packages. We can easily install packages from CRAN - say, the popular *[ggplot2](https://CRAN.R-project.org/package=ggplot2)* package for data visualization - by opening up R and typing in: @@ -83,7 +83,7 @@ BiocManager::install("scater") Packages only need to be installed once, and then they are available for all subsequent uses of a particular R installation. There is no need to repeat the installation every time we start R. -## Finding relevant packages +### Finding relevant packages To find relevant Bioconductor packages, one useful resource is the [BiocViews](https://bioconductor.org/packages/release/BiocViews.html) page. This provides a hierarchically organized view of annotations associated with each Bioconductor package. @@ -92,7 +92,7 @@ This gives us a listing of all Bioconductor packages that might be useful for ou CRAN uses the similar concept of ["Task views"](https://cran.r-project.org/web/views/), though this is understandably more general than genomics. For example, the [Cluster task view page](https://cran.r-project.org/web/views/Cluster.html) lists an assortment of packages that are relevant to cluster analyses. -## Staying up to date +### Staying up to date Updating all R/Bioconductor packages is as simple as running `BiocManager::install()` without any arguments. This will check for more recent versions of each package (within a Bioconductor release) and prompt the user to update if any are available. @@ -102,7 +102,7 @@ This will check for more recent versions of each package (within a Bioconductor BiocManager::install() ``` -# The `SingleCellExperiment` class +## The `SingleCellExperiment` class One of the main strengths of the Bioconductor project lies in the use of a common data infrastructure that powers interoperability across packages. @@ -141,7 +141,7 @@ The _getter_ methods are used to extract information from the slots and the _set Depending on the object, slots can contain different types of data (e.g., numeric matrices, lists, etc.). We will here review the main slots of the SingleCellExperiment class as well as their getter/setter methods. -## The `assays` +### The `assays` This is arguably the most fundamental part of the object that contains the count matrix, and potentially other matrices with transformed data. We can access the _list_ of matrices with the `assays` function and individual matrices with the `assay` function. If one of these matrices is called "counts", we can use the special `counts` getter (and the analogous `logcounts`). @@ -168,7 +168,7 @@ ENSMUSG00000102343 . . . You will notice that in this case we have a sparse matrix of class "dgTMatrix" inside the object. More generally, any "matrix-like" object can be used, e.g., dense matrices or HDF5-backed matrices (see "Working with large data"). -## The `colData` and `rowData` +### The `colData` and `rowData` Conceptually, these are two data frames that annotate the columns and the rows of your assay, respectively. @@ -302,7 +302,7 @@ cell_12178 0.00169483 2.061701 46162 cell_12179 0.03767894 1.798687 38398 ``` -## The `reducedDims` +### The `reducedDims` Everything that we have described so far (except for the `counts` getter) is part of the `SummarizedExperiment` class that SingleCellExperiment extends. You can find a complete lesson on the `SummarizedExperiment` class [here](https://carpentries-incubator.github.io/bioc-intro/60-next-steps.html). @@ -372,7 +372,7 @@ Combining two objects: The `MouseGastrulationData` package contains several data :::::::::::::: checklist -# Further Reading +## Further Reading * OSCA book, [Introduction](https://bioconductor.org/books/release/OSCA.intro) diff --git a/large_data.md b/large_data.md index 02a41f8..0008dc2 100644 --- a/large_data.md +++ b/large_data.md @@ -23,7 +23,7 @@ exercises: 2 # Minutes of exercises in the lesson -# Motivation +## Motivation Advances in scRNA-seq technologies have increased the number of cells that can be assayed in routine experiments. @@ -37,7 +37,7 @@ increasing size of scRNA-seq data sets. This section discusses how we can use various aspects of the Bioconductor ecosystem to tune our analysis pipelines for greater speed and efficiency. -# Out of memory representations +## Out of memory representations The count matrix is the central structure around which our analyses are based. In most of the previous chapters, this has been held fully in memory as a dense @@ -230,7 +230,7 @@ in-memory representations on HPC systems with plentiful memory, and then distributing file-backed counterparts to individual users for exploration and visualization on their personal machines. -# Parallelization +## Parallelization Parallelization of calculations across genes or cells is an obvious strategy for speeding up scRNA-seq analysis workflows. @@ -240,7 +240,7 @@ computing throughout the Bioconductor ecosystem, manifesting as a `BPPARAM` argument in compatible functions. We can also use `BiocParallel` with more expressive functions directly through the package's interface. -### Basic use +#### Basic use ```r @@ -359,9 +359,9 @@ parallelization backends involve (i) setting up one or more separate R sessions, session. Depending on the nature and size of the task, this overhead may outweigh any benefit from parallel computing. -# Fast approximations +## Fast approximations -## Nearest neighbor searching +### Nearest neighbor searching Identification of neighbouring cells in PC or expression space is a common procedure that is used in many functions, e.g., `buildSNNGraph()`, `doubletCells()`. @@ -408,19 +408,18 @@ table(exact = colLabels(sce), approx = clusters) exact 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 1 90 0 0 0 0 0 0 0 1 0 0 0 0 0 0 2 0 143 0 0 0 0 0 0 0 0 0 0 0 0 1 - 3 0 0 75 0 0 0 0 0 0 0 0 0 0 0 0 + 3 0 0 77 0 0 0 0 0 0 0 0 0 0 0 0 4 0 0 0 341 0 0 0 0 0 0 0 0 0 0 0 - 5 0 0 2 0 391 0 0 2 0 0 0 5 0 0 0 + 5 0 0 0 0 392 0 0 0 0 0 0 5 0 0 0 6 0 0 0 0 0 80 245 0 0 1 0 2 0 0 0 - 7 0 0 0 0 0 129 0 0 0 0 2 0 0 0 0 - 8 0 0 0 0 1 0 0 93 0 0 0 0 0 0 0 + 7 0 0 0 0 0 130 0 0 0 0 0 0 0 0 0 + 8 0 0 0 0 0 0 0 95 0 0 0 0 0 0 0 9 1 0 0 0 1 0 0 0 106 0 0 0 0 0 0 - 10 0 0 0 0 0 0 0 0 0 108 8 5 0 0 0 - 11 0 0 0 0 0 0 0 0 0 0 138 0 0 0 0 - 12 0 0 0 0 5 0 0 0 0 0 0 207 0 0 0 - 13 0 0 0 0 0 0 0 0 0 0 6 0 146 0 0 - 14 0 0 0 0 0 0 0 0 0 0 0 0 0 20 0 - 15 0 0 0 0 0 0 0 0 0 0 0 0 0 0 56 + 10 0 0 0 0 0 0 0 0 0 107 0 21 0 0 0 + 11 0 0 0 0 0 0 0 0 0 0 153 0 0 0 0 + 12 0 0 0 0 3 0 0 0 0 0 0 193 0 0 0 + 13 0 0 0 0 0 0 0 0 0 1 0 0 146 20 0 + 14 0 0 0 8 0 0 0 0 0 0 0 0 0 0 48 ``` @@ -448,7 +447,7 @@ mean(exact$index != approx$index) [1] 0.561925 ``` -## Singular value decomposition +### Singular value decomposition The singular value decomposition (SVD) underlies the PCA used throughout our analyses, e.g., in `denoisePCA()`, `fastMNN()`, `doubletCells()`. @@ -517,9 +516,9 @@ of power iterations (`q=`). We tend to prefer IRLBA as its default behavior is more accurate, though RSVD is much faster for file-backed matrices. -# Interoperability with popular single-cell analysis ecosytems +## Interoperability with popular single-cell analysis ecosytems -## Seurat +### Seurat [Seurat](https://satijalab.org/seurat) is an R package designed for QC, analysis, and exploration of single-cell RNA-seq data. Seurat can be used to identify and @@ -600,7 +599,7 @@ Idents(sobj) <- "celltype.mapped" sobj ``` -## Scanpy +### Scanpy [Scanpy](https://scanpy.readthedocs.io) is a scalable toolkit for analyzing single-cell gene expression data built jointly with @@ -667,7 +666,7 @@ The resulting H5AD file can then be read into Python using scanpy's [read_h5ad](https://scanpy.readthedocs.io/en/stable/generated/scanpy.read_h5ad.html) function and then directly used in compatible Python-based analysis frameworks. -# Session Info +## Session Info ```r @@ -796,12 +795,8 @@ loaded via a namespace (and not attached): [155] memoise_2.0.1 bit_4.0.5 ``` -# Further Reading -* OSCA book, [Chapter 14](https://bioconductor.org/books/release/OSCA.advanced/dealing-with-big-data.html): Dealing with big data -* The `BiocParallel` [intro vignette](https://bioconductor.org/packages/3.18/BiocParallel/vignettes/Introduction_To_BiocParallel.html). - -# Exercises +## Exercises :::::::::::::::::::::::::::::::::: challenge @@ -874,6 +869,14 @@ Use Seurat's `DimPlot` function. ::::::::::::::::::::::: +:::::::::::::: checklist +## Further Reading + +* OSCA book, [Chapter 14](https://bioconductor.org/books/release/OSCA.advanced/dealing-with-big-data.html): Dealing with big data +* The `BiocParallel` [intro vignette](https://bioconductor.org/packages/3.18/BiocParallel/vignettes/Introduction_To_BiocParallel.html). + +:::::::::::::: + ::::::::::::::::::::::::::::::::::::: keypoints - Out-of-memory representations can be used to work with single-cell datasets that are too large to fit in memory @@ -883,4 +886,4 @@ Use Seurat's `DimPlot` function. :::::::::::::::::::::::::::::::::::::::::::::::: -# References +## References diff --git a/md5sum.txt b/md5sum.txt index 51f66df..98bb569 100644 --- a/md5sum.txt +++ b/md5sum.txt @@ -4,12 +4,12 @@ "config.yaml" "b0d664d3d6abdd0e98b16282e1c03107" "site/built/config.yaml" "2024-05-02" "index.md" "a02c9c785ed98ddd84fe3d34ddb12fcd" "site/built/index.md" "2024-05-02" "links.md" "8184cf4149eafbf03ce8da8ff0778c14" "site/built/links.md" "2024-05-02" -"episodes/intro-sce.Rmd" "7bec0979f3e4076bb2033a132746db43" "site/built/intro-sce.md" "2024-05-02" +"episodes/intro-sce.Rmd" "6d721fd5170bfd2e149fae937e35cdf3" "site/built/intro-sce.md" "2024-05-03" "episodes/eda_qc.Rmd" "e7f8d8316c5b185864120a53f4913ece" "site/built/eda_qc.md" "2024-05-02" -"episodes/cell_type_annotation.Rmd" "26dd249dcbc49908b69f51857d0af997" "site/built/cell_type_annotation.md" "2024-05-02" -"episodes/multi-sample.Rmd" "8e8baaf84d3afc32d77e5177658b1a5e" "site/built/multi-sample.md" "2024-05-02" -"episodes/large_data.Rmd" "2735a12a1130dea13a98f4618f560ecc" "site/built/large_data.md" "2024-05-02" -"episodes/hca.Rmd" "77d772ef05ed56e1cf5e8ffa147019ac" "site/built/hca.md" "2024-05-02" +"episodes/cell_type_annotation.Rmd" "05e06d1ef4afc687a2f17b0a9c62194d" "site/built/cell_type_annotation.md" "2024-05-03" +"episodes/multi-sample.Rmd" "dbeae6a93dddfc716c0084e4f11536ba" "site/built/multi-sample.md" "2024-05-03" +"episodes/large_data.Rmd" "a53ef47db9fc73145e4388b04478b57d" "site/built/large_data.md" "2024-05-03" +"episodes/hca.Rmd" "70055acb81bdd8f18c9f75c93ae7cb50" "site/built/hca.md" "2024-05-03" "instructors/instructor-notes.md" "cae72b6712578d74a49fea7513099f8c" "site/built/instructor-notes.md" "2024-05-02" "learners/reference.md" "1c7cc4e229304d9806a13f69ca1b8ba4" "site/built/reference.md" "2024-05-02" "learners/setup.md" "2ab0d4fd5387d4b6ace48e81fe2e85d8" "site/built/setup.md" "2024-05-02" diff --git a/multi-sample.md b/multi-sample.md index 19c4d0a..fefac04 100644 --- a/multi-sample.md +++ b/multi-sample.md @@ -21,7 +21,7 @@ exercises: 15 # Minutes of exercises in the lesson :::::::::::::::::::::::::::::::::::::::::::::::: -# Setup and data exploration +## Setup and data exploration As said, we will use the the wild-type data from the Tal1 chimera experiment: @@ -184,7 +184,7 @@ There are evident sample effects. Depending on the analysis that you want to per For now, let's assume that we want to remove this effect. -# Correcting batch effects +## Correcting batch effects We correct the effect of samples by aid of the `correctExperiment` function in the `batchelor` package and using the `sample` `colData` column as batch. @@ -215,7 +215,7 @@ Once we removed the sample batch effect, we can proceed with the Differential Expression Analysis. -# Differential Expression +## Differential Expression In order to perform a Differential Expression Analysis, we need to identify groups of cells across samples/conditions (depending on the experimental @@ -227,7 +227,7 @@ In our case we will focus on this second aspect to group cells according to the already annotated cell types to proceed with the computation of the pseudo-bulk samples. -## Pseudo-bulk samples +### Pseudo-bulk samples To compute differences between groups of cells, a possible way is to compute pseudo-bulk samples, where we mediate the gene signal of all the cells @@ -267,7 +267,7 @@ mainExpName: NULL altExpNames(0): ``` -## Differential Expression Analysis +### Differential Expression Analysis The main advantage of using pseudo-bulk samples is the possibility to use well-tested methods for differential analysis like `edgeR` and `DESeq2`, we will @@ -623,7 +623,7 @@ ENSMUSG00000095742 NA NA NA NA NA ``` -# Differential Abundance +## Differential Abundance With DA we test for differences between clusters across conditions, to investigate which clusters change accordingly to the treatment (the tomato injection in our case). @@ -650,7 +650,7 @@ y.ab <- estimateDisp(y.ab, design, trend="none") fit.ab <- glmQLFit(y.ab, design, robust=TRUE, abundance.trend=FALSE) ``` -## Background on compositional effect +### Background on compositional effect As mentioned before, in DA we don't normalize our data with `calcNormFactors` function, because this approach considers that most of the input features do not vary between conditions. @@ -672,7 +672,7 @@ consider this aspect. We now look at different approaches for handling the compositional effect. -## Assuming most labels do not change +### Assuming most labels do not change We can use a similar approach used during the DEGs analysis, assuming that most labels are not changing, in particular if we think about the low number of DEGs @@ -727,7 +727,7 @@ Allantois 0.6001360 15.54924 2.085500 1.532954e-01 5.791158e-01 Erythroid2 -0.5177901 15.97357 1.614924 2.081314e-01 7.076469e-01 ``` -## Testing against a log-fold change threshold +### Testing against a log-fold change threshold This other approach assumes that the composition bias introduces a spurious log2-fold change of no more than a \tau quantity for a non-DA label. In other words, we interpret this as the maximum log-fold change in the total number of cells given by DA in other labels. @@ -779,7 +779,7 @@ Def. endoderm 0.9906682053 Addionally, the choice of \tau can be guided by other external experimental data, like a previous or a pilot experiment. -# Session Info +## Session Info ```r @@ -879,12 +879,7 @@ loaded via a namespace (and not attached): [111] KEGGREST_1.42.0 ``` - -# Further Reading - -* OSCA book, Multi-sample analysis, [Chapters 1, 4, and 6](https://bioconductor.org/books/release/OSCA.multisample) - -# Exercises +## Exercises :::::::::::::::::::::::::::::::::: challenge @@ -923,6 +918,13 @@ TODO ::::::::::::::::::::::::::::::::::::::::::::: +:::::::::::::: checklist +## Further Reading + +* OSCA book, Multi-sample analysis, [Chapters 1, 4, and 6](https://bioconductor.org/books/release/OSCA.multisample) + +:::::::::::::: + ::::::::::::::::::::::::::::::::::::: keypoints - TODO diff --git a/renv.lock b/renv.lock new file mode 100644 index 0000000..db45be8 --- /dev/null +++ b/renv.lock @@ -0,0 +1,3915 @@ +{ + "R": { + "Version": "4.3.3", + "Repositories": [ + { + "Name": "BioCsoft", + "URL": "https://bioconductor.org/packages/3.18/bioc" + }, + { + "Name": "BioCann", + "URL": "https://bioconductor.org/packages/3.18/data/annotation" + }, + { + "Name": "BioCexp", + "URL": "https://bioconductor.org/packages/3.18/data/experiment" + }, + { + "Name": "BioCworkflows", + "URL": "https://bioconductor.org/packages/3.18/workflows" + }, + { + "Name": "BioCbooks", + "URL": "https://bioconductor.org/packages/3.18/books" + }, + { + "Name": "carpentries", + "URL": "https://carpentries.r-universe.dev" + }, + { + "Name": "carpentries_archive", + "URL": "https://carpentries.github.io/drat" + }, + { + "Name": "CRAN", + "URL": "https://cran.rstudio.com" + } + ] + }, + "Bioconductor": { + "Version": "3.18" + }, + "Packages": { + "AUCell": { + "Package": "AUCell", + "Version": "1.24.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "DelayedArray", + "DelayedMatrixStats", + "GSEABase", + "Matrix", + "R.utils", + "SummarizedExperiment", + "data.table", + "grDevices", + "graphics", + "methods", + "mixtools", + "shiny", + "stats", + "utils" + ], + "Hash": "ce7561b7d55ab86b1046ad9d3435355d" + }, + "AnnotationDbi": { + "Package": "AnnotationDbi", + "Version": "1.64.1", + "Source": "Bioconductor", + "Requirements": [ + "Biobase", + "BiocGenerics", + "DBI", + "IRanges", + "KEGGREST", + "R", + "RSQLite", + "S4Vectors", + "methods", + "stats", + "stats4" + ], + "Hash": "27587689922e22f60ec9ad0182a0a825" + }, + "AnnotationFilter": { + "Package": "AnnotationFilter", + "Version": "1.26.0", + "Source": "Bioconductor", + "Requirements": [ + "GenomicRanges", + "R", + "lazyeval", + "methods", + "utils" + ], + "Hash": "759acec0b1522c1a85c6ba703d4c0ec5" + }, + "AnnotationHub": { + "Package": "AnnotationHub", + "Version": "3.10.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationDbi", + "BiocFileCache", + "BiocGenerics", + "BiocManager", + "BiocVersion", + "RSQLite", + "S4Vectors", + "curl", + "dplyr", + "grDevices", + "httr", + "interactiveDisplayBase", + "methods", + "rappdirs", + "utils", + "yaml" + ], + "Hash": "a25fbabd5d4c7bf62d7149443b21a35d" + }, + "BH": { + "Package": "BH", + "Version": "1.84.0-0", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "a8235afbcd6316e6e91433ea47661013" + }, + "Biobase": { + "Package": "Biobase", + "Version": "2.62.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "R", + "methods", + "utils" + ], + "Hash": "38252a34e82d3ff6bb46b4e2252d2dce" + }, + "BiocFileCache": { + "Package": "BiocFileCache", + "Version": "2.10.1", + "Source": "Bioconductor", + "Requirements": [ + "DBI", + "R", + "RSQLite", + "curl", + "dbplyr", + "dplyr", + "filelock", + "httr", + "methods", + "stats", + "utils" + ], + "Hash": "ac2a12468b948654220ed90ae94e9d08" + }, + "BiocGenerics": { + "Package": "BiocGenerics", + "Version": "0.48.1", + "Source": "Bioconductor", + "Requirements": [ + "R", + "graphics", + "methods", + "stats", + "utils" + ], + "Hash": "e34278c65d7dffcc08f737bf0944ca9a" + }, + "BiocIO": { + "Package": "BiocIO", + "Version": "1.12.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "R", + "S4Vectors", + "methods", + "tools" + ], + "Hash": "aa543468283543c9a8dad23a4897be96" + }, + "BiocManager": { + "Package": "BiocManager", + "Version": "1.30.22", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "utils" + ], + "Hash": "d57e43105a1aa9cb54fdb4629725acb1" + }, + "BiocNeighbors": { + "Package": "BiocNeighbors", + "Version": "1.20.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocParallel", + "Matrix", + "Rcpp", + "RcppHNSW", + "S4Vectors", + "methods", + "stats" + ], + "Hash": "c5c8ade5852fd3b25c66ec28873d00f1" + }, + "BiocParallel": { + "Package": "BiocParallel", + "Version": "1.36.0", + "Source": "Bioconductor", + "Requirements": [ + "BH", + "R", + "codetools", + "cpp11", + "futile.logger", + "methods", + "parallel", + "snow", + "stats", + "utils" + ], + "Hash": "6d1689ee8b65614ba6ef4012a67b663a" + }, + "BiocSingular": { + "Package": "BiocSingular", + "Version": "1.18.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocParallel", + "DelayedArray", + "Matrix", + "Rcpp", + "S4Vectors", + "ScaledMatrix", + "beachmat", + "irlba", + "methods", + "rsvd", + "utils" + ], + "Hash": "bed2b7ea3b0b0b31387d1d80286abb97" + }, + "BiocStyle": { + "Package": "BiocStyle", + "Version": "2.30.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocManager", + "bookdown", + "knitr", + "rmarkdown", + "stats", + "utils", + "yaml" + ], + "Hash": "1e22f9ad3acac55ff3069c5292d858cd" + }, + "BiocVersion": { + "Package": "BiocVersion", + "Version": "3.18.1", + "Source": "Bioconductor", + "Requirements": [ + "R" + ], + "Hash": "2ecaed86684f5fae76ed5530f9d29c4a" + }, + "Biostrings": { + "Package": "Biostrings", + "Version": "2.70.3", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "GenomeInfoDb", + "IRanges", + "R", + "S4Vectors", + "XVector", + "crayon", + "grDevices", + "graphics", + "methods", + "stats", + "utils" + ], + "Hash": "86ffa781f132f54e9c963a13fd6cf9fc" + }, + "BumpyMatrix": { + "Package": "BumpyMatrix", + "Version": "1.10.0", + "Source": "Bioconductor", + "Requirements": [ + "IRanges", + "Matrix", + "S4Vectors", + "methods", + "utils" + ], + "Hash": "746b6ebb83983ce7ecdee26c613fd588" + }, + "Cairo": { + "Package": "Cairo", + "Version": "1.6-2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics" + ], + "Hash": "3918e6b40d27984ca4a99c73b92406c3" + }, + "CuratedAtlasQueryR": { + "Package": "CuratedAtlasQueryR", + "Version": "1.0.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "DBI", + "HDF5Array", + "R", + "S4Vectors", + "Seurat", + "SeuratObject", + "SingleCellExperiment", + "SummarizedExperiment", + "assertthat", + "cli", + "dbplyr", + "dplyr", + "duckdb", + "glue", + "httr", + "methods", + "purrr", + "rlang", + "stats", + "stringr", + "tibble", + "tools", + "utils" + ], + "Hash": "8f3f539c9af071f3cbe6a66096bf2a05" + }, + "DBI": { + "Package": "DBI", + "Version": "1.2.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "164809cd72e1d5160b4cb3aa57f510fe" + }, + "DT": { + "Package": "DT", + "Version": "0.32", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "crosstalk", + "htmltools", + "htmlwidgets", + "httpuv", + "jquerylib", + "jsonlite", + "magrittr", + "promises" + ], + "Hash": "0d3ab8abbb0c3e3daa47d4dc8e17bbae" + }, + "DelayedArray": { + "Package": "DelayedArray", + "Version": "0.28.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "IRanges", + "Matrix", + "MatrixGenerics", + "R", + "S4Arrays", + "S4Vectors", + "SparseArray", + "methods", + "stats", + "stats4" + ], + "Hash": "0e5c84e543a3d04ce64c6f60ed46d7eb" + }, + "DelayedMatrixStats": { + "Package": "DelayedMatrixStats", + "Version": "1.24.0", + "Source": "Bioconductor", + "Requirements": [ + "DelayedArray", + "IRanges", + "Matrix", + "MatrixGenerics", + "S4Vectors", + "methods", + "sparseMatrixStats" + ], + "Hash": "71c2d178d33f9d91999f67dc2d53b747" + }, + "DropletUtils": { + "Package": "DropletUtils", + "Version": "1.22.0", + "Source": "Bioconductor", + "Requirements": [ + "BH", + "BiocGenerics", + "BiocParallel", + "DelayedArray", + "DelayedMatrixStats", + "GenomicRanges", + "HDF5Array", + "IRanges", + "Matrix", + "R.utils", + "Rcpp", + "Rhdf5lib", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "beachmat", + "dqrng", + "edgeR", + "methods", + "rhdf5", + "scuttle", + "stats", + "utils" + ], + "Hash": "be3893d30c97591f1d3ec6f053830c3a" + }, + "EnsDb.Mmusculus.v79": { + "Package": "EnsDb.Mmusculus.v79", + "Version": "2.99.0", + "Source": "Bioconductor", + "Requirements": [ + "ensembldb" + ], + "Hash": "53790b2a7c414e74dfd2e6f41a0e4c47" + }, + "ExperimentHub": { + "Package": "ExperimentHub", + "Version": "2.10.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationHub", + "BiocFileCache", + "BiocGenerics", + "BiocManager", + "S4Vectors", + "methods", + "rappdirs", + "utils" + ], + "Hash": "fb43ec028a58aa8a8539d79ea936d39f" + }, + "FNN": { + "Package": "FNN", + "Version": "1.1.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "eaabdc7938aa3632a28273f53a0d226d" + }, + "GSEABase": { + "Package": "GSEABase", + "Version": "1.64.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationDbi", + "Biobase", + "BiocGenerics", + "R", + "XML", + "annotate", + "graph", + "methods" + ], + "Hash": "96e2adf800dc97758f8c5a36b98d8fef" + }, + "GenomeInfoDb": { + "Package": "GenomeInfoDb", + "Version": "1.38.8", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "GenomeInfoDbData", + "IRanges", + "R", + "RCurl", + "S4Vectors", + "methods", + "stats", + "stats4", + "utils" + ], + "Hash": "155053909d2831bfac154a1118151d6b" + }, + "GenomeInfoDbData": { + "Package": "GenomeInfoDbData", + "Version": "1.2.11", + "Source": "Bioconductor", + "Requirements": [ + "R" + ], + "Hash": "10f32956181d1d46bd8402c93ac193e8" + }, + "GenomicAlignments": { + "Package": "GenomicAlignments", + "Version": "1.38.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "BiocParallel", + "Biostrings", + "GenomeInfoDb", + "GenomicRanges", + "IRanges", + "R", + "Rsamtools", + "S4Vectors", + "SummarizedExperiment", + "methods", + "stats", + "utils" + ], + "Hash": "3447de036330c8c2ae54f064c8f4e299" + }, + "GenomicFeatures": { + "Package": "GenomicFeatures", + "Version": "1.54.4", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "AnnotationDbi", + "Biobase", + "BiocGenerics", + "BiocIO", + "Biostrings", + "DBI", + "GenomeInfoDb", + "GenomicRanges", + "IRanges", + "R", + "RSQLite", + "S4Vectors", + "XVector", + "biomaRt", + "httr", + "methods", + "rjson", + "rtracklayer", + "stats", + "tools", + "utils" + ], + "Hash": "28667ac05b72cf841adf792154f387de" + }, + "GenomicRanges": { + "Package": "GenomicRanges", + "Version": "1.54.1", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "GenomeInfoDb", + "IRanges", + "R", + "S4Vectors", + "XVector", + "methods", + "stats", + "stats4", + "utils" + ], + "Hash": "7e0c1399af35369312d9c399454374e8" + }, + "HDF5Array": { + "Package": "HDF5Array", + "Version": "1.30.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "DelayedArray", + "IRanges", + "Matrix", + "R", + "Rhdf5lib", + "S4Arrays", + "S4Vectors", + "methods", + "rhdf5", + "rhdf5filters", + "stats", + "tools", + "utils" + ], + "Hash": "9b8deb4fd34fa439c16c829457d1968f" + }, + "IRanges": { + "Package": "IRanges", + "Version": "2.36.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "R", + "S4Vectors", + "methods", + "stats", + "stats4", + "utils" + ], + "Hash": "f98500eeb93e8a66ad65be955a848595" + }, + "KEGGREST": { + "Package": "KEGGREST", + "Version": "1.42.0", + "Source": "Bioconductor", + "Requirements": [ + "Biostrings", + "R", + "httr", + "methods", + "png" + ], + "Hash": "8d6e9f4dce69aec9c588c27ae79be08e" + }, + "KernSmooth": { + "Package": "KernSmooth", + "Version": "2.23-22", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "stats" + ], + "Hash": "2fecebc3047322fa5930f74fae5de70f" + }, + "MASS": { + "Package": "MASS", + "Version": "7.3-60.0.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "methods", + "stats", + "utils" + ], + "Hash": "b765b28387acc8ec9e9c1530713cb19c" + }, + "Matrix": { + "Package": "Matrix", + "Version": "1.6-5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "grid", + "lattice", + "methods", + "stats", + "utils" + ], + "Hash": "8c7115cd3a0e048bda2a7cd110549f7a" + }, + "MatrixGenerics": { + "Package": "MatrixGenerics", + "Version": "1.14.0", + "Source": "Bioconductor", + "Requirements": [ + "matrixStats", + "methods" + ], + "Hash": "088cd2077b5619fcb7b373b1a45174e7" + }, + "MouseGastrulationData": { + "Package": "MouseGastrulationData", + "Version": "1.16.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BumpyMatrix", + "ExperimentHub", + "R", + "S4Vectors", + "SingleCellExperiment", + "SpatialExperiment", + "SummarizedExperiment", + "methods" + ], + "Hash": "dc980c3bf06eaea786233351e5654258" + }, + "ProtGenerics": { + "Package": "ProtGenerics", + "Version": "1.34.0", + "Source": "Bioconductor", + "Requirements": [ + "methods" + ], + "Hash": "f9cf8f8dac1d3e1bd9a5e3215286b700" + }, + "R.methodsS3": { + "Package": "R.methodsS3", + "Version": "1.8.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "utils" + ], + "Hash": "278c286fd6e9e75d0c2e8f731ea445c8" + }, + "R.oo": { + "Package": "R.oo", + "Version": "1.26.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R.methodsS3", + "methods", + "utils" + ], + "Hash": "4fed809e53ddb5407b3da3d0f572e591" + }, + "R.utils": { + "Package": "R.utils", + "Version": "2.12.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R.methodsS3", + "R.oo", + "methods", + "tools", + "utils" + ], + "Hash": "3dc2829b790254bfba21e60965787651" + }, + "R6": { + "Package": "R6", + "Version": "2.5.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "470851b6d5d0ac559e9d01bb352b4021" + }, + "RANN": { + "Package": "RANN", + "Version": "2.6.1", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "d128ea05a972d3e67c6f39de52c72bd7" + }, + "RColorBrewer": { + "Package": "RColorBrewer", + "Version": "1.1-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "45f0398006e83a5b10b72a90663d8d8c" + }, + "RCurl": { + "Package": "RCurl", + "Version": "1.98-1.14", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "bitops", + "methods" + ], + "Hash": "47f648d288079d0c696804ad4e55197e" + }, + "ROCR": { + "Package": "ROCR", + "Version": "1.0-11", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "gplots", + "grDevices", + "graphics", + "methods", + "stats" + ], + "Hash": "cc151930e20e16427bc3d0daec62b4a9" + }, + "RSQLite": { + "Package": "RSQLite", + "Version": "2.3.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "DBI", + "R", + "bit64", + "blob", + "cpp11", + "memoise", + "methods", + "pkgconfig", + "plogr", + "rlang" + ], + "Hash": "f5a75d57e0a3014a6ef537ac04a80fc6" + }, + "RSpectra": { + "Package": "RSpectra", + "Version": "0.16-1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "Rcpp", + "RcppEigen" + ], + "Hash": "6b5ab997fd5ff6d46a5f1d9f8b76961c" + }, + "Rcpp": { + "Package": "Rcpp", + "Version": "1.0.12", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "methods", + "utils" + ], + "Hash": "5ea2700d21e038ace58269ecdbeb9ec0" + }, + "RcppAnnoy": { + "Package": "RcppAnnoy", + "Version": "0.0.22", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "methods" + ], + "Hash": "f6baa1e06fb6c3724f601a764266cb0d" + }, + "RcppArmadillo": { + "Package": "RcppArmadillo", + "Version": "0.12.8.1.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "methods", + "stats", + "utils" + ], + "Hash": "e78bbbb81a5dcd71a4bd3268d6ede0b1" + }, + "RcppEigen": { + "Package": "RcppEigen", + "Version": "0.3.4.0.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "stats", + "utils" + ], + "Hash": "df49e3306f232ec28f1604e36a202847" + }, + "RcppHNSW": { + "Package": "RcppHNSW", + "Version": "0.6.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Rcpp", + "methods" + ], + "Hash": "1f2dc32c27746a35196aaf95adb357be" + }, + "RcppML": { + "Package": "RcppML", + "Version": "0.3.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "Rcpp", + "RcppEigen", + "methods", + "stats" + ], + "Hash": "225157373f361daf85198a8d1ddaa733" + }, + "RcppProgress": { + "Package": "RcppProgress", + "Version": "0.4.2", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "1c0aa18b97e6aaa17f93b8b866c0ace5" + }, + "RcppTOML": { + "Package": "RcppTOML", + "Version": "0.2.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp" + ], + "Hash": "c232938949fcd8126034419cc529333a" + }, + "ResidualMatrix": { + "Package": "ResidualMatrix", + "Version": "1.12.0", + "Source": "Bioconductor", + "Requirements": [ + "DelayedArray", + "Matrix", + "S4Vectors", + "methods" + ], + "Hash": "d267a37fc29376e448e4adead5718584" + }, + "Rhdf5lib": { + "Package": "Rhdf5lib", + "Version": "1.24.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "R" + ], + "Hash": "3cf103db29d75af0221d71946509a30c" + }, + "Rhtslib": { + "Package": "Rhtslib", + "Version": "2.4.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "zlibbioc" + ], + "Hash": "ee7abc23ddeada73fedfee74c633bffe" + }, + "Rsamtools": { + "Package": "Rsamtools", + "Version": "2.18.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocParallel", + "Biostrings", + "GenomeInfoDb", + "GenomicRanges", + "IRanges", + "R", + "Rhtslib", + "S4Vectors", + "XVector", + "bitops", + "methods", + "stats", + "utils", + "zlibbioc" + ], + "Hash": "242517db56d7fe7214120ecc77a5890d" + }, + "Rtsne": { + "Package": "Rtsne", + "Version": "0.17", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Rcpp", + "stats" + ], + "Hash": "f81f7764a3c3e310b1d40e1a8acee19e" + }, + "S4Arrays": { + "Package": "S4Arrays", + "Version": "1.2.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "IRanges", + "Matrix", + "R", + "S4Vectors", + "abind", + "crayon", + "methods", + "stats" + ], + "Hash": "3213a9826adb8f48e51af1e7b30fa568" + }, + "S4Vectors": { + "Package": "S4Vectors", + "Version": "0.40.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "R", + "methods", + "stats", + "stats4", + "utils" + ], + "Hash": "1716e201f81ced0f456dd5ec85fe20f8" + }, + "ScaledMatrix": { + "Package": "ScaledMatrix", + "Version": "1.10.0", + "Source": "Bioconductor", + "Requirements": [ + "DelayedArray", + "Matrix", + "S4Vectors", + "methods" + ], + "Hash": "ecab4b44d12fc7642a7161f71f3397b5" + }, + "Seurat": { + "Package": "Seurat", + "Version": "5.0.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "KernSmooth", + "MASS", + "Matrix", + "R", + "RANN", + "RColorBrewer", + "ROCR", + "RSpectra", + "Rcpp", + "RcppAnnoy", + "RcppEigen", + "RcppHNSW", + "RcppProgress", + "Rtsne", + "SeuratObject", + "cluster", + "cowplot", + "fastDummies", + "fitdistrplus", + "future", + "future.apply", + "generics", + "ggplot2", + "ggrepel", + "ggridges", + "grDevices", + "graphics", + "grid", + "httr", + "ica", + "igraph", + "irlba", + "jsonlite", + "leiden", + "lifecycle", + "lmtest", + "matrixStats", + "methods", + "miniUI", + "patchwork", + "pbapply", + "plotly", + "png", + "progressr", + "purrr", + "reticulate", + "rlang", + "scales", + "scattermore", + "sctransform", + "shiny", + "spatstat.explore", + "spatstat.geom", + "stats", + "tibble", + "tools", + "utils", + "uwot" + ], + "Hash": "f5325a968489ef65254a51d74dc0c520" + }, + "SeuratObject": { + "Package": "SeuratObject", + "Version": "5.0.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "Rcpp", + "RcppEigen", + "future", + "future.apply", + "generics", + "grDevices", + "grid", + "lifecycle", + "methods", + "progressr", + "rlang", + "sp", + "spam", + "stats", + "tools", + "utils" + ], + "Hash": "424c2b9e50b053c86fc38f17e09917da" + }, + "SingleCellExperiment": { + "Package": "SingleCellExperiment", + "Version": "1.24.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "DelayedArray", + "GenomicRanges", + "S4Vectors", + "SummarizedExperiment", + "methods", + "stats", + "utils" + ], + "Hash": "e21b3571ce76eb4dfe6bf7900960aa6a" + }, + "SingleR": { + "Package": "SingleR", + "Version": "2.4.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocNeighbors", + "BiocParallel", + "BiocSingular", + "DelayedArray", + "DelayedMatrixStats", + "Matrix", + "Rcpp", + "S4Vectors", + "SummarizedExperiment", + "beachmat", + "methods", + "parallel", + "stats", + "utils" + ], + "Hash": "c92ff71608dda35b5fecbf7024a069f8" + }, + "SparseArray": { + "Package": "SparseArray", + "Version": "1.2.4", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "IRanges", + "Matrix", + "MatrixGenerics", + "R", + "S4Arrays", + "S4Vectors", + "XVector", + "matrixStats", + "methods", + "stats" + ], + "Hash": "391092e7b81373ab624bd6471cebccd4" + }, + "SpatialExperiment": { + "Package": "SpatialExperiment", + "Version": "1.12.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocFileCache", + "BiocGenerics", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "grDevices", + "magick", + "methods", + "rjson", + "utils" + ], + "Hash": "df55f81c526995211170f86c5d35a19d" + }, + "SummarizedExperiment": { + "Package": "SummarizedExperiment", + "Version": "1.32.0", + "Source": "Bioconductor", + "Requirements": [ + "Biobase", + "BiocGenerics", + "DelayedArray", + "GenomeInfoDb", + "GenomicRanges", + "IRanges", + "Matrix", + "MatrixGenerics", + "R", + "S4Arrays", + "S4Vectors", + "methods", + "stats", + "tools", + "utils" + ], + "Hash": "caee529bf9710ff6fe1776612fcaa266" + }, + "TENxBrainData": { + "Package": "TENxBrainData", + "Version": "1.22.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationHub", + "ExperimentHub", + "HDF5Array", + "SingleCellExperiment" + ], + "Hash": "f7038e6ad8b93befa4d3ab361e84818c" + }, + "XML": { + "Package": "XML", + "Version": "3.99-0.16.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods", + "utils" + ], + "Hash": "da3098169c887914551b607c66fe2a28" + }, + "XVector": { + "Package": "XVector", + "Version": "0.42.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "IRanges", + "R", + "S4Vectors", + "methods", + "tools", + "utils", + "zlibbioc" + ], + "Hash": "65c0b6bca03f88758f86ef0aa18c4873" + }, + "abind": { + "Package": "abind", + "Version": "1.4-5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods", + "utils" + ], + "Hash": "4f57884290cc75ab22f4af9e9d4ca862" + }, + "annotate": { + "Package": "annotate", + "Version": "1.80.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationDbi", + "Biobase", + "BiocGenerics", + "DBI", + "R", + "XML", + "graphics", + "httr", + "methods", + "stats", + "utils", + "xtable" + ], + "Hash": "08359e5ce909c14a936ec1f9712ca830" + }, + "askpass": { + "Package": "askpass", + "Version": "1.2.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "sys" + ], + "Hash": "cad6cf7f1d5f6e906700b9d3e718c796" + }, + "assertthat": { + "Package": "assertthat", + "Version": "0.2.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "tools" + ], + "Hash": "50c838a310445e954bc13f26f26a6ecf" + }, + "base64enc": { + "Package": "base64enc", + "Version": "0.1-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "543776ae6848fde2f48ff3816d0628bc" + }, + "basilisk": { + "Package": "basilisk", + "Version": "1.14.3", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "basilisk.utils", + "dir.expiry", + "methods", + "parallel", + "reticulate", + "utils" + ], + "Hash": "7f12a0c0a99c04674711a95eec595d9f" + }, + "basilisk.utils": { + "Package": "basilisk.utils", + "Version": "1.14.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "dir.expiry", + "methods", + "tools", + "utils" + ], + "Hash": "a7a2fef1e703a0e2dd4af666b6de76b1" + }, + "batchelor": { + "Package": "batchelor", + "Version": "1.18.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "BiocNeighbors", + "BiocParallel", + "BiocSingular", + "DelayedArray", + "DelayedMatrixStats", + "Matrix", + "Rcpp", + "ResidualMatrix", + "S4Vectors", + "ScaledMatrix", + "SingleCellExperiment", + "SummarizedExperiment", + "beachmat", + "igraph", + "methods", + "scuttle", + "stats", + "utils" + ], + "Hash": "e4b9d99c9e53be1b5b232634ebdb22c9" + }, + "beachmat": { + "Package": "beachmat", + "Version": "2.18.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BiocGenerics", + "DelayedArray", + "Matrix", + "Rcpp", + "SparseArray", + "methods" + ], + "Hash": "c1c423ca7149d9e7f55d1e609342c2bd" + }, + "beeswarm": { + "Package": "beeswarm", + "Version": "0.4.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grDevices", + "graphics", + "stats", + "utils" + ], + "Hash": "0f4e9d8caa6feaa7e409ae6c30f2ca66" + }, + "biomaRt": { + "Package": "biomaRt", + "Version": "2.58.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "AnnotationDbi", + "BiocFileCache", + "XML", + "digest", + "httr", + "methods", + "progress", + "rappdirs", + "stringr", + "utils", + "xml2" + ], + "Hash": "d6e043a6bfb4e2e256d00b8eee9c4266" + }, + "bit": { + "Package": "bit", + "Version": "4.0.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "d242abec29412ce988848d0294b208fd" + }, + "bit64": { + "Package": "bit64", + "Version": "4.0.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "bit", + "methods", + "stats", + "utils" + ], + "Hash": "9fe98599ca456d6552421db0d6772d8f" + }, + "bitops": { + "Package": "bitops", + "Version": "1.0-7", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "b7d8d8ee39869c18d8846a184dd8a1af" + }, + "blob": { + "Package": "blob", + "Version": "1.2.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "methods", + "rlang", + "vctrs" + ], + "Hash": "40415719b5a479b87949f3aa0aee737c" + }, + "bluster": { + "Package": "bluster", + "Version": "1.12.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocNeighbors", + "BiocParallel", + "Matrix", + "Rcpp", + "S4Vectors", + "cluster", + "igraph", + "methods", + "stats", + "utils" + ], + "Hash": "fca0d5ffad6380f13cad4d7855107aef" + }, + "bookdown": { + "Package": "bookdown", + "Version": "0.38", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "htmltools", + "jquerylib", + "knitr", + "rmarkdown", + "tinytex", + "xfun", + "yaml" + ], + "Hash": "388b27ab03b34a5c9704fb8cd1dae880" + }, + "bslib": { + "Package": "bslib", + "Version": "0.6.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "base64enc", + "cachem", + "grDevices", + "htmltools", + "jquerylib", + "jsonlite", + "lifecycle", + "memoise", + "mime", + "rlang", + "sass" + ], + "Hash": "7fb73102553e0c8e478bfaa0ccebe479" + }, + "caTools": { + "Package": "caTools", + "Version": "1.18.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "bitops" + ], + "Hash": "34d90fa5845004236b9eacafc51d07b2" + }, + "cachem": { + "Package": "cachem", + "Version": "1.0.8", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "fastmap", + "rlang" + ], + "Hash": "c35768291560ce302c0a6589f92e837d" + }, + "cli": { + "Package": "cli", + "Version": "3.6.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "utils" + ], + "Hash": "1216ac65ac55ec0058a6f75d7ca0fd52" + }, + "cluster": { + "Package": "cluster", + "Version": "2.1.6", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "stats", + "utils" + ], + "Hash": "0aaa05204035dc43ea0004b9c76611dd" + }, + "codetools": { + "Package": "codetools", + "Version": "0.2-19", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "c089a619a7fae175d149d89164f8c7d8" + }, + "colorspace": { + "Package": "colorspace", + "Version": "2.1-0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "methods", + "stats" + ], + "Hash": "f20c47fd52fae58b4e377c37bb8c335b" + }, + "commonmark": { + "Package": "commonmark", + "Version": "1.9.1", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "5d8225445acb167abf7797de48b2ee3c" + }, + "cowplot": { + "Package": "cowplot", + "Version": "1.1.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "ggplot2", + "grDevices", + "grid", + "gtable", + "methods", + "rlang", + "scales" + ], + "Hash": "8ef2084dd7d28847b374e55440e4f8cb" + }, + "cpp11": { + "Package": "cpp11", + "Version": "0.4.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "5a295d7d963cc5035284dcdbaf334f4e" + }, + "crayon": { + "Package": "crayon", + "Version": "1.5.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grDevices", + "methods", + "utils" + ], + "Hash": "e8a1e41acf02548751f45c718d55aa6a" + }, + "crosstalk": { + "Package": "crosstalk", + "Version": "1.2.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R6", + "htmltools", + "jsonlite", + "lazyeval" + ], + "Hash": "ab12c7b080a57475248a30f4db6298c0" + }, + "curl": { + "Package": "curl", + "Version": "5.2.1", + "Source": "Repository", + "Repository": "RSPM", + "Requirements": [ + "R" + ], + "Hash": "411ca2c03b1ce5f548345d2fc2685f7a" + }, + "data.table": { + "Package": "data.table", + "Version": "1.15.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "536dfe4ac4093b5d115caed7a1a7223b" + }, + "dbplyr": { + "Package": "dbplyr", + "Version": "2.5.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "DBI", + "R", + "R6", + "blob", + "cli", + "dplyr", + "glue", + "lifecycle", + "magrittr", + "methods", + "pillar", + "purrr", + "rlang", + "tibble", + "tidyr", + "tidyselect", + "utils", + "vctrs", + "withr" + ], + "Hash": "39b2e002522bfd258039ee4e889e0fd1" + }, + "deldir": { + "Package": "deldir", + "Version": "2.0-4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics" + ], + "Hash": "24754fce82729ff85317dd195b6646a8" + }, + "digest": { + "Package": "digest", + "Version": "0.6.35", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "utils" + ], + "Hash": "698ece7ba5a4fa4559e3d537e7ec3d31" + }, + "dir.expiry": { + "Package": "dir.expiry", + "Version": "1.10.0", + "Source": "Bioconductor", + "Requirements": [ + "filelock", + "utils" + ], + "Hash": "d4412704cb3bf84c5f03fe2ac03c236f" + }, + "dotCall64": { + "Package": "dotCall64", + "Version": "1.1-1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "80f374ef8500fcdc5d84a0345b837227" + }, + "dplyr": { + "Package": "dplyr", + "Version": "1.1.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "cli", + "generics", + "glue", + "lifecycle", + "magrittr", + "methods", + "pillar", + "rlang", + "tibble", + "tidyselect", + "utils", + "vctrs" + ], + "Hash": "fedd9d00c2944ff00a0e2696ccf048ec" + }, + "dqrng": { + "Package": "dqrng", + "Version": "0.3.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "BH", + "R", + "Rcpp", + "sitmo" + ], + "Hash": "824df2aeba88d701df5e79018b35b815" + }, + "duckdb": { + "Package": "duckdb", + "Version": "0.10.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "DBI", + "R", + "methods", + "utils" + ], + "Hash": "797d264c5dbae66be1fbd0e1e27c459b" + }, + "edgeR": { + "Package": "edgeR", + "Version": "4.0.16", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "R", + "Rcpp", + "graphics", + "limma", + "locfit", + "methods", + "stats", + "utils" + ], + "Hash": "a0405c7890708dcb53809d46758800f4" + }, + "ellipsis": { + "Package": "ellipsis", + "Version": "0.3.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "rlang" + ], + "Hash": "bb0eec2fe32e88d9e2836c2f73ea2077" + }, + "ensembldb": { + "Package": "ensembldb", + "Version": "2.26.0", + "Source": "Bioconductor", + "Requirements": [ + "AnnotationDbi", + "AnnotationFilter", + "Biobase", + "BiocGenerics", + "Biostrings", + "DBI", + "GenomeInfoDb", + "GenomicFeatures", + "GenomicRanges", + "IRanges", + "ProtGenerics", + "R", + "RSQLite", + "Rsamtools", + "S4Vectors", + "curl", + "methods", + "rtracklayer" + ], + "Hash": "6be48b1a96556976a4e9ee6836f88b97" + }, + "evaluate": { + "Package": "evaluate", + "Version": "0.23", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "daf4a1246be12c1fa8c7705a0935c1a0" + }, + "fansi": { + "Package": "fansi", + "Version": "1.0.6", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "utils" + ], + "Hash": "962174cf2aeb5b9eea581522286a911f" + }, + "farver": { + "Package": "farver", + "Version": "2.1.1", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "8106d78941f34855c440ddb946b8f7a5" + }, + "fastDummies": { + "Package": "fastDummies", + "Version": "1.7.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "data.table", + "stringr", + "tibble" + ], + "Hash": "e0f9c0c051e0e8d89996d7f0c400539f" + }, + "fastmap": { + "Package": "fastmap", + "Version": "1.1.1", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "f7736a18de97dea803bde0a2daaafb27" + }, + "filelock": { + "Package": "filelock", + "Version": "1.0.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "192053c276525c8495ccfd523aa8f2d1" + }, + "fitdistrplus": { + "Package": "fitdistrplus", + "Version": "1.1-11", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "MASS", + "R", + "grDevices", + "methods", + "stats", + "survival" + ], + "Hash": "f40ef9686e85681a1ccbf33d9236aeb9" + }, + "fontawesome": { + "Package": "fontawesome", + "Version": "0.5.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "htmltools", + "rlang" + ], + "Hash": "c2efdd5f0bcd1ea861c2d4e2a883a67d" + }, + "formatR": { + "Package": "formatR", + "Version": "1.14", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "63cb26d12517c7863f5abb006c5e0f25" + }, + "fs": { + "Package": "fs", + "Version": "1.6.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "47b5f30c720c23999b913a1a635cf0bb" + }, + "futile.logger": { + "Package": "futile.logger", + "Version": "1.4.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "futile.options", + "lambda.r", + "utils" + ], + "Hash": "99f0ace8c05ec7d3683d27083c4f1e7e" + }, + "futile.options": { + "Package": "futile.options", + "Version": "1.0.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "0d9bf02413ddc2bbe8da9ce369dcdd2b" + }, + "future": { + "Package": "future", + "Version": "1.33.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "digest", + "globals", + "listenv", + "parallel", + "parallelly", + "utils" + ], + "Hash": "e57e292737f7a4efa9d8a91c5908222c" + }, + "future.apply": { + "Package": "future.apply", + "Version": "1.11.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "future", + "globals", + "parallel", + "utils" + ], + "Hash": "455e00c16ec193c8edcf1b2b522b3288" + }, + "generics": { + "Package": "generics", + "Version": "0.1.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "15e9634c0fcd294799e9b2e929ed1b86" + }, + "ggbeeswarm": { + "Package": "ggbeeswarm", + "Version": "0.7.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "beeswarm", + "cli", + "ggplot2", + "lifecycle", + "vipor" + ], + "Hash": "899f28fe0388b7f687d7453429c2474d" + }, + "ggplot2": { + "Package": "ggplot2", + "Version": "3.5.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "MASS", + "R", + "cli", + "glue", + "grDevices", + "grid", + "gtable", + "isoband", + "lifecycle", + "mgcv", + "rlang", + "scales", + "stats", + "tibble", + "vctrs", + "withr" + ], + "Hash": "52ef83f93f74833007f193b2d4c159a2" + }, + "ggrastr": { + "Package": "ggrastr", + "Version": "1.0.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Cairo", + "R", + "ggbeeswarm", + "ggplot2", + "grid", + "png", + "ragg" + ], + "Hash": "7c8178842114bfcd44e688e7fd84c52a" + }, + "ggrepel": { + "Package": "ggrepel", + "Version": "0.9.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "ggplot2", + "grid", + "rlang", + "scales", + "withr" + ], + "Hash": "cc3361e234c4a5050e29697d675764aa" + }, + "ggridges": { + "Package": "ggridges", + "Version": "0.5.6", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "ggplot2", + "grid", + "scales", + "withr" + ], + "Hash": "66488692cb8621bc78df1b9b819497a6" + }, + "globals": { + "Package": "globals", + "Version": "0.16.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "codetools" + ], + "Hash": "2580567908cafd4f187c1e5a91e98b7f" + }, + "glue": { + "Package": "glue", + "Version": "1.7.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "methods" + ], + "Hash": "e0b3a53876554bd45879e596cdb10a52" + }, + "goftest": { + "Package": "goftest", + "Version": "1.2-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "stats" + ], + "Hash": "dbe0201f91eeb15918dd3fbf01ee689a" + }, + "gplots": { + "Package": "gplots", + "Version": "3.1.3.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "KernSmooth", + "R", + "caTools", + "gtools", + "methods", + "stats" + ], + "Hash": "f72b5d1ed587f8905e38ee7295e88d80" + }, + "graph": { + "Package": "graph", + "Version": "1.80.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "R", + "methods", + "stats", + "stats4", + "utils" + ], + "Hash": "af02a936ce577656083213cdd8f5584d" + }, + "gridExtra": { + "Package": "gridExtra", + "Version": "2.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grDevices", + "graphics", + "grid", + "gtable", + "utils" + ], + "Hash": "7d7f283939f563670a697165b2cf5560" + }, + "gtable": { + "Package": "gtable", + "Version": "0.3.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "glue", + "grid", + "lifecycle", + "rlang" + ], + "Hash": "b29cf3031f49b04ab9c852c912547eef" + }, + "gtools": { + "Package": "gtools", + "Version": "3.9.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "methods", + "stats", + "utils" + ], + "Hash": "588d091c35389f1f4a9d533c8d709b35" + }, + "here": { + "Package": "here", + "Version": "1.0.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "rprojroot" + ], + "Hash": "24b224366f9c2e7534d2344d10d59211" + }, + "highr": { + "Package": "highr", + "Version": "0.10", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "xfun" + ], + "Hash": "06230136b2d2b9ba5805e1963fa6e890" + }, + "hms": { + "Package": "hms", + "Version": "1.1.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "lifecycle", + "methods", + "pkgconfig", + "rlang", + "vctrs" + ], + "Hash": "b59377caa7ed00fa41808342002138f9" + }, + "htmltools": { + "Package": "htmltools", + "Version": "0.5.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "base64enc", + "digest", + "ellipsis", + "fastmap", + "grDevices", + "rlang", + "utils" + ], + "Hash": "2d7b3857980e0e0d0a1fd6f11928ab0f" + }, + "htmlwidgets": { + "Package": "htmlwidgets", + "Version": "1.6.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grDevices", + "htmltools", + "jsonlite", + "knitr", + "rmarkdown", + "yaml" + ], + "Hash": "04291cc45198225444a397606810ac37" + }, + "httpuv": { + "Package": "httpuv", + "Version": "1.6.14", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "Rcpp", + "later", + "promises", + "utils" + ], + "Hash": "16abeb167dbf511f8cc0552efaf05bab" + }, + "httr": { + "Package": "httr", + "Version": "1.4.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "curl", + "jsonlite", + "mime", + "openssl" + ], + "Hash": "ac107251d9d9fd72f0ca8049988f1d7f" + }, + "ica": { + "Package": "ica", + "Version": "1.0-3", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "d9b52ced14e24a0e69e228c20eb5eb27" + }, + "igraph": { + "Package": "igraph", + "Version": "2.0.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "cli", + "cpp11", + "grDevices", + "graphics", + "lifecycle", + "magrittr", + "methods", + "pkgconfig", + "rlang", + "stats", + "utils", + "vctrs" + ], + "Hash": "c3b7d801d722e26e4cd888e042bf9af5" + }, + "interactiveDisplayBase": { + "Package": "interactiveDisplayBase", + "Version": "1.40.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "DT", + "R", + "methods", + "shiny" + ], + "Hash": "776b86cd30211a590997dc15d02c8eff" + }, + "irlba": { + "Package": "irlba", + "Version": "2.3.5.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "methods", + "stats" + ], + "Hash": "acb06a47b732c6251afd16e19c3201ff" + }, + "isoband": { + "Package": "isoband", + "Version": "0.2.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grid", + "utils" + ], + "Hash": "0080607b4a1a7b28979aecef976d8bc2" + }, + "jquerylib": { + "Package": "jquerylib", + "Version": "0.1.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "htmltools" + ], + "Hash": "5aab57a3bd297eee1c1d862735972182" + }, + "jsonlite": { + "Package": "jsonlite", + "Version": "1.8.8", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "methods" + ], + "Hash": "e1b9c55281c5adc4dd113652d9e26768" + }, + "kernlab": { + "Package": "kernlab", + "Version": "0.9-32", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "methods", + "stats" + ], + "Hash": "d7d6a7cb690ac73eeced99e1ed9d6cdb" + }, + "knitr": { + "Package": "knitr", + "Version": "1.45", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "evaluate", + "highr", + "methods", + "tools", + "xfun", + "yaml" + ], + "Hash": "1ec462871063897135c1bcbe0fc8f07d" + }, + "labeling": { + "Package": "labeling", + "Version": "0.4.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "graphics", + "stats" + ], + "Hash": "b64ec208ac5bc1852b285f665d6368b3" + }, + "lambda.r": { + "Package": "lambda.r", + "Version": "1.2.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "formatR" + ], + "Hash": "b1e925c4b9ffeb901bacf812cbe9a6ad" + }, + "later": { + "Package": "later", + "Version": "1.3.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Rcpp", + "rlang" + ], + "Hash": "a3e051d405326b8b0012377434c62b37" + }, + "lattice": { + "Package": "lattice", + "Version": "0.22-6", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "grid", + "stats", + "utils" + ], + "Hash": "cc5ac1ba4c238c7ca9fa6a87ca11a7e2" + }, + "lazyeval": { + "Package": "lazyeval", + "Version": "0.2.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "d908914ae53b04d4c0c0fd72ecc35370" + }, + "leiden": { + "Package": "leiden", + "Version": "0.4.3.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "igraph", + "methods", + "reticulate" + ], + "Hash": "b21c4ae2bb7935504c42bcdf749c04e6" + }, + "lifecycle": { + "Package": "lifecycle", + "Version": "1.0.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "glue", + "rlang" + ], + "Hash": "b8552d117e1b808b09a832f589b79035" + }, + "limma": { + "Package": "limma", + "Version": "3.58.1", + "Source": "Bioconductor", + "Requirements": [ + "R", + "grDevices", + "graphics", + "methods", + "statmod", + "stats", + "utils" + ], + "Hash": "74c3b64358e0be7edc3ecd130816dd3f" + }, + "listenv": { + "Package": "listenv", + "Version": "0.9.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "e2fca3e12e4db979dccc6e519b10a7ee" + }, + "lmtest": { + "Package": "lmtest", + "Version": "0.9-40", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "graphics", + "stats", + "zoo" + ], + "Hash": "c6fafa6cccb1e1dfe7f7d122efd6e6a7" + }, + "locfit": { + "Package": "locfit", + "Version": "1.5-9.9", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "lattice" + ], + "Hash": "3885127e04b35dafded049075057ad83" + }, + "magick": { + "Package": "magick", + "Version": "2.8.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Rcpp", + "curl", + "magrittr" + ], + "Hash": "3f6bcbb8a0c1c9365b2f02d5d04ad7bc" + }, + "magrittr": { + "Package": "magrittr", + "Version": "2.0.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "7ce2733a9826b3aeb1775d56fd305472" + }, + "matrixStats": { + "Package": "matrixStats", + "Version": "1.2.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "33a3ca9e732b57244d14f5d732ffc9eb" + }, + "memoise": { + "Package": "memoise", + "Version": "2.0.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "cachem", + "rlang" + ], + "Hash": "e2817ccf4a065c5d9d7f2cfbe7c1d78c" + }, + "metapod": { + "Package": "metapod", + "Version": "1.10.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "Rcpp" + ], + "Hash": "64e76c256313f40ff540e371e58b5503" + }, + "mgcv": { + "Package": "mgcv", + "Version": "1.9-1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "graphics", + "methods", + "nlme", + "splines", + "stats", + "utils" + ], + "Hash": "110ee9d83b496279960e162ac97764ce" + }, + "mime": { + "Package": "mime", + "Version": "0.12", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "tools" + ], + "Hash": "18e9c28c1d3ca1560ce30658b22ce104" + }, + "miniUI": { + "Package": "miniUI", + "Version": "0.1.1.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "htmltools", + "shiny", + "utils" + ], + "Hash": "fec5f52652d60615fdb3957b3d74324a" + }, + "mixtools": { + "Package": "mixtools", + "Version": "2.0.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "MASS", + "R", + "kernlab", + "plotly", + "scales", + "segmented", + "stats", + "survival" + ], + "Hash": "2b9414057d7f3725130e2f743ea05a2f" + }, + "munsell": { + "Package": "munsell", + "Version": "0.5.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "colorspace", + "methods" + ], + "Hash": "6dfe8bf774944bd5595785e3229d8771" + }, + "nlme": { + "Package": "nlme", + "Version": "3.1-164", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "graphics", + "lattice", + "stats", + "utils" + ], + "Hash": "a623a2239e642806158bc4dc3f51565d" + }, + "openssl": { + "Package": "openssl", + "Version": "2.1.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "askpass" + ], + "Hash": "2a0dc8c6adfb6f032e4d4af82d258ab5" + }, + "parallelly": { + "Package": "parallelly", + "Version": "1.37.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "parallel", + "tools", + "utils" + ], + "Hash": "5410df8d22bd36e616f2a2343dbb328c" + }, + "patchwork": { + "Package": "patchwork", + "Version": "1.2.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "cli", + "ggplot2", + "grDevices", + "graphics", + "grid", + "gtable", + "rlang", + "stats", + "utils" + ], + "Hash": "9c8ab14c00ac07e9e04d1664c0b74486" + }, + "pbapply": { + "Package": "pbapply", + "Version": "1.7-2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "parallel" + ], + "Hash": "68a2d681e10cf72f0afa1d84d45380e5" + }, + "pheatmap": { + "Package": "pheatmap", + "Version": "1.0.12", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "RColorBrewer", + "grDevices", + "graphics", + "grid", + "gtable", + "scales", + "stats" + ], + "Hash": "db1fb0021811b6693741325bbe916e58" + }, + "pillar": { + "Package": "pillar", + "Version": "1.9.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "cli", + "fansi", + "glue", + "lifecycle", + "rlang", + "utf8", + "utils", + "vctrs" + ], + "Hash": "15da5a8412f317beeee6175fbc76f4bb" + }, + "pkgconfig": { + "Package": "pkgconfig", + "Version": "2.0.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "utils" + ], + "Hash": "01f28d4278f15c76cddbea05899c5d6f" + }, + "plogr": { + "Package": "plogr", + "Version": "0.2.0", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "09eb987710984fc2905c7129c7d85e65" + }, + "plotly": { + "Package": "plotly", + "Version": "4.10.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "RColorBrewer", + "base64enc", + "crosstalk", + "data.table", + "digest", + "dplyr", + "ggplot2", + "htmltools", + "htmlwidgets", + "httr", + "jsonlite", + "lazyeval", + "magrittr", + "promises", + "purrr", + "rlang", + "scales", + "tibble", + "tidyr", + "tools", + "vctrs", + "viridisLite" + ], + "Hash": "a1ac5c03ad5ad12b9d1597e00e23c3dd" + }, + "plyr": { + "Package": "plyr", + "Version": "1.8.9", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp" + ], + "Hash": "6b8177fd19982f0020743fadbfdbd933" + }, + "png": { + "Package": "png", + "Version": "0.1-8", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "bd54ba8a0a5faded999a7aab6e46b374" + }, + "polyclip": { + "Package": "polyclip", + "Version": "1.10-6", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "436542aadb70675e361cf359285af7c7" + }, + "prettyunits": { + "Package": "prettyunits", + "Version": "1.2.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "6b01fc98b1e86c4f705ce9dcfd2f57c7" + }, + "progress": { + "Package": "progress", + "Version": "1.2.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "crayon", + "hms", + "prettyunits" + ], + "Hash": "f4625e061cb2865f111b47ff163a5ca6" + }, + "progressr": { + "Package": "progressr", + "Version": "0.14.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "digest", + "utils" + ], + "Hash": "ac50c4ffa8f6a46580dd4d7813add3c4" + }, + "promises": { + "Package": "promises", + "Version": "1.2.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R6", + "Rcpp", + "fastmap", + "later", + "magrittr", + "rlang", + "stats" + ], + "Hash": "0d8a15c9d000970ada1ab21405387dee" + }, + "purrr": { + "Package": "purrr", + "Version": "1.0.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "lifecycle", + "magrittr", + "rlang", + "vctrs" + ], + "Hash": "1cba04a4e9414bdefc9dcaa99649a8dc" + }, + "ragg": { + "Package": "ragg", + "Version": "1.3.0", + "Source": "Repository", + "Repository": "carpentries", + "Requirements": [ + "systemfonts", + "textshaping" + ], + "Hash": "082e1a198e3329d571f4448ef0ede4bc" + }, + "rappdirs": { + "Package": "rappdirs", + "Version": "0.3.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "5e3c5dc0b071b21fa128676560dbe94d" + }, + "renv": { + "Package": "renv", + "Version": "1.0.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "utils" + ], + "Hash": "32c3f93e8360f667ca5863272ec8ba6a" + }, + "reshape2": { + "Package": "reshape2", + "Version": "1.4.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "plyr", + "stringr" + ], + "Hash": "bb5996d0bd962d214a11140d77589917" + }, + "restfulr": { + "Package": "restfulr", + "Version": "0.0.15", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "RCurl", + "S4Vectors", + "XML", + "methods", + "rjson", + "yaml" + ], + "Hash": "44651c1e68eda9d462610aca9f15a815" + }, + "reticulate": { + "Package": "reticulate", + "Version": "1.35.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "Rcpp", + "RcppTOML", + "graphics", + "here", + "jsonlite", + "methods", + "png", + "rappdirs", + "rlang", + "utils", + "withr" + ], + "Hash": "90be16b53b955990db4aa355c03d85eb" + }, + "rhdf5": { + "Package": "rhdf5", + "Version": "2.46.1", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "R", + "Rhdf5lib", + "S4Vectors", + "methods", + "rhdf5filters" + ], + "Hash": "b0a244022c3427cd8213c33804c6b5de" + }, + "rhdf5filters": { + "Package": "rhdf5filters", + "Version": "1.14.1", + "Source": "Bioconductor", + "Requirements": [ + "Rhdf5lib" + ], + "Hash": "d27a2f6a89def6388fad5b0aae026220" + }, + "rjson": { + "Package": "rjson", + "Version": "0.2.21", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "f9da75e6444e95a1baf8ca24909d63b9" + }, + "rlang": { + "Package": "rlang", + "Version": "1.1.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "utils" + ], + "Hash": "42548638fae05fd9a9b5f3f437fbbbe2" + }, + "rmarkdown": { + "Package": "rmarkdown", + "Version": "2.26", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "bslib", + "evaluate", + "fontawesome", + "htmltools", + "jquerylib", + "jsonlite", + "knitr", + "methods", + "tinytex", + "tools", + "utils", + "xfun", + "yaml" + ], + "Hash": "9b148e7f95d33aac01f31282d49e4f44" + }, + "rprojroot": { + "Package": "rprojroot", + "Version": "2.0.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "4c8415e0ec1e29f3f4f6fc108bef0144" + }, + "rsvd": { + "Package": "rsvd", + "Version": "1.0.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R" + ], + "Hash": "b462187d887abc519894874486dbd6fd" + }, + "rtracklayer": { + "Package": "rtracklayer", + "Version": "1.62.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocIO", + "Biostrings", + "GenomeInfoDb", + "GenomicAlignments", + "GenomicRanges", + "IRanges", + "R", + "RCurl", + "Rsamtools", + "S4Vectors", + "XML", + "XVector", + "methods", + "restfulr", + "tools", + "zlibbioc" + ], + "Hash": "e940c622725a16a0069505876051b077" + }, + "sass": { + "Package": "sass", + "Version": "0.4.9", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R6", + "fs", + "htmltools", + "rappdirs", + "rlang" + ], + "Hash": "d53dbfddf695303ea4ad66f86e99b95d" + }, + "scDblFinder": { + "Package": "scDblFinder", + "Version": "1.16.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocNeighbors", + "BiocParallel", + "BiocSingular", + "DelayedArray", + "GenomeInfoDb", + "GenomicRanges", + "IRanges", + "MASS", + "Matrix", + "R", + "Rsamtools", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "bluster", + "igraph", + "methods", + "rtracklayer", + "scater", + "scran", + "scuttle", + "stats", + "utils", + "xgboost" + ], + "Hash": "3dc5166545e7caa130d362f5b809677b" + }, + "scales": { + "Package": "scales", + "Version": "1.3.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "RColorBrewer", + "cli", + "farver", + "glue", + "labeling", + "lifecycle", + "munsell", + "rlang", + "viridisLite" + ], + "Hash": "c19df082ba346b0ffa6f833e92de34d1" + }, + "scater": { + "Package": "scater", + "Version": "1.30.1", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocNeighbors", + "BiocParallel", + "BiocSingular", + "DelayedArray", + "Matrix", + "MatrixGenerics", + "RColorBrewer", + "RcppML", + "Rtsne", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "beachmat", + "ggbeeswarm", + "ggplot2", + "ggrastr", + "ggrepel", + "methods", + "pheatmap", + "rlang", + "scuttle", + "stats", + "utils", + "uwot", + "viridis" + ], + "Hash": "d92b4aa892e1f28148ce3ecad8e63cfb" + }, + "scattermore": { + "Package": "scattermore", + "Version": "1.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "ggplot2", + "grDevices", + "graphics", + "grid", + "scales" + ], + "Hash": "d316e4abb854dd1677f7bd3ad08bc4e8" + }, + "scran": { + "Package": "scran", + "Version": "1.30.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Requirements": [ + "BH", + "BiocGenerics", + "BiocParallel", + "BiocSingular", + "DelayedArray", + "DelayedMatrixStats", + "Matrix", + "Rcpp", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "beachmat", + "bluster", + "dqrng", + "edgeR", + "igraph", + "limma", + "metapod", + "methods", + "scuttle", + "statmod", + "stats", + "utils" + ], + "Hash": "147b3753ca3cb0a1a24a7f2a35f05222" + }, + "sctransform": { + "Package": "sctransform", + "Version": "0.4.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "MASS", + "Matrix", + "R", + "Rcpp", + "RcppArmadillo", + "dplyr", + "future", + "future.apply", + "ggplot2", + "gridExtra", + "magrittr", + "matrixStats", + "methods", + "reshape2", + "rlang" + ], + "Hash": "0242402f321be0246fb67cf8c63b3572" + }, + "scuttle": { + "Package": "scuttle", + "Version": "1.12.0", + "Source": "Bioconductor", + "Requirements": [ + "BiocGenerics", + "BiocParallel", + "DelayedArray", + "DelayedMatrixStats", + "GenomicRanges", + "Matrix", + "Rcpp", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "beachmat", + "methods", + "stats", + "utils" + ], + "Hash": "1412c4b6dfd8de528e1101e493e66a02" + }, + "segmented": { + "Package": "segmented", + "Version": "2.0-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "MASS", + "R", + "nlme" + ], + "Hash": "64759091e34e35dffa60b74e69b170d9" + }, + "shiny": { + "Package": "shiny", + "Version": "1.8.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "R6", + "bslib", + "cachem", + "commonmark", + "crayon", + "ellipsis", + "fastmap", + "fontawesome", + "glue", + "grDevices", + "htmltools", + "httpuv", + "jsonlite", + "later", + "lifecycle", + "methods", + "mime", + "promises", + "rlang", + "sourcetools", + "tools", + "utils", + "withr", + "xtable" + ], + "Hash": "3a1f41807d648a908e3c7f0334bf85e6" + }, + "sitmo": { + "Package": "sitmo", + "Version": "2.0.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp" + ], + "Hash": "c956d93f6768a9789edbc13072b70c78" + }, + "snow": { + "Package": "snow", + "Version": "0.4-4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "utils" + ], + "Hash": "40b74690debd20c57d93d8c246b305d4" + }, + "sourcetools": { + "Package": "sourcetools", + "Version": "0.1.7-1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "5f5a7629f956619d519205ec475fe647" + }, + "sp": { + "Package": "sp", + "Version": "2.1-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "grid", + "lattice", + "methods", + "stats", + "utils" + ], + "Hash": "1a0cc0cec2915700e63fd0921085cf6a" + }, + "spam": { + "Package": "spam", + "Version": "2.10-0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "Rcpp", + "dotCall64", + "grid", + "methods" + ], + "Hash": "ffe1f9e95a4375530747b268f82b5086" + }, + "sparseMatrixStats": { + "Package": "sparseMatrixStats", + "Version": "1.14.0", + "Source": "Bioconductor", + "Requirements": [ + "Matrix", + "MatrixGenerics", + "Rcpp", + "matrixStats", + "methods" + ], + "Hash": "49383d0f6c6152ff7cb594f254c23cc8" + }, + "spatstat.data": { + "Package": "spatstat.data", + "Version": "3.0-4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "spatstat.utils" + ], + "Hash": "114a35341cb4955e1b8d30e28ec356c6" + }, + "spatstat.explore": { + "Package": "spatstat.explore", + "Version": "3.2-7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "abind", + "goftest", + "grDevices", + "graphics", + "methods", + "nlme", + "spatstat.data", + "spatstat.geom", + "spatstat.random", + "spatstat.sparse", + "spatstat.utils", + "stats", + "utils" + ], + "Hash": "b590c5d278d0606d53278afac666ad60" + }, + "spatstat.geom": { + "Package": "spatstat.geom", + "Version": "3.2-9", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "deldir", + "grDevices", + "graphics", + "methods", + "polyclip", + "spatstat.data", + "spatstat.utils", + "stats", + "utils" + ], + "Hash": "96b9f23da42d16660aa6d136ad99cf5f" + }, + "spatstat.random": { + "Package": "spatstat.random", + "Version": "3.2-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "methods", + "spatstat.data", + "spatstat.geom", + "spatstat.utils", + "stats", + "utils" + ], + "Hash": "01aff260c49550e820a47d97e566af6a" + }, + "spatstat.sparse": { + "Package": "spatstat.sparse", + "Version": "3.0-3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "abind", + "methods", + "spatstat.utils", + "stats", + "tensor", + "utils" + ], + "Hash": "1daaecefd754bb259a5ad5ce95a2cdcc" + }, + "spatstat.utils": { + "Package": "spatstat.utils", + "Version": "3.0-4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "methods", + "stats", + "utils" + ], + "Hash": "81d929f43f8532c1f8180a105449d414" + }, + "statmod": { + "Package": "statmod", + "Version": "1.5.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "graphics", + "stats" + ], + "Hash": "26e158d12052c279bdd4ba858b80fb1f" + }, + "stringi": { + "Package": "stringi", + "Version": "1.8.3", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "stats", + "tools", + "utils" + ], + "Hash": "058aebddea264f4c99401515182e656a" + }, + "stringr": { + "Package": "stringr", + "Version": "1.5.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "glue", + "lifecycle", + "magrittr", + "rlang", + "stringi", + "vctrs" + ], + "Hash": "960e2ae9e09656611e0b8214ad543207" + }, + "survival": { + "Package": "survival", + "Version": "3.5-8", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "graphics", + "methods", + "splines", + "stats", + "utils" + ], + "Hash": "184d7799bca4ba8c3be72ea396f4b9a3" + }, + "sys": { + "Package": "sys", + "Version": "3.4.2", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "3a1be13d68d47a8cd0bfd74739ca1555" + }, + "systemfonts": { + "Package": "systemfonts", + "Version": "1.0.6", + "Source": "Repository", + "Repository": "carpentries", + "Requirements": [ + "R", + "cpp11" + ], + "Hash": "6d538cff441f0f1f36db2209ac7495ac" + }, + "tensor": { + "Package": "tensor", + "Version": "1.5", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "25cfab6cf405c15bccf7e69ec39df090" + }, + "textshaping": { + "Package": "textshaping", + "Version": "0.3.7", + "Source": "Repository", + "Repository": "carpentries", + "Requirements": [ + "R", + "cpp11", + "systemfonts" + ], + "Hash": "997aac9ad649e0ef3b97f96cddd5622b" + }, + "tibble": { + "Package": "tibble", + "Version": "3.2.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "fansi", + "lifecycle", + "magrittr", + "methods", + "pillar", + "pkgconfig", + "rlang", + "utils", + "vctrs" + ], + "Hash": "a84e2cc86d07289b3b6f5069df7a004c" + }, + "tidyr": { + "Package": "tidyr", + "Version": "1.3.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "cpp11", + "dplyr", + "glue", + "lifecycle", + "magrittr", + "purrr", + "rlang", + "stringr", + "tibble", + "tidyselect", + "utils", + "vctrs" + ], + "Hash": "915fb7ce036c22a6a33b5a8adb712eb1" + }, + "tidyselect": { + "Package": "tidyselect", + "Version": "1.2.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "glue", + "lifecycle", + "rlang", + "vctrs", + "withr" + ], + "Hash": "829f27b9c4919c16b593794a6344d6c0" + }, + "tinytex": { + "Package": "tinytex", + "Version": "0.50", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "xfun" + ], + "Hash": "be7a76845222ad20adb761f462eed3ea" + }, + "utf8": { + "Package": "utf8", + "Version": "1.2.4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "62b65c52671e6665f803ff02954446e9" + }, + "uwot": { + "Package": "uwot", + "Version": "0.1.16", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "FNN", + "Matrix", + "Rcpp", + "RcppAnnoy", + "RcppProgress", + "dqrng", + "irlba", + "methods" + ], + "Hash": "252deaa1c1d6d3da6946694243781ea3" + }, + "vctrs": { + "Package": "vctrs", + "Version": "0.6.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "cli", + "glue", + "lifecycle", + "rlang" + ], + "Hash": "c03fa420630029418f7e6da3667aac4a" + }, + "vipor": { + "Package": "vipor", + "Version": "0.4.7", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "graphics", + "stats" + ], + "Hash": "86493c62c14eb78140f1725003958a77" + }, + "viridis": { + "Package": "viridis", + "Version": "0.6.5", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "ggplot2", + "gridExtra", + "viridisLite" + ], + "Hash": "acd96d9fa70adeea4a5a1150609b9745" + }, + "viridisLite": { + "Package": "viridisLite", + "Version": "0.4.2", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R" + ], + "Hash": "c826c7c4241b6fc89ff55aaea3fa7491" + }, + "withr": { + "Package": "withr", + "Version": "3.0.0", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics" + ], + "Hash": "d31b6c62c10dcf11ec530ca6b0dd5d35" + }, + "xfun": { + "Package": "xfun", + "Version": "0.42", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "grDevices", + "stats", + "tools" + ], + "Hash": "fd1349170df31f7a10bd98b0189e85af" + }, + "xgboost": { + "Package": "xgboost", + "Version": "1.7.7.1", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "Matrix", + "R", + "data.table", + "jsonlite", + "methods" + ], + "Hash": "6303e61eac62aef7bd2b396ef7e24386" + }, + "xml2": { + "Package": "xml2", + "Version": "1.3.6", + "Source": "Repository", + "Repository": "carpentries", + "Requirements": [ + "R", + "cli", + "methods", + "rlang" + ], + "Hash": "1d0336142f4cd25d8d23cd3ba7a8fb61" + }, + "xtable": { + "Package": "xtable", + "Version": "1.8-4", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "stats", + "utils" + ], + "Hash": "b8acdf8af494d9ec19ccb2481a9b11c2" + }, + "yaml": { + "Package": "yaml", + "Version": "2.3.8", + "Source": "Repository", + "Repository": "CRAN", + "Hash": "29240487a071f535f5e5d5a323b7afbd" + }, + "zellkonverter": { + "Package": "zellkonverter", + "Version": "1.12.1", + "Source": "Bioconductor", + "Requirements": [ + "DelayedArray", + "Matrix", + "S4Vectors", + "SingleCellExperiment", + "SummarizedExperiment", + "basilisk", + "cli", + "methods", + "reticulate", + "utils" + ], + "Hash": "bf5728624cccd09a78363e7b1f4f65e9" + }, + "zlibbioc": { + "Package": "zlibbioc", + "Version": "1.48.2", + "Source": "Bioconductor", + "Repository": "Bioconductor 3.18", + "Hash": "2344be62c2da4d9e9942b5d8db346e59" + }, + "zoo": { + "Package": "zoo", + "Version": "1.8-12", + "Source": "Repository", + "Repository": "CRAN", + "Requirements": [ + "R", + "grDevices", + "graphics", + "lattice", + "stats", + "utils" + ], + "Hash": "5c715954112b45499fb1dadc6ee6ee3e" + } + } +}