All Projects → ElementoLab → scTCRseq

ElementoLab / scTCRseq

Licence: AGPL-3.0 license
Processing of single cell RNAseq data for the recovery of TCRs in python

Programming Languages

python
139335 projects - #7 most used programming language
perl
6916 projects

Projects that are alternatives of or similar to scTCRseq

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 (+254.55%)
Mutual labels:  rna-seq, single-cell-rna-seq
OrchestratingSingleCellAnalysis-release
An online companion to the OSCA manuscript demonstrating Bioconductor resources and workflows for single-cell RNA-seq analysis.
Stars: ✭ 35 (+59.09%)
Mutual labels:  rna-seq, single-cell-rna-seq
scaden
Deep Learning based cell composition analysis with Scaden.
Stars: ✭ 61 (+177.27%)
Mutual labels:  rna-seq, single-cell-rna-seq
CellO
CellO: Gene expression-based hierarchical cell type classification using the Cell Ontology
Stars: ✭ 34 (+54.55%)
Mutual labels:  rna-seq, single-cell-rna-seq
arriba
Fast and accurate gene fusion detection from RNA-Seq data
Stars: ✭ 162 (+636.36%)
Mutual labels:  rna-seq
Protocols-4pub
Multi-omics analysis protocols by Lyu.
Stars: ✭ 37 (+68.18%)
Mutual labels:  rna-seq
ngs-in-bioc
A course on Analysing Next Generation (/High Throughput etc..) Sequencing data using Bioconductor
Stars: ✭ 37 (+68.18%)
Mutual labels:  rna-seq
poreplex
A versatile sequenced read processor for nanopore direct RNA sequencing
Stars: ✭ 74 (+236.36%)
Mutual labels:  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 (+145.45%)
Mutual labels:  single-cell-rna-seq
dynmethods
A collection of 50+ trajectory inference methods within a common interface 📥📤
Stars: ✭ 94 (+327.27%)
Mutual labels:  single-cell-rna-seq
rna-seq-kallisto-sleuth
A Snakemake workflow for differential expression analysis of RNA-seq data with Kallisto and Sleuth.
Stars: ✭ 56 (+154.55%)
Mutual labels:  rna-seq
Nebulosa
R package to visualize gene expression data based on weighted kernel density estimation
Stars: ✭ 50 (+127.27%)
Mutual labels:  single-cell-rna-seq
DEGreport
Create a cromphensive report of DEG list coming from any analysis of RNAseq data
Stars: ✭ 18 (-18.18%)
Mutual labels:  rna-seq
kana
Single cell analysis in the browser
Stars: ✭ 81 (+268.18%)
Mutual labels:  rna-seq
rnatoy
A proof of concept RNA-Seq pipeline with Nextflow
Stars: ✭ 32 (+45.45%)
Mutual labels:  rna-seq
Taiji
All-in-one analysis pipeline
Stars: ✭ 28 (+27.27%)
Mutual labels:  single-cell-rna-seq
scRNAseq cell cluster labeling
Scripts to run and benchmark scRNA-seq cell cluster labeling methods
Stars: ✭ 41 (+86.36%)
Mutual labels:  single-cell-rna-seq
pipeComp
A R framework for pipeline benchmarking, with application to single-cell RNAseq
Stars: ✭ 38 (+72.73%)
Mutual labels:  single-cell-rna-seq
grape-nf
An automated RNA-seq pipeline using Nextflow
Stars: ✭ 30 (+36.36%)
Mutual labels:  rna-seq
Subread to DEXSeq
Scripts to import your FeatureCounts output into DEXSeq
Stars: ✭ 23 (+4.55%)
Mutual labels:  rna-seq

scTCRseq

Introduction

For specific questions/problems please email David Redmond at: [email protected]

This project is an implementation of a pipeline for Single-cell RNAseq package for recovering TCR data in python

Github Project

Configuration and Dependencies

The pipeline needs for the following programs to be installed and the paths :

###SEQTK: https://github.com/lh3/seqtk

###Blastall: http://mirrors.vbi.vt.edu/mirrors/ftp.ncbi.nih.gov/blast/executables/release/2.2.15/

###GapFiller: http://www.baseclear.com/genomics/bioinformatics/basetools/gapfiller

###Vidjil: https://github.com/vidjil/vidjil

And their accompanying paths need to be changed in the script cmd_line_sctcrseq.py:

seqTkDir="/path/to/seqtk/"

blastallDir="/path/to/blastall/"

gapFillerDir="/path/to/GapFiller_v1-10_linux-x86_64/"

vidjildir="/path/to/vidjil/"

lengthScript="/path/to/calc.median.read.length.pl"

###Reference TCR sequences:

Also the user can select their chosen TCR alpha and beta V and C reference databases (we recommend downloading from imgt.org) and enter their locations:

location for FASTA BLAST reference sequences downloadable from imgt.org - (needs to be changed manually)

humanTRAVblast="/path/to/TRAV.human.fa"

humanTRBVblast="/path/to/TRBV.human.fa"

humanTRACblast="/path/to/TRAC.human.fa"

humanTRBCblast="/path/to/TRBC.human.fa"

mouseTRAVblast="/path/to/TRAV.mouse.fa"

mouseTRBVblast="/path/to/TRBV.mouse.fa"

mouseTRACblast="/path/to/TRAC.mouse.fa"

mouseTRBCblast="/path/to/TRBC.mouse.fa"

location for Vidjil BLAST reference sequences in vidjil program - (needs to be changed manually)

humanVidjilRef="/path/to/tr_germline/human"

mouseVidjilRef="/path/to/tr_germline/mouse"

Example Command Line

We recommend running the pipeline on paired end fluidigm single cell RNA seq data.

The usage is as follows:

####python cmd_line_sctcrseq.py --fastq1 FASTQ1 --fastq2 FASTQ2 --species human/mouse --outdir OUTPUT DIRECTORY --label OUTPUT LABEL

Also running:

####python cmd_line_sctcrseq.py

Will give command line options

To test the program we recommend either using your own single cell RNA sequencing data or downloading data such as at

http://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSM1104129

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