All Projects → quadbiolab → Pando

quadbiolab / Pando

Licence: MIT license
Multiome GRN inference.

Programming Languages

r
7636 projects

Projects that are alternatives of or similar to Pando

EWCE
Expression Weighted Celltype Enrichment. See the package website for up-to-date instructions on usage.
Stars: ✭ 30 (+42.86%)
Mutual labels:  transcriptomics, single-cell
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 (+271.43%)
Mutual labels:  transcriptomics, single-cell
scCATCH
Automatic Annotation on Cell Types of Clusters from Single-Cell RNA Sequencing Data
Stars: ✭ 137 (+552.38%)
Mutual labels:  transcriptomics, single-cell
bap
Bead-based single-cell atac processing
Stars: ✭ 20 (-4.76%)
Mutual labels:  single-cell, epigenomics
kallistobustools
kallisto | bustools workflow for pre-processing single-cell RNA-seq data
Stars: ✭ 79 (+276.19%)
Mutual labels:  single-cell
peax
Peax is a tool for interactive visual pattern search and exploration in epigenomic data based on unsupervised representation learning with autoencoders
Stars: ✭ 63 (+200%)
Mutual labels:  epigenomics
haystack bio
Haystack: Epigenetic Variability and Transcription Factor Motifs Analysis Pipeline
Stars: ✭ 42 (+100%)
Mutual labels:  epigenomics
SCopeLoomR
R package (compatible with SCope) to create generic .loom files and extend them with other data e.g.: SCENIC regulons, Seurat clusters and markers, ...
Stars: ✭ 25 (+19.05%)
Mutual labels:  single-cell
vitessceR
R API and htmlwidget for Vitessce
Stars: ✭ 19 (-9.52%)
Mutual labels:  single-cell
dee2
Digital Expression Explorer 2 (DEE2): a repository of uniformly processed RNA-seq data
Stars: ✭ 32 (+52.38%)
Mutual labels:  transcriptomics
cna
Covarying neighborhood analysis (CNA) is a method for finding structure in- and conducting association analysis with multi-sample single-cell datasets.
Stars: ✭ 35 (+66.67%)
Mutual labels:  single-cell
celltypist
A tool for semi-automatic cell type annotation
Stars: ✭ 92 (+338.1%)
Mutual labels:  single-cell
pychopper
A tool to identify, orient, trim and rescue full length cDNA reads
Stars: ✭ 74 (+252.38%)
Mutual labels:  transcriptomics
gchromVAR
Cell type specific enrichments using finemapped variants and quantitative epigenetic data
Stars: ✭ 31 (+47.62%)
Mutual labels:  single-cell
immunarch
🧬 Immunarch by ImmunoMind: R Package for Fast and Painless Exploration of Single-cell and Bulk T-cell/Antibody Immune Repertoires
Stars: ✭ 204 (+871.43%)
Mutual labels:  single-cell
pipeline-pinfish-analysis
Pipeline for annotating genomes using long read transcriptomics data with pinfish
Stars: ✭ 27 (+28.57%)
Mutual labels:  transcriptomics
pisces
PISCES is a pipeline for rapid transcript quantitation, genetic fingerprinting, and quality control assessment of RNAseq libraries using Salmon.
Stars: ✭ 23 (+9.52%)
Mutual labels:  transcriptomics
GCModeller
GCModeller: genomics CAD(Computer Assistant Design) Modeller system in .NET language
Stars: ✭ 25 (+19.05%)
Mutual labels:  single-cell
MERlin
MERlin is an extensible analysis pipeline applied to decoding MERFISH data
Stars: ✭ 19 (-9.52%)
Mutual labels:  transcriptomics
cellrangerRkit
Non-official Git repository for R package cellrangerRkit (currently not available elsewhere; I'm not affiliated with 10x)
Stars: ✭ 18 (-14.29%)
Mutual labels:  single-cell

Build

Pando

Pando leverages multi-modal single-cell measurements to infer gene regulatory networks using a flexible linear model-based framework. By modeling the relationship between TF-binding site pairs with the expression of target genes, Pando simultaneously infers gene modules and sets of regulatory regions for each transcription factor.

Introduction

The fate and state of a cell is regulated through complex circuits of transcription factors (TFs) converging at regulatory elements to enable precise control of gene expression. Modern single-cell genomic approaches allow the simultaneous profiling of gene expression and chromatin accessibility in individual cells, which opens up new opportunities for the inference of cell regulomes. Pando jointly utilizes scRNA-seq and scATAC-seq data to infer regulatory relationships between TFs and target genes.

Installation

devtools::install_github('quadbiolab/Pando')

Quick start

If you have a seurat_object with transcriptomic and chromantin accessibility data, you can start right away with inferring the regulatory network:

# Load Packages
library(Pando)
library(Seurat)
library(BSgenome.Hsapiens.UCSC.hg38)

# Get motif data
data(motifs)

# Select variable features
seurat_object <- Seurat::FindVariableFeatures(seurat_object, assay='RNA')

# Initiate GRN object and select candidate regions
seurat_object <- initiate_grn(seurat_object)

# Scan candidate regions for TF binding motifs
seurat_object <- find_motifs(
    seurat_object,
    pfm = motifs,
    genome = BSgenome.Hsapiens.UCSC.hg38
)

# Infer gene regulatory network
seurat_object <- infer_grn(seurat_object)

# Print inferred coefficients
coef(seurat_object)

# Find gene and regulatory modules 
test_srt <- find_modules(test_srt)

# Print modules
NetworkModules(test_srt)

More

More info about Pando can be found on our website. There you can find an API reference and a number of tutorial vignettes that give an introduction on how to use Pando most effectively.

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