README.md

ccImpute

Years in BioConductor badge Build results badge

In single-cell RNA sequencing (scRNA-seq) data, dropout events often mask lowly expressed genes, making them indistinguishable from true zero expression and obscuring subtle differences between cell types. This hinders accurate downstream analysis. ccImpute is an innovative imputation algorithm designed to address this issue. It leverages consensus clustering to identify similar cells and imputes the most probable dropout events. The rigorous evaluation demonstrates that ccImpute outperforms existing methods while minimizing the introduction of noise, as evidenced by clustering performance on datasets with known cell identities. Please see the manuscript for more details.

Installation

You can install the release version of ccImpute from BioConductor:

if (!require("BiocManager", quietly = TRUE))
    install.packages("BiocManager")

BiocManager::install("ccImpute")

Alternatively, you can install the development version of the package from GitHub with:

if (!require("devtools", quietly = TRUE))
    install.packages("devtools")
devtools::install_github("khazum/ccImpute")

Quick Start

Here's a simple example that loads scRNA-seq data and imputes dropout events, creating a new assay named 'imputed' within the 'SingleCellExperiment' object. Please refer to the package manual for detailed instructions and strategies to optimize the performance. package manual.

library(scRNAseq)
library(scater)
library(BiocParallel)

# Load Usoskin brain cells dataset:
sce <- UsoskinBrainData()

X <- cpm(sce)
labels <- colData(sce)$"Level 1"

# Do pre-processing of the data:
#Filter bad cells
filt <- !grepl("Empty well", labels) &
        !grepl("NF outlier", labels) &
        !grepl("TH outlier", labels) &
        !grepl("NoN outlier", labels) &
        !grepl("NoN", labels) &
        !grepl("Central, unsolved", labels) &
        !grepl(">1 cell", labels) &
        !grepl("Medium", labels)

labels <-labels[filt]
X <- as.matrix(X[,filt])

#Remove genes that are not expressed in any cells:
X <- X[rowSums(X)>0,]

#Recreate the SingleCellExperiment and add log-transformed data:
ann <- data.frame(cell_id = labels)
sce <- SingleCellExperiment(assays = list(normcounts = as.matrix(X)), 
                               colData = ann)
logcounts(sce) <- log(normcounts(sce) + 1)

cores <- 2
BPPARAM = MulticoreParam(cores)
sce <- ccImpute(sce, BPPARAM=BPPARAM)
summary(assay(sce, "imputed"))

Release Notes

Version 1.7.1

Version 0.99.x:

Issues

Please use this page to report bugs, comments and suggestions.



khazum/ccImpute documentation built on July 26, 2024, 1:13 a.m.