All Projects → single-cell-genetics → cellsnp-lite

single-cell-genetics / cellsnp-lite

Licence: Apache-2.0 license
Efficient genotyping bi-allelic SNPs on single cells

Programming Languages

c
50402 projects - #5 most used programming language
shell
77523 projects
Makefile
30231 projects
M4
1887 projects
python
139335 projects - #7 most used programming language

Projects that are alternatives of or similar to cellsnp-lite

cellSNP
Pileup biallelic SNPs from single-cell and bulk RNA-seq data
Stars: ✭ 42 (-10.64%)
Mutual labels:  single-cell, genetic-variants, genotyping
kana
Single cell analysis in the browser
Stars: ✭ 81 (+72.34%)
Mutual labels:  single-cell
scPower
Experimental design framework for scRNAseq population studies (eQTL and DE)
Stars: ✭ 19 (-59.57%)
Mutual labels:  single-cell
dyngen
Simulating single-cell data using gene regulatory networks 📠
Stars: ✭ 59 (+25.53%)
Mutual labels:  single-cell
cardelino
Clone identification from single-cell data
Stars: ✭ 49 (+4.26%)
Mutual labels:  single-cell
SCICoNE
Single-cell copy number calling and event history reconstruction.
Stars: ✭ 20 (-57.45%)
Mutual labels:  single-cell
velodyn
Dynamical systems methods for RNA velocity analysis
Stars: ✭ 16 (-65.96%)
Mutual labels:  single-cell
Circle-Map
A method for circular DNA detection based on probabilistic mapping of ultrashort reads
Stars: ✭ 45 (-4.26%)
Mutual labels:  genotyping
Nebulosa
R package to visualize gene expression data based on weighted kernel density estimation
Stars: ✭ 50 (+6.38%)
Mutual labels:  single-cell
scAlign
A deep learning-based tool for alignment and integration of single cell genomic data across multiple datasets, species, conditions, batches
Stars: ✭ 32 (-31.91%)
Mutual labels:  single-cell
SCope
Fast visualization tool for large-scale and high dimensional single-cell data
Stars: ✭ 62 (+31.91%)
Mutual labels:  single-cell
CrossTalkeR
R package to do the Ligand Receptor Analysis Visualization
Stars: ✭ 33 (-29.79%)
Mutual labels:  single-cell
CITE-seq-Count
A tool that allows to get UMI counts from a single cell protein assay
Stars: ✭ 62 (+31.91%)
Mutual labels:  single-cell
Awesome Single Cell
Community-curated list of software packages and data resources for single-cell, including RNA-seq, ATAC-seq, etc.
Stars: ✭ 1,937 (+4021.28%)
Mutual labels:  single-cell
scMCA
Mouse cell atlas
Stars: ✭ 45 (-4.26%)
Mutual labels:  single-cell
SPLiT-Seq demultiplexing
An unofficial demultiplexing strategy for SPLiT-seq RNA-Seq data
Stars: ✭ 20 (-57.45%)
Mutual labels:  single-cell
scATAC-pro
A comprehensive tool for processing, analyzing and visulizing single cell chromatin accessibility sequencing data
Stars: ✭ 63 (+34.04%)
Mutual labels:  single-cell
NGS
Next-Gen Sequencing tools from the Horvath Lab
Stars: ✭ 30 (-36.17%)
Mutual labels:  single-cell
sinto
Tools for single-cell data processing
Stars: ✭ 74 (+57.45%)
Mutual labels:  single-cell
anndata2ri
Convert between AnnData and SingleCellExperiment
Stars: ✭ 79 (+68.09%)
Mutual labels:  single-cell

cellsnp-lite

conda platforms license

cellsnp-lite was initially designed to pileup the expressed alleles in single-cell or bulk RNA-seq data, which can be directly used for donor deconvolution in multiplexed single-cell RNA-seq data, particularly with vireo, which assigns cells to donors and detects doublets, even without genotyping reference. Now besides RNA-seq data, cellsnp-lite could also be applied on DNA-seq and ATAC-seq data, either in bulk or single-cell.

cellsnp-lite heavily depends on htslib. This program should give very similar results as samtools/bcftools mpileup. Also, there are two major differences comparing to bcftools mpileup:

  1. cellsnp-lite can now pileup a list of positions, with directly splitting into a list of cell barcodes, e.g., for 10x genome. With bcftools, you may need to manipulate the RG tag in the bam file if you want to divide reads into cell barcode groups.
  2. cellsnp-lite uses simple filtering for outputting SNPs, i.e., total UMIs or counts and minor alleles fractions. The idea here is to keep most information of SNPs and the downstream statistical model can take the full use of it.

cellsnp-lite is the C version of cellSNP, which is implemented in Python. Compared to cellSNP, cellsnp-lite is basically more efficient with higher speed and less memory usage. Benchmarking results could be found in the preprint. Note, the old version, together with the latest version, of benchmarking scripts are now both in a new repo csp_benchmark.

News

All release notes can be found in doc/release.rst.

For computational efficiency, we initialised comments on this: doc/speed.rst

A pre-compiled candidate SNP list for human is at Candidate_SNPs.

Citation

If you find cellsnp-lite is useful for your research, please cite:

Xianjie Huang, Yuanhua Huang, Cellsnp-lite: an efficient tool for genotyping single cells, Bioinformatics, 2021;, btab358, https://doi.org/10.1093/bioinformatics/btab358

(previously cellsnp-lite has a preprint on bioRxiv)

Installation

cellsnp-lite is implemented in C. You can install it via conda or from this github repo.

Install via conda (latest stable version)

This is the recommended way to install cellsnp-lite. Lacking the potential issues of dependency, it's simple and fast if conda is available on the machine.

Step 1: add config

conda config --add channels bioconda
conda config --add channels conda-forge

Step 2: install

to your current environment:

conda install cellsnp-lite

or to a new environment:

conda create -n CSP cellsnp-lite     # you can replace 'CSP' with another env name.

Install from this Github Repo (latest stable/dev version)

We recommend installing cellsnp-lite via conda, as described above. To compile from source code, you could refer to install_from_repo.

Manual

The full manual is at https://cellsnp-lite.readthedocs.io.

Also, type cellsnp-lite -h for all arguments with the version you are using.

FAQ and releases

For troubleshooting, please have a look of FAQ.rst, and we welcome reporting any issue.

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].