All Projects → saketkc → rna-seq-snakemake

saketkc / rna-seq-snakemake

Licence: BSD-2-Clause license
Snakemake based pipeline for RNA-Seq analysis

Programming Languages

r
7636 projects
python
139335 projects - #7 most used programming language
PowerBuilder
6 projects
shell
77523 projects

Projects that are alternatives of or similar to rna-seq-snakemake

lncpipe
UNDER DEVELOPMENT--- Analysis of long non-coding RNAs from RNA-seq datasets
Stars: ✭ 24 (-17.24%)
Mutual labels:  pipeline, rna-seq-analysis
ngs pipeline
Exome/Capture/RNASeq Pipeline Implementation using snakemake
Stars: ✭ 40 (+37.93%)
Mutual labels:  snakemake, pipeline
tailseeker
Software for measuring poly(A) tail length and 3′-end modifications using a high-throughput sequencer
Stars: ✭ 17 (-41.38%)
Mutual labels:  snakemake, pipeline
makepipe
Tools for constructing simple make-like pipelines in R.
Stars: ✭ 23 (-20.69%)
Mutual labels:  pipeline
PeekingDuck
A modular framework built to simplify Computer Vision inference workloads.
Stars: ✭ 143 (+393.1%)
Mutual labels:  pipeline
STOCK-RETURN-PREDICTION-USING-KNN-SVM-GUASSIAN-PROCESS-ADABOOST-TREE-REGRESSION-AND-QDA
Forecast stock prices using machine learning approach. A time series analysis. Employ the Use of Predictive Modeling in Machine Learning to Forecast Stock Return. Approach Used by Hedge Funds to Select Tradeable Stocks
Stars: ✭ 94 (+224.14%)
Mutual labels:  pipeline
panoptes
Monitor computational workflows in real time
Stars: ✭ 45 (+55.17%)
Mutual labels:  snakemake
pipe
Functional Pipeline in Go
Stars: ✭ 30 (+3.45%)
Mutual labels:  pipeline
ORNA
Fast in-silico normalization algorithm for NGS data
Stars: ✭ 21 (-27.59%)
Mutual labels:  rna-seq-analysis
ngs-test-data
A workflow for creating small NGS test data sets, useful for continuous integration.
Stars: ✭ 19 (-34.48%)
Mutual labels:  snakemake
datajob
Build and deploy a serverless data pipeline on AWS with no effort.
Stars: ✭ 101 (+248.28%)
Mutual labels:  pipeline
functions
An Open Source Serverless Platform
Stars: ✭ 44 (+51.72%)
Mutual labels:  pipeline
XProc-Z
A platform for running XProc pipelines as web applications in a Java servlet container
Stars: ✭ 20 (-31.03%)
Mutual labels:  pipeline
nemesyst
Generalised and highly customisable, hybrid-parallelism, database based, deep learning framework.
Stars: ✭ 17 (-41.38%)
Mutual labels:  pipeline
transtats
Track translations and automate workflow.
Stars: ✭ 31 (+6.9%)
Mutual labels:  pipeline
hic
Analysis of Chromosome Conformation Capture data (Hi-C)
Stars: ✭ 45 (+55.17%)
Mutual labels:  pipeline
scATAC-pro
A comprehensive tool for processing, analyzing and visulizing single cell chromatin accessibility sequencing data
Stars: ✭ 63 (+117.24%)
Mutual labels:  pipeline
AnimationDNA
Maya > Arnold > Nuke pipeline
Stars: ✭ 101 (+248.28%)
Mutual labels:  pipeline
gulp-sort
Sort files in stream by path or any custom sort comparator
Stars: ✭ 22 (-24.14%)
Mutual labels:  pipeline
ember-pipeline
Railway oriented programming in Ember
Stars: ✭ 17 (-41.38%)
Mutual labels:  pipeline

rna-seq-snakamake

Snakemake based pipeline for RNA-Seq analysis

Inputs to all snakefiles are specified using a config.py, and generally is as simple as specifiying the directory containing all *.fq/*.fq.gz/*.fastq.gz/*.sra files.

  1. Snakefile_fastq_multilane.snake - For multilane paired end fastq files

  2. Snakefile_sra_pe - For paired end *.sra files

  3. Snakefile_sra_se - For single end *.sra files

  4. Snakefile_fastq - For paired end fastq files

Dependecies

  • snakemake
  • STAR
  • bamtools
  • DESeq2
  • qualimap
  • multiqc
  • rseqc
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].