| Start the Shiny APP | |
|---|---|
| Run the single cell analysis app | |
| 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 | |
| Wrapper for calculating QC metrics with scater. | |
| Get runDropletQC .html report | |
| Get runCellQC .html report | |
| Plots for runPerCellQC outputs. | |
| Decontamination | |
| Detecting contamination with DecontX. | |
| Plots for runDecontX outputs. | |
| Detecting and correct contamination with SoupX | |
| Get or Set SoupX Result | |
| Plot SoupX Result | |
| 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  | |
| Plots for runBarcodeRankDrops outputs. | |
| Plots for runEmptyDrops outputs. | |
| Plots for runBcds outputs. | |
| Plots for runCxds outputs. | |
| Plots for runCxdsBcdsHybrid outputs. | |
| Plots for runScDblFinder outputs. | |
| Plots for runDoubletFinder outputs. | |
| Plots for runScrublet outputs. | |
| Normalization | |
| Run normalization/transformation with various methods | |
| scaterlogNormCounts Uses logNormCounts to log normalize input data | |
| scaterCPM Uses CPM from scater library to compute counts-per-million. | |
| runSeuratNormalizeData Wrapper for NormalizeData() function from seurat library Normalizes the sce object according to the input parameters | |
| runSeuratScaleData Scales the input sce object according to the input parameters | |
| runSeuratSCTransform Runs the SCTransform function to transform/normalize the input data | |
| Compute Z-Score | |
| Trim Counts | |
| Batch Effect Correction | |
| Apply the mutual nearest neighbors (MNN) batch effect correction method to SingleCellExperiment object | |
| 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 Harmony 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 | |
| runSeuratIntegration 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 | |
| Plot comparison of batch corrected result against original assay | |
| Plot mean feature value in each batch of a SingleCellExperiment object | |
| Feature Selection | |
| Run Variable Feature Detection Methods | |
| Calculate Variable Genes with Scran modelGeneVar | |
| runSeuratFindHVG Find highly variable genes and store in the input sce object | |
| Get or set top HVG after calculation | |
| Plot highly variable genes | |
| Dimensionality Reduction & Embedding | |
| Generic Wrapper function for running dimensionality reduction | |
| Perform scater PCA on a SingleCellExperiment Object | |
| Run UMAP embedding with scater method | |
| Run t-SNE embedding with Rtsne method | |
| runSeuratICA Computes ICA on the input sce object and stores the calculated independent components within the sce object | |
| runSeuratPCA Computes PCA on the input sce object and stores the calculated principal components within the sce object | |
| runSeuratUMAP Computes UMAP from the given sce object and stores the UMAP computations back into the sce object | |
| runSeuratTSNE Computes tSNE from the given sce object and stores the tSNE computations back into the sce object | |
| Plot PCA run data from its components. | |
| Plot UMAP results either on already run results or run first and then plot. | |
| Plot t-SNE plot on dimensionality reduction data run from t-SNE method. | |
| Plot dimensionality reduction from computed metrics including PCA, ICA, tSNE and UMAP | |
| Dimension reduction plot tool for colData | |
| Dimension reduction plot tool for assay data | |
| Clustering | |
| Get clustering with SNN graph | |
| runSeuratFindClusters 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 object | 
| Get Top Table of a DEG analysis | |
| Generate volcano plot for DEGs | |
| Generate violin plot to show the expression of top DEGs | |
| Create linear regression plot to show the expression the of top DEGs | |
| Heatmap visualization of DEG result | |
| MAST Identify adaptive thresholds | |
| Find Marker | |
| Find the marker gene set for each cluster | |
| Fetch the table of top markers that pass the filtering | |
| Plot a heatmap to visualize the result of  | |
| Differential Abundance | |
| Calculate Differential Abundance with FET | |
| Get/Set diffAbundanceFET result table | |
| Plot the differential Abundance | |
| Cell Type Labeling | |
| Label cell types with SingleR | |
| Enrichment & Pathway Analysis | |
| Shows MSigDB categories | |
| Run EnrichR on SCE object | |
| Get or Set EnrichR Result | |
| Run GSVA analysis on a SingleCellExperiment object | |
| Run VAM to score gene sets in single cell data | |
| List pathway analysis result names | |
| Generate violin plots for pathway analysis results | |
| Trajectory Analysis | |
| Run TSCAN to obtain pseudotime values for cells | |
| Find DE genes between all TSCAN paths rooted from given cluster | |
| Test gene expression changes along a TSCAN trajectory path | |
| Plot features identified by  | |
| Plot TSCAN pseudotime rooted from given cluster | |
| Plot feature expression on cell 2D embedding with MST overlaid | |
| Plot expression changes of top features along a TSCAN pseudotime path | |
| Plot heatmap of genes with expression change along TSCAN pseudotime | |
| Plot MST pseudotime values on cell 2D embedding | |
| 
 | getTSCANResults accessor function | 
| Seurat Curated Workflow | |
| runSeuratFindClusters Computes the clusters from the input sce object and stores them back in sce object | |
| runSeuratFindHVG Find highly variable genes and store in the input sce object | |
| runSeuratFindMarkers | |
| runSeuratHeatmap Computes the heatmap plot object from the pca slot in the input sce object | |
| runSeuratICA Computes ICA on the input sce object and stores the calculated independent components within the sce object | |
| runSeuratIntegration A wrapper function to Seurat Batch-Correction/Integration workflow. | |
| runSeuratJackStraw Compute jackstraw plot and store the computations in the input sce object | |
| runSeuratNormalizeData Wrapper for NormalizeData() function from seurat library Normalizes the sce object according to the input parameters | |
| runSeuratPCA Computes PCA on the input sce object and stores the calculated principal components within the sce object | |
| runSeuratSCTransform Runs the SCTransform function to transform/normalize the input data | |
| runSeuratScaleData Scales the input sce object according to the input parameters | |
| runSeuratTSNE Computes tSNE from the given sce object and stores the tSNE computations back into the sce object | |
| runSeuratUMAP Computes UMAP from the given sce object and stores the UMAP computations back into the sce object | |
| Computes heatmap for a set of features against dimensionality reduction components | |
| Get variable feature names after running runSeuratFindHVG function | |
| Scanpy Curated Workflow | |
| runScanpyFindClusters Computes the clusters from the input sce object and stores them back in sce object | |
| runScanpyFindHVG Find highly variable genes and store in the input sce object | |
| runScanpyFindMarkers | |
| runScanpyNormalizeData Wrapper for NormalizeData() function from scanpy library Normalizes the sce object according to the input parameters | |
| runScanpyPCA Computes PCA on the input sce object and stores the calculated principal components within the sce object | |
| runScanpyScaleData Scales the input sce object according to the input parameters | |
| runScanpyTSNE Computes tSNE from the given sce object and stores the tSNE computations back into the sce object | |
| runScanpyUMAP Computes UMAP from the given sce object and stores the UMAP computations back into the sce object | |
| Visualization | |
| Plots for runBarcodeRankDrops outputs. | |
| Plots for runBarcodeRankDrops outputs. | |
| Plot comparison of batch corrected result against original assay | |
| Plot the percent of the variation that is explained by batch and condition in the data | |
| Plots for runBcds outputs. | |
| Plot the differential Abundance | |
| Plots for runCxds outputs. | |
| Heatmap visualization of DEG result | |
| Create linear regression plot to show the expression the of top DEGs | |
| Generate violin plot to show the expression of top DEGs | |
| Generate volcano plot for DEGs | |
| Plots for runDecontX outputs. | |
| Plot dimensionality reduction from computed metrics including PCA, ICA, tSNE and UMAP | |
| Plots for runDoubletFinder outputs. | |
| Plots for runEmptyDrops outputs. | |
| Plots for runEmptyDrops outputs. | |
| Plot a heatmap to visualize the result of  | |
| MAST Identify adaptive thresholds | |
| Plot PCA run data from its components. | |
| Generate violin plots for pathway analysis results | |
| Plots for runPerCellQC 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 runScDblFinder outputs. | |
| plotScanpyDotPlot | |
| plotScanpyEmbedding | |
| plotScanpyHVG | |
| plotScanpyHeatmap | |
| plotScanpyMarkerGenes | |
| plotScanpyMarkerGenesDotPlot | |
| plotScanpyMarkerGenesHeatmap | |
| plotScanpyMarkerGenesMatrixPlot | |
| plotScanpyMarkerGenesViolin | |
| plotScanpyMatrixPlot | |
| plotScanpyPCA | |
| plotScanpyPCAGeneRanking | |
| plotScanpyPCAVariance | |
| plotScanpyViolin | |
| Plots for runCxdsBcdsHybrid outputs. | |
| Plots for runScrublet outputs. | |
| plotSeuratElbow Computes the plot object for elbow plot from the pca slot in the input sce object | |
| Compute and plot visualizations for marker genes | |
| plotSeuratHVG Plot highly variable genes from input sce object (must have highly variable genes computations stored) | |
| plotSeuratHeatmap Modifies the heatmap plot object so it contains specified number of heatmaps in a single plot | |
| plotSeuratJackStraw Computes the plot object for jackstraw plot from the pca slot in the input sce object | |
| plotSeuratReduction Plots the selected dimensionality reduction method | |
| Plot SoupX Result | |
| Plot features identified by  | |
| Plot TSCAN pseudotime rooted from given cluster | |
| Plot feature expression on cell 2D embedding with MST overlaid | |
| Plot expression changes of top features along a TSCAN pseudotime path | |
| Plot heatmap of genes with expression change along TSCAN pseudotime | |
| Plot MST pseudotime values on cell 2D embedding | |
| Plot t-SNE plot on dimensionality reduction data run from t-SNE method. | |
| Plot highly variable genes | |
| Plot UMAP results either on already run results or run first and then plot. | |
| Report Generation | |
| Get runCellQC .html report | |
| Get plotClusterAbundance .html report | |
| Get diffAbundanceFET .html report | |
| Get runDEAnalysis .html report | |
| Get runDropletQC .html report | |
| Get runFindMarker .html report | |
| Get .html report of the output of the selected QC algorithm | |
| Generates an HTML report for the complete Seurat workflow and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Clustering and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Dimensionality Reduction and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Feature Selection and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Results (including Clustering & Marker Selection) and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Normalization and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Results (including Clustering & Marker Selection) and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Run (including Normalization, Feature Selection, Dimensionality Reduction & Clustering) and returns the SCE object with the results computed and stored inside the object. | |
| Generates an HTML report for Seurat Scaling and returns the SCE object with the results computed and stored inside the object. | |
| Exporting Results | |
| Export data in SingleCellExperiment object | |
| Export data in Seurat object | |
| Export a SingleCellExperiment R object as Python annData object | |
| Export a SingleCellExperiment object to flat text files | |
| Datasets | |
| Example Single Cell RNA-Seq data in SingleCellExperiment Object, GSE60361 subset | |
| Example Single Cell RNA-Seq data in SingleCellExperiment object, with different batches annotated | |
| List of mitochondrial genes of multiple reference | |
| MSigDB gene get Category table | |
| Example Single Cell RNA-Seq data in SingleCellExperiment Object, subset of 10x public dataset | |
| Stably Expressed Gene (SEG) list obect, with SEG sets for human and mouse. | |
| Other Data Processing | |
| expData
Get data item from an input  | |
| 
 | expData Store data items using tags to identify the type of data item stored. To be used as a replacement for assay<- setter function but with additional parameter to set a tag to a data item. | 
| expData Store data items using tags to identify the type of data item stored. To be used as a replacement for assay<- setter function but with additional parameter to set a tag to a data item. | |
| expData
Get data item from an input  | |
| expDataNames
Get names of all the data items in the input  | |
| expDataNames
Get names of all the data items in the input  | |
| expDeleteDataTag Remove tag against an input data from the stored tag information in the metadata of the input object. | |
| expSetDataTag Set tag to an assay or a data item in the input SCE object. | |
| expTaggedData
Returns a list of names of data items from the 
input  | |
| Finds the effect sizes for all genes in the original dataset, regardless of significance. | |
| 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 | |
| Create SingleCellExperiment object from csv or txt input | |
| Deduplicate the rownames of a matrix or SingleCellExperiment object | |
| Detecting outliers within the SingleCellExperiment object. | |
| Generate given number of color codes | |
| Generate a distinct palette for coloring different clusters | |
| Estimate numbers of detected genes, significantly differentially expressed genes, and median significant effect size | |
| Estimate numbers of detected genes, significantly differentially expressed genes, and median significant effect size | |
| Retrieve row index for a set of features | |
| Retrieve cell/feature index by giving identifiers saved in col/rowData | |
| Generate table of SCTK QC outputs. | |
| 
 | Stores and returns table of SCTK QC outputs to metadata. | 
| Lists the table of SCTK QC outputs stored within the metadata. | |
| Lists imported GeneSetCollections | |
| List geneset names from geneSetCollection | |
| Indicates which rowData to use for visualization | |
| Subset a SingleCellExperiment object by columns | |
| Subset a SingleCellExperiment object by rows | |
| Generate HTAN manifest file for droplet and cell count data | |
| Generate HTAN manifest file for droplet and cell count data | |
| Generates a single simulated dataset, bootstrapping from the input counts matrix. | |
| Given a list of genes and a SingleCellExperiment object, return the binary or continuous expression of the genes. | |
| Extract QC parameters from the SingleCellExperiment object | |
| Returns significance data from a snapshot. | |
| Merging colData from two singleCellExperiment objects | |
| Create SingleCellExperiment object from command line input arguments | |
| Set rownames of SCE with a character vector or a rowData column | |
| Passes the output of generateSimulatedData() to differential expression tests, picking either t-tests or ANOVA for data with only two conditions or multiple conditions, respectively. | |
| Summarize an assay in a SingleCellExperiment | |
| Python Environment Setting | |
| Installs Python packages into a Conda environment | |
| Selects a Conda environment | |
| Installs Python packages into a virtual environment | |
| Selects a virtual environment | |