All Projects → single-cell-genetics → cardelino

single-cell-genetics / cardelino

Licence: other
Clone identification from single-cell data

Programming Languages

r
7636 projects

Projects that are alternatives of or similar to cardelino

scAlign
A deep learning-based tool for alignment and integration of single cell genomic data across multiple datasets, species, conditions, batches
Stars: ✭ 32 (-34.69%)
Mutual labels:  scrna-seq, single-cell
fastq utils
Validation and manipulation of FASTQ files, scRNA-seq barcode pre-processing and UMI quantification.
Stars: ✭ 25 (-48.98%)
Mutual labels:  scrna-seq, single-cell
SPLiT-Seq demultiplexing
An unofficial demultiplexing strategy for SPLiT-seq RNA-Seq data
Stars: ✭ 20 (-59.18%)
Mutual labels:  scrna-seq, single-cell
single-cell-papers-with-code
Papers with code for single cell related papers
Stars: ✭ 20 (-59.18%)
Mutual labels:  scrna-seq, single-cell
babel
Deep learning model for single-cell inference of multi-omic profiles from a single input modality.
Stars: ✭ 20 (-59.18%)
Mutual labels:  scrna-seq, single-cell
scarches
Reference mapping for single-cell genomics
Stars: ✭ 175 (+257.14%)
Mutual labels:  scrna-seq, single-cell
celltypist
A tool for semi-automatic cell type annotation
Stars: ✭ 92 (+87.76%)
Mutual labels:  scrna-seq, single-cell
scarf
Toolkit for highly memory efficient analysis of single-cell RNA-Seq, scATAC-Seq and CITE-Seq data. Analyze atlas scale datasets with millions of cells on laptop.
Stars: ✭ 54 (+10.2%)
Mutual labels:  scrna-seq
cellrouter
Reconstruction of complex single-cell trajectories using CellRouter
Stars: ✭ 38 (-22.45%)
Mutual labels:  scrna-seq
symphony
Efficient and precise single-cell reference atlas mapping with Symphony
Stars: ✭ 69 (+40.82%)
Mutual labels:  scrna-seq
souporcell
Clustering scRNAseq by genotypes
Stars: ✭ 88 (+79.59%)
Mutual labels:  scrna-seq
Tangram
Spatial alignment of single cell transcriptomic data.
Stars: ✭ 149 (+204.08%)
Mutual labels:  scrna-seq
zellkonverter
Conversion between scRNA-seq objects
Stars: ✭ 67 (+36.73%)
Mutual labels:  scrna-seq
BEER
BEER: Batch EffEct Remover for single-cell data
Stars: ✭ 19 (-61.22%)
Mutual labels:  scrna-seq
SHARP
SHARP: Single-cell RNA-seq Hyper-fast and Accurate processing via ensemble Random Projection
Stars: ✭ 14 (-71.43%)
Mutual labels:  scrna-seq
visium-clustergrammer2
Spatial Transcriptomics Dashboard
Stars: ✭ 24 (-51.02%)
Mutual labels:  scrna-seq
vireo
Demultiplexing pooled scRNA-seq data with or without genotype reference
Stars: ✭ 34 (-30.61%)
Mutual labels:  scrna-seq
clustergrammer2-notebooks
Examples using Clustergrammer2 to explore high-dimensional datasets.
Stars: ✭ 35 (-28.57%)
Mutual labels:  scrna-seq
Harmony
Harmony framework for connecting scRNA-seq data from discrete time points
Stars: ✭ 36 (-26.53%)
Mutual labels:  scrna-seq
scHPF
Single-cell Hierarchical Poisson Factorization
Stars: ✭ 52 (+6.12%)
Mutual labels:  scrna-seq

cardelino: clone identification from single-cell data

R build status

cardelino contains a Bayesian method to infer clonal structure for a population of cells using single-cell RNA-seq data (and possibly other data modalities).

In its main mode cardelino requires:

  • An imperfect clonal tree structure inferred using, for example Canopy, from bulk or single-cell DNA sequencing data (e.g. bulk whole exome sequencing data).

  • Single-cell RNA sequencing data from which cell-specific somatic variants are called using, for example cellsnp-lite.

Installation

Release version

You can install the release version of cardelino from BioConductor:

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

BiocManager::install("cardelino")

Development version

The development version of cardelino can be installed using the remotes package thus:

# install.packages("remotes")
remotes::install_github("single-cell-genetics/cardelino")

Getting started

The best place to start are the vignettes. From inside an R session, load cardelino and then browse the vignettes:

library(cardelino)
browseVignettes("cardelino")

Notes on donor deconvolution

The donor demultiplex function, named Vireo, was previously supported in this R package, but now has been re-implemented in Python, which is more memory efficient and easier to run via a command line. We, therefore, highly recommend you switch to the Python version: https://vireoSNP.readthedocs.io.

The vireo function is not supported from version >=0.5.0. If you want to use the R functions, please use the version ==0.4.2 or lower. You can also find it in a separate branch in this repository: with_vireo branch or use the donor_id.R file directly. However, using the Python implementation of Vireo is strongly recommended.

Code of Conduct

Please note that the cardelino project is released with a Contributor Code of Conduct. By contributing to this project, you agree to abide by its terms.

Citation

If you find cardelino helpful please consider citing:

McCarthy, D.J., Rostom, R., Huang, Y. et al. (2020) Cardelino: computational integration of somatic clonal substructure and single-cell transcriptomes. Nature Methods

About the name

cardelino is almost an anagram of "clone ID R" and is almost the same as the Italian for "goldfinch", a common and attractive European bird, pictured below and used in cardelino's hex sticker. In the Western art canon, the goldfinch is considered a "saviour" bird and appears in notable paintings from the Italian renaissance and the Dutch Golden Age. Perhaps this package may prove a saviour for certain single-cell datasets!

Acknowledgement: The cardelino image was produced by Darren Bellerby. It was obtained from Flickr and is reproduced here under a CC-BY-2.0 licence.

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].