CellRanger | R Documentation |
Contains UMI droplet-based single-cell RNA-seq data.
CellRanger(
dir,
filtered = TRUE,
organism = NULL,
ensemblRelease = NULL,
genomeBuild = NULL,
gffFile = NULL,
refdataDir = NULL,
samples = NULL,
censorSamples = NULL,
sampleMetadataFile = NULL,
transgeneNames = NULL,
interestingGroups = "sampleName"
)
dir |
|
filtered |
|
organism |
|
ensemblRelease |
|
genomeBuild |
|
gffFile |
|
refdataDir |
|
samples |
|
censorSamples |
|
sampleMetadataFile |
|
transgeneNames |
|
interestingGroups |
|
Read 10x Genomics Cell Ranger output
for a Chromium data set into a SingleCellExperiment
object.
Currently supports loading of a single genome.
CellRanger
.
Cell Ranger can vary in its output directory structure, but we're requiring a
single, consistent directory structure for datasets containing multiple
samples that have not been aggregated into a single matrix with aggr
.
Cell Ranger v3 output:
| <dir>/ |-- <sampleName>/ |---- SC_RNA_COUNTER_CS/ |---- outs/ |------ filtered_feature_bc_matrix/ |-------- barcodes.tsv.gz |-------- features.tsv.gz |-------- matrix.mtx.gz |------ filtered_feature_bc_matrix.h5 |------ metrics_summary.csv |------ molecule_info.h5 |------ possorted_genome_bam.bam |------ possorted_genome_bam.bam.bai |------ raw_feature_bc_matrix/ |-------- barcodes.tsv.gz |-------- features.tsv.gz |-------- matrix.mtx.gz |------ raw_feature_bc_matrix.h5 |------ web_summary.html
Cell Ranger v2 output:
| <dir>/ |-- <sampleName>/ |---- SC_RNA_COUNTER_CS/ |---- outs/ |------ filtered_gene_bc_matrices/ |-------- <genomeBuild>/ |---------- barcodes.tsv |---------- genes.tsv |---------- matrix.mtx |------ filtered_gene_bc_matrices_h5.h5 |------ metrics_summary.csv |------ molecule_info.h5 |------ possorted_genome_bam.bam |------ possorted_genome_bam.bam.bai |------ raw_gene_bc_matrices/ |-------- <genomeBuild>/ |---------- barcodes.tsv |---------- genes.tsv |---------- matrix.mtx |------ raw_gene_bc_matrices_h5.h5
A user-supplied sample metadata file defined by sampleMetadataFile
is
required for multiplexed datasets. Otherwise this can be left NULL
, and
minimal sample data will be used, based on the directory names.
We strongly recommend supplying the corresponding reference data required for
Cell Ranger with the refdataDir
argument. It will convert the gene
annotations defined in the GTF file into a GRanges
object, which get
slotted in rowRanges()
. Otherwise, the
function will attempt to use the most current annotations available from
Ensembl, and some gene IDs may not match, due to deprecation in the current
Ensembl release.
Updated 2022-06-07.
https://support.10xgenomics.com/single-cell-gene-expression/
dir <- system.file("extdata", "cellranger_v3", package = "Chromium")
x <- CellRanger(dir)
print(x)
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.