All Projects → nf-core → hlatyping

nf-core / hlatyping

Licence: MIT license
Precision HLA typing from next-generation sequencing data

Programming Languages

Nextflow
61 projects
python
139335 projects - #7 most used programming language
HTML
75241 projects
Dockerfile
14818 projects

Projects that are alternatives of or similar to hlatyping

lncpipe
UNDER DEVELOPMENT--- Analysis of long non-coding RNAs from RNA-seq datasets
Stars: ✭ 24 (-14.29%)
Mutual labels:  pipeline, rna, nf-core
rnafusion
RNA-seq analysis pipeline for detection gene-fusions
Stars: ✭ 72 (+157.14%)
Mutual labels:  pipeline, rna, nf-core
Galaxy
Data intensive science for everyone.
Stars: ✭ 812 (+2800%)
Mutual labels:  pipeline, dna
Ugene
UGENE is free open-source cross-platform bioinformatics software
Stars: ✭ 112 (+300%)
Mutual labels:  pipeline, dna
dnapacman
waka waka
Stars: ✭ 15 (-46.43%)
Mutual labels:  dna, rna
seqfold
minimalistic nucleic acid folding
Stars: ✭ 39 (+39.29%)
Mutual labels:  dna, rna
RNASeq
RNASeq pipeline
Stars: ✭ 30 (+7.14%)
Mutual labels:  pipeline, rna
naf
Nucleotide Archival Format - Compressed file format for DNA/RNA/protein sequences
Stars: ✭ 35 (+25%)
Mutual labels:  dna, rna
hic
Analysis of Chromosome Conformation Capture data (Hi-C)
Stars: ✭ 45 (+60.71%)
Mutual labels:  pipeline, nf-core
kourami
Kourami: Graph-guided assembly for HLA alleles
Stars: ✭ 31 (+10.71%)
Mutual labels:  hla, hla-typing
bactmap
A mapping-based pipeline for creating a phylogeny from bacterial whole genome sequences
Stars: ✭ 36 (+28.57%)
Mutual labels:  pipeline, nf-core
Sns
Analysis pipelines for sequencing data
Stars: ✭ 43 (+53.57%)
Mutual labels:  pipeline, dna
sequencework
programs and scripts, mainly python, for analyses related to nucleic or protein sequences
Stars: ✭ 22 (-21.43%)
Mutual labels:  dna, rna
scrnaseq
A single-cell RNAseq pipeline for 10X genomics data
Stars: ✭ 60 (+114.29%)
Mutual labels:  pipeline, nf-core
nanoseq
Nanopore demultiplexing, QC and alignment pipeline
Stars: ✭ 82 (+192.86%)
Mutual labels:  pipeline, nf-core
FluentDNA
FluentDNA allows you to browse sequence data of any size using a zooming visualization similar to Google Maps. You can use FluentDNA as a standalone program or as a python module for your own bioinformatics projects.
Stars: ✭ 52 (+85.71%)
Mutual labels:  dna
get phylomarkers
A pipeline to select optimal markers for microbial phylogenomics and species tree estimation using coalescent and concatenation approaches
Stars: ✭ 34 (+21.43%)
Mutual labels:  pipeline
gunpowder
A library to facilitate machine learning on multi-dimensional images.
Stars: ✭ 40 (+42.86%)
Mutual labels:  pipeline
effepi
Fun functional programming with pipelinable functions
Stars: ✭ 13 (-53.57%)
Mutual labels:  pipeline
poly
A Go package for engineering organisms.
Stars: ✭ 270 (+864.29%)
Mutual labels:  dna

nf-core/hlatyping

GitHub Actions CI Status GitHub Actions Linting Status Nextflow DOI

install with bioconda Docker Get help on Slack

Introduction

The pipeline does next-generation sequencing-based Human Leukozyte Antigen (HLA) typing using OptiType. OptiType is a HLA genotyping algorithm based on integer linear programming. Reads of whole exome/genome/transcriptome sequencing data are mapped against a reference of known MHC class I alleles. To produce accurate 4-digit HLA genotyping predictions, all major and minor HLA-I loci are considered simultaneously to find an allele combination that maximizes the number of explained reads.

The pipeline is built using Nextflow, a workflow tool to run tasks across multiple compute infrastructures in a very portable manner. It comes with docker containers making installation trivial and results highly reproducible.

Quick Start

  1. Install nextflow

  2. Install either Docker or Singularity for full pipeline reproducibility (please only use Conda as a last resort; see docs)

  3. Download the pipeline and test it on a minimal dataset with a single command:

    nextflow run nf-core/hlatyping -profile test,<docker/singularity/conda/institute>

    Please check nf-core/configs to see if a custom config file to run nf-core pipelines already exists for your Institute. If so, you can simply use -profile <institute> in your command. This will enable either docker or singularity and set the appropriate execution settings for your local compute environment.

  4. Start running your own analysis!

    nextflow run nf-core/hlatyping -profile <docker/singularity/conda/institute> --input '*_R{1,2}.fastq.gz'

See usage docs for all of the available options when running the pipeline.

Documentation

The nf-core/hlatyping pipeline comes with documentation about the pipeline which you can read at https://nf-co.re/hlatyping.

Pipeline DAG

The hlatyping pipeline can currently deal with two input formats: .fastq{.gz} or .bam, not both at the same time however. If the input file type is bam, than the pipeline extracts all reads from it and performs an mapping additional step with the yara mapper against the HLA reference sequence. Indices are provided in the ./data directory of this repository. Optitype uses razers3, which is very memory consuming. In order to avoid memory issues during pipeline execution, we reduce the mapping information on the relevant HLA regions on chromosome 6.

DAG with .fastq{.gz} as input

Creates a config file from the command line arguments, which is then passed to OptiType. In parallel, the fastqs are unzipped if they are passed as archives. OptiType is then used for the HLA typing.

DAG with fastq.{gz} files

DAG with .bam as input

Creates a config file from the command line arguments, which is then passed to OptiType. In parallel, the reads are extracted from the bam file and mapped again against the HLA reference sequence on chromosome 6. OptiType is then used for the HLA typing.

DAG with .bam file

Credits

nf-core/hlatyping was originally written by Christopher Mohr from Institute for Translational Bioinformatics and Quantitative Biology Center, Alexander Peltzer from Boeheringer Ingelheim, and Sven Fillinger from Quantitative Biology Center.

Contributions and Support

If you would like to contribute to this pipeline, please see the contributing guidelines.

For further information or help, don't hesitate to get in touch on the Slack #hlatyping channel (you can join with this invite).

Citation

If you use nf-core/hlatyping for your analysis, please cite it using the following doi: 10.5281/zenodo.1401039

You can cite the nf-core publication as follows:

The nf-core framework for community-curated bioinformatics pipelines.

Philip Ewels, Alexander Peltzer, Sven Fillinger, Harshil Patel, Johannes Alneberg, Andreas Wilm, Maxime Ulysse Garcia, Paolo Di Tommaso & Sven Nahnsen.

Nat Biotechnol. 2020 Feb 13. doi: 10.1038/s41587-020-0439-x. ReadCube: Full Access Link

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