All Projects → edroaldo → cellrouter

edroaldo / cellrouter

Licence: other
Reconstruction of complex single-cell trajectories using CellRouter

Programming Languages

r
7636 projects

Projects that are alternatives of or similar to cellrouter

Trajectory-Analysis-and-Classification-in-Python-Pandas-and-Scikit-Learn
Formed trajectories of sets of points.Experimented on finding similarities between trajectories based on DTW (Dynamic Time Warping) and LCSS (Longest Common SubSequence) algorithms.Modeled trajectories as strings based on a Grid representation.Benchmarked KNN, Random Forest, Logistic Regression classification algorithms to classify efficiently t…
Stars: ✭ 41 (+7.89%)
Mutual labels:  trajectory-analysis
symphony
Efficient and precise single-cell reference atlas mapping with Symphony
Stars: ✭ 69 (+81.58%)
Mutual labels:  scrna-seq
scHPF
Single-cell Hierarchical Poisson Factorization
Stars: ✭ 52 (+36.84%)
Mutual labels:  scrna-seq
scGEAToolbox
scGEAToolbox: Matlab toolbox for single-cell gene expression analyses
Stars: ✭ 15 (-60.53%)
Mutual labels:  scrna-seq
traja
Python tools for spatial trajectory and time-series data analysis
Stars: ✭ 65 (+71.05%)
Mutual labels:  trajectory-analysis
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 (+42.11%)
Mutual labels:  scrna-seq
cerebra
A tool for fast and accurate summarizing of variant calling format (VCF) files
Stars: ✭ 55 (+44.74%)
Mutual labels:  scrna-seq
souporcell
Clustering scRNAseq by genotypes
Stars: ✭ 88 (+131.58%)
Mutual labels:  scrna-seq
vireo
Demultiplexing pooled scRNA-seq data with or without genotype reference
Stars: ✭ 34 (-10.53%)
Mutual labels:  scrna-seq
cTPnet
cTPnet Package
Stars: ✭ 18 (-52.63%)
Mutual labels:  scrna-seq
northstar
Single cell type annotation guided by cell atlases, with freedom to be queer
Stars: ✭ 23 (-39.47%)
Mutual labels:  scrna-seq
Tangram
Spatial alignment of single cell transcriptomic data.
Stars: ✭ 149 (+292.11%)
Mutual labels:  scrna-seq
BEER
BEER: Batch EffEct Remover for single-cell data
Stars: ✭ 19 (-50%)
Mutual labels:  scrna-seq
membrane-curvature
MDAnalysis tool to calculate membrane curvature.
Stars: ✭ 19 (-50%)
Mutual labels:  trajectory-analysis
Harmony
Harmony framework for connecting scRNA-seq data from discrete time points
Stars: ✭ 36 (-5.26%)
Mutual labels:  scrna-seq
yupi
Python package designed for collecting and processing trajectory data.
Stars: ✭ 30 (-21.05%)
Mutual labels:  trajectory-analysis
SHARP
SHARP: Single-cell RNA-seq Hyper-fast and Accurate processing via ensemble Random Projection
Stars: ✭ 14 (-63.16%)
Mutual labels:  scrna-seq
pytraj
Python interface of cpptraj
Stars: ✭ 106 (+178.95%)
Mutual labels:  trajectory-analysis
zellkonverter
Conversion between scRNA-seq objects
Stars: ✭ 67 (+76.32%)
Mutual labels:  scrna-seq
celltypist
A tool for semi-automatic cell type annotation
Stars: ✭ 92 (+142.11%)
Mutual labels:  scrna-seq

Updates (May 21, 2018)

New version available! Please, check our updated tutorial. Updates include:

  1. Raw count/UMI data can be provided as input.
  2. Perform quality control on genes and cells
  3. Normalize the data
  4. Clustering and identification of gene signatures. Annotated heatmaps
  5. Improved visualization
  6. Enhanced flexibility for trajectory reconstruction (User-defined clusters or other metadata can be used, such as sorted populations)

We are working on to create an R package for CellRouter. Stay tuned!

CellRouter

Please, join our google groups to provide suggestions, report issues, discuss about CellRouter or request new features: https://groups.google.com/forum/#!forum/cellrouter/. CellRouter was tested in Unix-based systems. Therefore, we strongly recommend to use CellRouter in Unix-based systems or Mac. CellRouter was not tested in Windows.

Introduction

CellRouter is a multifaceted single-cell analysis platform that identifies complex cell-state transition trajectories by using flow networks to explore the subpopulation structure of multi-dimensional, single-cell omics data. CellRouter integrates subpopulation identification, multi-state trajectories, and gene regulatory networks (GRNs) to provide new insights into cell-state transitions during lineage diversification, convergence, or cell reprogramming. For current tutorials illustrating how to use CellRouter, please take a look at the section Examples. CellRouter is an ongoing research project and we will keep providing more tutorials and applications. Please, do not hesitate to contact us!

Overview of CellRouter. Step (1) Starting from single cells representing multiple cell states, including stable and in transition, a gene regulatory network is reconstructed to identify putative gene regulatory relationships. Step (2) Subpopulations are then identified by a combination of learning the structure of the data and community detection algorithms. Step (3) High-resolution multi-state trajectories are identified from any subpopulation to any other, including intermediate and mature cell types. Step (4) Multi-state trajectories illustrate the divergence of single-cell transcriptomes along each trajectory progression. Identification of genes implicated in the dynamic biological process under study, such as differentiation, and identification of regulators driving or mediating cell-fate transitions at the gene and network level.

Installation

To use CellRouter, clone/download this repository. You also need to install several packages:

list.of.packages <- c('reshape','reshape2','pheatmap','tsne','igraph','ggplot2','mclust','grid','Rtsne','cccd')
new.packages <- list.of.packages[!(list.of.packages %in% installed.packages()[,"Package"])]

if(length(new.packages)) install.packages(new.packages, repos=c("http://cran.rstudio.com/", "https://bioconductor.org/biocLite.R"))

In case of a missing package after running the steps above, please install them by typing:

source('http://bioconductor.org/biocLite.R')
biocLite('package_name')

The package Vennerable also needs to be installed:

install.packages("Vennerable", repos="http://R-Forge.R-project.org")

Then, source the CellRouter class and make sure you provide the correct directory for the Java libraries inside the folder "CellRouter", as specified by the variable 'libdir'.

source('path/to/CellRouter_Class.R')
libdir <- 'path/to/CellRouter/'

Example(s)

  1. Analysis of mouse myeloid progenitor single-cell RNA-seq data generated by Paul et al.(Cell 2015)

Citation

If you use CellRouter, please cite:

Edroaldo Lummertz da Rocha, R. Grant Rowe, Vanessa Lundin, Mohan Malleshaiah, Deepak Kumar Jha, Carlos R. Rambo, Hu Li , Trista E. North, James J. Collins & George Q. Daley. Reconstruction of complex single-cell trajectories using CellRouter. Nature Communications. 2018 Mar 1;9(1):892. doi: 10.1038/s41467-018-03214-y.

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