All Projects → noush-joglekar → scisorseqr

noush-joglekar / scisorseqr

Licence: MIT license
scisorseqr is an R-package for processing of single-cell long read data and analyzing differential isoform expression across any two conditions

Programming Languages

r
7636 projects
shell
77523 projects
awk
318 projects
python
139335 projects - #7 most used programming language

Projects that are alternatives of or similar to scisorseqr

psichomics
Interactive R package to quantify, analyse and visualise alternative splicing
Stars: ✭ 26 (+23.81%)
Mutual labels:  splicing-quantification
Nebulosa
R package to visualize gene expression data based on weighted kernel density estimation
Stars: ✭ 50 (+138.1%)
Mutual labels:  single-cell-rna-seq
scTCRseq
Processing of single cell RNAseq data for the recovery of TCRs in python
Stars: ✭ 22 (+4.76%)
Mutual labels:  single-cell-rna-seq
berokka
🍊 💫 Trim, circularise and orient long read bacterial genome assemblies
Stars: ✭ 23 (+9.52%)
Mutual labels:  long-read-sequencing
Taiji
All-in-one analysis pipeline
Stars: ✭ 28 (+33.33%)
Mutual labels:  single-cell-rna-seq
scRNAseq cell cluster labeling
Scripts to run and benchmark scRNA-seq cell cluster labeling methods
Stars: ✭ 41 (+95.24%)
Mutual labels:  single-cell-rna-seq
SignacX
Signac
Stars: ✭ 15 (-28.57%)
Mutual labels:  single-cell-rna-seq
SOT
Single-cell Orientation Tracing
Stars: ✭ 20 (-4.76%)
Mutual labels:  single-cell-rna-seq
scaden
Deep Learning based cell composition analysis with Scaden.
Stars: ✭ 61 (+190.48%)
Mutual labels:  single-cell-rna-seq
squidpy
Spatial Single Cell Analysis in Python
Stars: ✭ 235 (+1019.05%)
Mutual labels:  single-cell-rna-seq
cellrank
CellRank for directed single-cell fate mapping
Stars: ✭ 222 (+957.14%)
Mutual labels:  single-cell-rna-seq
arshamg-scrnaseq-wgan
Wasserstein Generative Adversarial Network for analysing scRNAseq data
Stars: ✭ 33 (+57.14%)
Mutual labels:  single-cell-rna-seq
dynmethods
A collection of 50+ trajectory inference methods within a common interface 📥📤
Stars: ✭ 94 (+347.62%)
Mutual labels:  single-cell-rna-seq
scCODA
A Bayesian model for compositional single-cell data analysis
Stars: ✭ 109 (+419.05%)
Mutual labels:  single-cell-rna-seq
EmptyDrops2017
Code for the empty droplet and cell detection project from the HCA Hackathon.
Stars: ✭ 16 (-23.81%)
Mutual labels:  single-cell-rna-seq
MAnorm2
MAnorm2 for Normalizing and Comparing ChIP-seq Samples
Stars: ✭ 15 (-28.57%)
Mutual labels:  differential-analysis
pipeComp
A R framework for pipeline benchmarking, with application to single-cell RNAseq
Stars: ✭ 38 (+80.95%)
Mutual labels:  single-cell-rna-seq
deepconsensus
DeepConsensus uses gap-aware sequence transformers to correct errors in Pacific Biosciences (PacBio) Circular Consensus Sequencing (CCS) data.
Stars: ✭ 124 (+490.48%)
Mutual labels:  long-read-sequencing
diffxpy
Differential expression analysis for single-cell RNA-seq data.
Stars: ✭ 137 (+552.38%)
Mutual labels:  single-cell-rna-seq
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 (+157.14%)
Mutual labels:  single-cell-rna-seq

scisorseqr - a comparative analysis of alternative splicing patterns

scisorseqr is a linux based R-package for analyzing differential isoform expression in single cells. The methods are based on our recent publication and the scISOrSeq workflow

Any comparative studies of alternative splicing can be performed with scisorseqr. The package includes functions for barcode deconvolution from fastqs, integration with long read alignment tools, mapping and filtering of high confidence, full-length spliced reads, and some handy tools to conduct differential expression analysis.

The tools are also applicable to long-read spatial transcriptomics, and can be used to resolve exon expression at the spatial level


Hardware / software requirements

The package has only been tested on a CentOS x86_64 machine. For alignment and mapping, we recommend

  • STARlong software installation for PacBio reads
  • Minimap2 installation for Oxford Nanopore (or PacBio) reads
  • samtools
  • bedtools
  • python version 3.7

Installation

The easiest way to install scisorseqr is through Github with:

devtools::install_github('noush-joglekar/scisorseqr',build_vignettes = TRUE)

Workflow

These steps are available as functions in the package. For example, barcode deconvolution can be done using the following command

library(scisorseqr)
GetBarcodes('FastqFiles/','userInput/BarcodeCluster_Assignments', concatenate=TRUE, 
  filterReads=FALSE, numProcesses=24)

A step-by-step outline of the various functions is available as a vignette. To access it, run

browseVignettes("scisorseqr")

Support

We appreciate any and all inputs for improving scisorseqr. Feel free to send us an email or open an 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].