All Projects → ZJUFanLab → scCATCH

ZJUFanLab / scCATCH

Licence: GPL-3.0 license
Automatic Annotation on Cell Types of Clusters from Single-Cell RNA Sequencing Data

Programming Languages

r
7636 projects

Projects that are alternatives of or similar to scCATCH

alevin-fry
🐟 🔬🦀 alevin-fry is an efficient and flexible tool for processing single-cell sequencing data, currently focused on single-cell transcriptomics and feature barcoding.
Stars: ✭ 78 (-43.07%)
Mutual labels:  rna-seq, transcriptomics, single-cell
tailseeker
Software for measuring poly(A) tail length and 3′-end modifications using a high-throughput sequencer
Stars: ✭ 17 (-87.59%)
Mutual labels:  rna-seq, transcriptome
IsoQuant
Reference-based transcript discovery from long RNA read
Stars: ✭ 26 (-81.02%)
Mutual labels:  rna-seq, transcriptomics
MetaOmGraph
MetaOmGraph: a workbench for interactive exploratory data analysis of large expression datasets
Stars: ✭ 30 (-78.1%)
Mutual labels:  rna-seq, transcriptomics
OrchestratingSingleCellAnalysis-release
An online companion to the OSCA manuscript demonstrating Bioconductor resources and workflows for single-cell RNA-seq analysis.
Stars: ✭ 35 (-74.45%)
Mutual labels:  rna-seq, single-cell
RATTLE
Reference-free reconstruction and error correction of transcriptomes from Nanopore long-read sequencing
Stars: ✭ 35 (-74.45%)
Mutual labels:  rna-seq, transcriptome
iDEA
Differential expression (DE); gene set Enrichment Analysis (GSEA); single cell RNAseq studies (scRNAseq)
Stars: ✭ 23 (-83.21%)
Mutual labels:  rna-seq, single-cell
MINTIE
Method for Identifying Novel Transcripts and Isoforms using Equivalence classes, in cancer and rare disease.
Stars: ✭ 24 (-82.48%)
Mutual labels:  rna-seq, transcriptomics
RNASeq
RNASeq pipeline
Stars: ✭ 30 (-78.1%)
Mutual labels:  rna-seq, sequencing
velodyn
Dynamical systems methods for RNA velocity analysis
Stars: ✭ 16 (-88.32%)
Mutual labels:  rna-seq, single-cell
TransPi
TransPi – a comprehensive TRanscriptome ANalysiS PIpeline for de novo transcriptome assembly
Stars: ✭ 18 (-86.86%)
Mutual labels:  rna-seq, transcriptomics
kana
Single cell analysis in the browser
Stars: ✭ 81 (-40.88%)
Mutual labels:  rna-seq, single-cell
dee2
Digital Expression Explorer 2 (DEE2): a repository of uniformly processed RNA-seq data
Stars: ✭ 32 (-76.64%)
Mutual labels:  rna-seq, transcriptomics
pipeline-pinfish-analysis
Pipeline for annotating genomes using long read transcriptomics data with pinfish
Stars: ✭ 27 (-80.29%)
Mutual labels:  rna-seq, transcriptomics
pychopper
A tool to identify, orient, trim and rescue full length cDNA reads
Stars: ✭ 74 (-45.99%)
Mutual labels:  rna-seq, transcriptomics
fastq utils
Validation and manipulation of FASTQ files, scRNA-seq barcode pre-processing and UMI quantification.
Stars: ✭ 25 (-81.75%)
Mutual labels:  sequencing, single-cell
EWCE
Expression Weighted Celltype Enrichment. See the package website for up-to-date instructions on usage.
Stars: ✭ 30 (-78.1%)
Mutual labels:  transcriptomics, single-cell
GeneTonic
Enjoy your transcriptomic data and analysis responsibly - like sipping a cocktail
Stars: ✭ 66 (-51.82%)
Mutual labels:  transcriptome, transcriptomics
cellSNP
Pileup biallelic SNPs from single-cell and bulk RNA-seq data
Stars: ✭ 42 (-69.34%)
Mutual labels:  rna-seq, single-cell
NGS
Next-Gen Sequencing tools from the Horvath Lab
Stars: ✭ 30 (-78.1%)
Mutual labels:  rna-seq, single-cell

scCATCH v3.1

R >4.0 installed with CRAN

Automatic Annotation on Cell Types of Clusters from Single-Cell RNA Sequencing Data

Recent advance in single-cell RNA sequencing (scRNA-seq) has enabled large-scale transcriptional characterization of thousands of cells in multiple complex tissues, in which accurate cell type identification becomes the prerequisite and vital step for scRNA-seq studies. Currently, the common practice in cell type annotation is to map the highly expressed marker genes with known cell markers manually based on the identified clusters, which requires the priori knowledge and tends to be subjective on the choice of which marker genes to use. Besides, such manual annotation is usually time-consuming.

To address these problems, we introduce a single cell Cluster-based Annotation Toolkit for Cellular Heterogeneity (scCATCH) from cluster marker genes identification to cluster annotation based on evidence-based score by matching the identified potential marker genes with known cell markers in tissue-specific cell taxonomy reference database (CellMatch).

download CellMatch

CellMatch includes a panel of 353 cell types and related 686 subtypes associated with 184 tissue types, and 2,097 references of human and mouse.

The scCATCH mainly includes two function findmarkergene() and findcelltype() to realize the automatic annotation for each identified cluster. Usage and Examples are detailed below.

Cite

DOI PMID:32062421

Shao et al., scCATCH:Automatic Annotation on Cell Types of Clusters from Single-Cell RNA Sequencing Data, iScience, Volume 23, Issue 3, 27 March 2020. doi: 10.1016/j.isci.2020.100882. PMID:32062421

News

v3.1

  • scCATCH is available on CRAN
  • Update Gene symbols in CellMatch according to NCBI Gene symbols (updated in Jan. 2, 2022, https://www.ncbi.nlm.nih.gov/gene).
  • Allow users to use custom cellmatch
  • Allow users to select different combination of tissues or cancers for annotation.
  • Allow users to add more marker genes to cellmatch for annotation.
  • Allow users to use markers from different species other than human and mouse.
  • Allow users to use more methods to identify highly expressed genes.
  • Create scCATCH object from Seurat object with the following code

obj <- createscCATCH(data = Seurat_obj[['RNA']]@data, cluster = as.character(Idents(Seurat_obj)))

Install

install.packages("scCATCH")

OR

# install devtools and install
install.packages(pkgs = 'devtools')
devtools::install_github('ZJUFanLab/scCATCH')

Usage

Please refer to the document and tutorial vignette. Available tissues and cancers see the wiki page

Issues

bug error

Solutions for possilble bugs and errors. Please refer to closed Issues1 and Issues2

About

scCATCH was developed by Xin Shao. Should you have any questions, please contact Xin Shao at [email protected]

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