Importing scRNA-seq data |
|
---|---|
Construct SCE object from Salmon-Alevin output |
|
Create a SingleCellExperiment Object from Python AnnData .h5ad files |
|
Construct SCE object from BUStools output |
|
|
Construct SCE object from Cell Ranger output |
Construct SCE object from Cell Ranger V2 output for a single sample |
|
Construct SCE object from Cell Ranger V3 output for a single sample |
|
Create a SingleCellExperiment Object from DropEst output |
|
Retrieve example datasets |
|
Create a SingleCellExperiment object from files |
|
Imports gene sets from a GeneSetCollection object |
|
Imports gene sets from a GMT file |
|
Imports gene sets from a list |
|
Imports gene sets from MSigDB |
|
Import mitochondrial gene sets |
|
Imports samples from different sources and compiles them into a list of SCE objects |
|
Construct SCE object from Optimus output |
|
Construct SCE object from seqc output |
|
Construct SCE object from STARsolo outputs |
|
Read single cell expression matrix |
|
Quality Control & Preprocessing |
|
Perform comprehensive single cell QC |
|
Perform comprehensive droplet QC |
|
Decontamination |
|
Detecting contamination with DecontX. |
|
Doublet/Empty Droplet Detection |
|
Identify empty droplets using barcodeRanks. |
|
Identify empty droplets using emptyDrops. |
|
Find doublets/multiplets using bcds. |
|
Find doublets/multiplets using cxds. |
|
Find doublets/multiplets using cxds_bcds_hybrid. |
|
Detect doublet cells using scDblFinder. |
|
Generates a doublet score for each cell via doubletFinder |
|
Find doublets using |
|
Normalization |
|
Wrapper function to run any of the integrated normalization/transformation methods in the singleCellTK. The available methods include 'LogNormalize', 'CLR', 'RC' and 'SCTransform' from Seurat, 'logNormCounts and 'CPM' from Scater. Additionally, users can 'scale' using Z.Score, 'transform' using log, log1p and sqrt, add 'pseudocounts' and trim the final matrices between a range of values. |
|
scaterlogNormCounts Uses logNormCounts to log normalize input data |
|
scaterCPM Uses CPM from scater library to compute counts-per-million. |
|
seuratNormalizeData Wrapper for NormalizeData() function from seurat library Normalizes the sce object according to the input parameters |
|
seuratScaleData Scales the input sce object according to the input parameters |
|
Compute Z-Score |
|
Trim Counts |
|
Batch Effect Correction |
|
Apply ComBat-Seq batch effect correction method to SingleCellExperiment object |
|
Apply BBKNN batch effect correction method to SingleCellExperiment object |
|
Apply a fast version of the mutual nearest neighbors (MNN) batch effect correction method to SingleCellExperiment object |
|
Apply Limma's batch effect correction method to SingleCellExperiment object |
|
Apply the mutual nearest neighbors (MNN) batch effect correction method to SingleCellExperiment object |
|
Apply the mutual nearest neighbors (MNN) batch effect correction method to SingleCellExperiment object |
|
Apply scMerge batch effect correction method to SingleCellExperiment object |
|
seuratIntegration A wrapper function to Seurat Batch-Correction/Integration workflow. |
|
Apply ZINBWaVE Batch effect correction method to SingleCellExperiment object |
|
Plot the percent of the variation that is explained by batch and condition in the data |
|
Feature Selection |
|
scranModelGeneVar Generates and stores variability data from scran::modelGeneVar in the input singleCellExperiment object |
|
seuratFindHVG Find highly variable genes and store in the input sce object |
|
getTopHVG Extracts the top variable genes from an input singleCellExperiment object |
|
seuratPlotHVG Plot highly variable genes from input sce object (must have highly variable genes computations stored) |
|
Dimensionality Reduction |
|
Perform PCA on a SingleCellExperiment Object A wrapper to runPCA function to compute principal component analysis (PCA) from a given SingleCellExperiment object. |
|
Uniform Manifold Approximation and Projection(UMAP) algorithm for dimension reduction. |
|
Run t-SNE dimensionality reduction method on a SingleCellExperiment Object |
|
seuratICA Computes ICA on the input sce object and stores the calculated independent components within the sce object |
|
seuratPCA Computes PCA on the input sce object and stores the calculated principal components within the sce object |
|
seuratRunUMAP Computes UMAP from the given sce object and stores the UMAP computations back into the sce object |
|
seuratRunTSNE Computes tSNE from the given sce object and stores the tSNE computations back into the sce object |
|
Dimension reduction plot tool for colData |
|
Dimension reduction plot tool for assay data |
|
Clustering |
|
Get clustering with SNN graph |
|
seuratFindClusters Computes the clusters from the input sce object and stores them back in sce object |
|
Get clustering with KMeans |
|
Differential Expression |
|
Perform differential expression analysis on SCE with specified method Method supported: 'MAST', 'DESeq2', 'Limma', 'ANOVA' |
|
Perform differential expression analysis on SCE with Wilcoxon test |
|
Perform differential expression analysis on SCE with MAST |
|
Perform differential expression analysis on SCE with DESeq2. |
|
Perform differential expression analysis on SCE with Limma. |
|
Perform differential expression analysis on SCE with ANOVA |
|
plot the violin plot to show visualize the expression distribution of DEGs identified by differential expression analysis |
|
plot the linear regression to show visualize the expression the of DEGs identified by differential expression analysis |
|
Heatmap visualization of DEG result |
|
MAST Identify adaptive thresholds |
|
Find Marker |
|
Find the marker gene set for each cluster With an input SingleCellExperiment object and specifying the clustering labels, this function iteratively call the differential expression analysis on each cluster against all the others. |
|
Plot a heatmap to visualize the result of |
|
Visualization |
|
Plots for runEmptyDrops outputs. |
|
Plots for runBarcodeRankDrops outputs. |
|
Plot the percent of the variation that is explained by batch and condition in the data |
|
Plots for runBcds outputs. |
|
Given a set of genes, return a ggplot of expression values. |
|
Plot the differential Abundance |
|
Plots for runCxds outputs. |
|
Plots for runDecontX outputs. |
|
Heatmap visualization of DEG result |
|
plot the linear regression to show visualize the expression the of DEGs identified by differential expression analysis |
|
plot the violin plot to show visualize the expression distribution of DEGs identified by differential expression analysis |
|
Plot dimensionality reduction from computed metrics including PCA, ICA, tSNE and UMAP |
|
Plots for runDoubletFinder outputs. |
|
Plots for runEmptyDrops outputs. |
|
Plots for runEmptyDrops outputs. |
|
plotHeatmapMulti |
|
Plot a heatmap to visualize the result of |
|
MAST Identify adaptive thresholds |
|
Plot PCA run data from its components. |
|
Plots for runPerCellQC outputs. |
|
Plots for runScDblFinder outputs. |
|
Plots for runCxdsBcdsHybrid outputs. |
|
Bar plot of assay data. |
|
Bar plot of colData. |
|
Plot mean feature value in each batch of a SingleCellExperiment object |
|
Density plot of any data stored in the SingleCellExperiment object. |
|
Density plot of assay data. |
|
Density plot of colData. |
|
Dimension reduction plot tool for colData |
|
Dimension reduction plot tool for assay data |
|
Plot heatmap of using data stored in SingleCellExperiment Object |
|
Dimension reduction plot tool for all types of data |
|
Violin plot of any data stored in the SingleCellExperiment object. |
|
Violin plot of assay data. |
|
Violin plot of colData. |
|
Plots for runScrublet outputs. |
|
Plot highly variable genes |
|
Plot t-SNE plot on dimensionality reduction data run from t-SNE method. |
|
Plot UMAP results either on already run results or run first and then plot. |
|
Exporting Results |
|
Export data in SingleCellExperiment object |
|
Export a SingleCellExperiment R object as Python annData object |
|
Export a SingleCellExperiment object to flat text files |
|
Export data in Seurat object |
|
Other Data processing |
|
Combine a list of SingleCellExperiment objects as one SingleCellExperiment object |
|
convertSCEToSeurat Converts sce object to seurat while retaining all assays and metadata |
|
convertSeuratToSCE Converts the input seurat object to a sce object |
|
Subset a SingleCellExperiment object by columns |
|
Subset a SingleCellExperiment object by rows |
|
Deduplicate the rownames of a matrix or SingleCellExperiment object
Adds '-1', '-2', ... '-i' to multiple duplicated rownames, and in place
replace the unique rownames, store unique rownames in |