• Stars
    star
    151
  • Rank 244,587 (Top 5 %)
  • Language
  • License
    MIT License
  • Created over 7 years ago
  • Updated over 2 years ago

Reviews

There are no reviews yet. Be the first to send feedback to the community and the maintainers!

Repository Details

Documentation of the Snakemake-Workflows project

The Snakemake-Workflows project

The Snakemake-workflows project is a joint effort to create workflows for common use cases of the Snakemake workflow management system.

Workflows

A list of all available workflows that are currently in development can be found here.

Approved workflows

The following workflows have undergone a strict review and quality control process and are ready for production. They can be considered as best practice examples.

Workflow Domain Authors
rna-seq-star-deseq2 RNA-seq Johannes Köster (https://koesterlab.github.io)
rna-seq-kallisto-sleuth RNA-seq Johannes Köster (https://koesterlab.github.io)
dna-seq-gatk-variant-calling DNA-seq Johannes Köster (https://koesterlab.github.io)
dna-seq-varlociraptor DNA-seq Johannes Köster, Felix Mölder (https://koesterlab.github.io)
accel-amplicon-trimming Accel Amplicon Patrik Smeds (Clinical Genomics Uppsala)
single-cell-rna-seq Single cell RNA-seq Johannes Köster (https://koesterlab.github.io)
single-cell-drop-seq Single cell RNA-seq Patrick Roelli (TU Munich, Swiss Institute of Bioinformatics)

Documentation

Join the team

Once the initiators have agreed on the procedure, it will be possible to join the team here.

Contribute

Contributing is easy:

  1. Join the team
  2. Create a new repository for your workflow
  3. Ensure that your workflow meets our guidelines.
  4. Request a review here.

Guidelines

  1. A workflow repository shall consist of one Snakemake workflow.
  2. The structure of the workflow should follow our template. You can create a new workflow from it by clicking the Use this template button on the template repositories page. And just follow the TODOs from there.
  3. Whenever possible, Snakemake wrappers should be used.
  4. The workflow should be configurable via a well documented YAML-based configuration file and (when necessary) a sample and a unit sheet (see here for an example).
  5. The workflow has to define an (integration-style) test case that is configured via the .travis.yml file in the skeleton.
  6. For inclusion in the snakemake workflow catalog, further follow the catalog inclusion requirements.

More Repositories

1

rna-seq-star-deseq2

RNA-seq workflow using STAR and DESeq2
Python
318
star
2

dna-seq-gatk-variant-calling

This Snakemake pipeline implements the GATK best-practices workflow
Python
238
star
3

single-cell-rna-seq

A single cell RNA-seq workflow, including highly variable gene analysis, cell type assignment and differential expression analysis.
R
97
star
4

snakemake-workflow-template

A template for standard compliant snakemake-workflows
Python
85
star
5

dna-seq-varlociraptor

A Snakemake workflow for calling small and structural variants under any kind of scenario (tumor/normal, tumor/normal/relapse, germline, pedigree, populations) via the unified statistical model of Varlociraptor.
Python
82
star
6

rna-seq-kallisto-sleuth

A Snakemake workflow for differential expression analysis of RNA-seq data with Kallisto and Sleuth.
Python
64
star
7

cookiecutter-snakemake-workflow

A cookiecutter template for Snakemake workflows
Python
56
star
8

chipseq

ChIP-seq peak-calling, QC and differential analysis pipeline (Snakemake port of the nextflow pipeline at https://nf-co.re/chipseq).
Python
26
star
9

ngs-test-data

A workflow for creating small NGS test data sets, useful for continuous integration.
Python
21
star
10

dna-seq-neoantigen-prediction

Snakemake workflow for neoantigen prediction
Python
14
star
11

dna-seq-benchmark

A snakemake workflow for benchmarking variant calling approaches with Genome in a Bottle (GIAB), CHM (syndip) or other custom datasets
Python
11
star
12

dna-seq-mtb

A flavor of https://github.com/snakemake-workflows/dna-seq-varlociraptor preconfigured for molecular tumor boards
Python
4
star
13

cyrcular-calling

A Snakemake workflow for ecDNA detection in Nanopore or Illumina sequencing reads derived from DNA samples enriched for circular DNA.
Python
3
star
14

species-quantification

Python
2
star
15

cite-seq-alevin-fry-seurat

Snakemake workflow for CITE-seq analaysis with alevin-fry and seurat
R
2
star
16

transcriptome-differential-expression

long read differential expression analysis
Python
1
star
17

rad-seq-stacks

Python
1
star
18

structure-based-screening

Workflow for screening massive amounts of small molecules (ligands) against a target (PDB-File)
Python
1
star