Remove some more modules

This commit is contained in:
drpatelh 2020-08-05 17:25:34 +01:00
parent 1edc58a36b
commit 4f590ff239
16 changed files with 0 additions and 240 deletions

View file

@ -1,16 +0,0 @@
process bwa_index {
tag "$fasta"
container 'quay.io/biocontainers/bwa:0.7.17--hed695b0_7'
input:
path fasta
output:
path "${fasta}.*"
script:
"""
bwa index ${fasta}
"""
}

View file

@ -1,25 +0,0 @@
name: bwa index
description: create indexes for BWA from a fasta file
keywords:
- index
tools:
- bwa:
description: |
BWA is a software package for mapping DNA sequences against a large reference genome, such as the human genome.
homepage: http://bio-bwa.sourceforge.net/
documentation: http://www.htslib.org/doc/samtools.html
arxiv: arXiv:1303.3997
input:
-
- input:
type: file
description: Input fasta file
pattern: "*.{fasta,fa}"
output:
-
- index:
type: file
description: bwa indexes file
pattern: "*.{fasta,fa}.{amb,ann,bwt,pac,sa}"
authors:
- "@maxulysse"

View file

@ -1,16 +0,0 @@
#!/usr/bin/env nextflow
nextflow.preview.dsl = 2
include '../../../tests/functions/check_process_outputs.nf' params(params)
include '../main.nf' params(params)
// Define input channels
input = '../../../test-datasets/tools/bwa/index/input/reference.fasta'
Channel
.from(input)
.set { ch_input }
// Run the workflow
workflow {
fastqc(ch_input)
// .check_output()
}

View file

@ -1,2 +0,0 @@
docker.enabled = true
params.outdir = './results'

View file

@ -1,7 +0,0 @@
FROM nfcore/base
LABEL authors="Jeremy Guntoro" \
description="Docker image containing all requirements for nf-core/modules/bwa/mem module"
COPY environment.yml /
RUN conda env create -f /environment.yml && conda clean -a
ENV PATH /opt/conda/envs/nf-core-bwa-mem/bin:$PATH

View file

@ -1,10 +0,0 @@
# You can use this file to create a conda environment for this pipeline:
# conda env create -f environment.yml
name: nf-core-bwa-mem
channels:
- conda-forge
- bioconda
- defaults
dependencies:
- bioconda::bwa=0.7.17
- bioconda::samtools=1.9

View file

@ -1,27 +0,0 @@
params.bwa_options = "-M -B 2"
params.sequencer = "ILLUMINA"
process bwa_mem {
tag "$id"
publishDir "${params.outdir}/bwa_mem", mode: 'copy'
//TO-DO: Change container declaration, for now a test container is present in my personal docker acccount
container 'jeremy1805/bwa-mem-img'
input:
tuple val(id), path(reads)
path genomeindex
val indexprefix
output:
tuple path("*.bam"), path("*.bai")
script:
"""
bwa mem -t ${task.cpus} -R "@RG\\tID:${id}\\tLB:${id}\\tSM:${id}\\tPL:${params.sequencer}" \\
${params.bwa_options} ${indexprefix} ${reads} | samtools sort -@8 -O BAM -o ${id}.bam -
samtools index ${id}.bam
"""
}

View file

@ -1,42 +0,0 @@
name: bwa mem
description: Performs fastq alignment to a fasta reference using the burrows-wheeler aligner
keywords:
- mem
- bwa
- alignment
tools:
- bwa:
description: |
BWA is a software package for mapping DNA sequences against a large reference genome, such as the human genome.
homepage: http://bio-bwa.sourceforge.net/
documentation: http://www.htslib.org/doc/samtools.html
arxiv: arXiv:1303.3997
input:
-
- id:
type: val
description: read/read pair id
- reads:
type: file
description: Input fastq file
pattern: "*.{fastq,fq}"
- index:
type: file
description: bwa indexes file
pattern: "*.{amb,ann,bwt,pac,sa}"
- prefix:
type: val
description: bwa index prefix, equivalent to index file names without extensions. Usually the reference genome file name unless otherwise specified.
output:
-
- bam:
type: file
description: Output bam file
pattern: "*.bam"
- bamindex:
type: file
description: Output bam index file
pattern: "*.bai"
authors:
- "@jeremy1805"

View file

@ -1,13 +0,0 @@
#!/usr/bin/env nextflow
nextflow.preview.dsl = 2
include '../../../../tests/functions/check_process_outputs.nf' params(params)
include '../main.nf' params(params)
reads = '../../../../test-datasets/tools/bwa/mem/reads/*_R{1,2}_001.fastq.gz'
index = '../../../../test-datasets/tools/bwa/mem/index/H3N2.{amb,ann,bwt,pac,sa}'
prefix = 'H3N2'
workflow {
read_input=Channel.fromFilePairs(reads)
bwa_mem(read_input,file(index),prefix)
}

View file

@ -1,2 +0,0 @@
docker.enabled = true
params.outdir = './results'

View file

@ -1,8 +0,0 @@
FROM nfcore/base:1.7
LABEL authors="phil.ewels@scilifelab.se" \
description="Docker image for nf-core modules samtools"
# foobar
COPY environment.yml /
RUN conda env create -f /environment.yml && conda clean -a
ENV PATH /opt/conda/envs/nf-core-modules-samtools/bin:$PATH

View file

@ -1,9 +0,0 @@
# You can use this file to create a conda environment for this pipeline:
# conda env create -f environment.yml
name: nf-core-modules-samtools
channels:
- conda-forge
- bioconda
- defaults
dependencies:
- samtools=1.9

View file

@ -1,21 +0,0 @@
process samtools_index {
tag "${bam.baseName}"
container 'quay.io/biocontainers/samtools:1.9--h10a08f8_12'
input:
path bam
output:
path "*.bai"
script:
def suff_mem = ("${(task.memory.toBytes() - 6000000000) / task.cpus}" > 2000000000) ? 'true' : 'false'
def avail_mem = (task.memory && suff_mem) ? "-m" + "${(task.memory.toBytes() - 6000000000) / task.cpus}" : ''
"""
samtools index $bam \\
-@ ${task.cpus} ${avail_mem}
samtools --version &> v_samtools.txt
"""
}

View file

@ -1,27 +0,0 @@
name: samtools index
description: index a BAM or CRAM file
keywords:
- index
tools:
- samtools:
description: |
SAMtools is a set of utilities for interacting with and post-processing
short DNA sequence read alignments in the SAM, BAM and CRAM formats, written by Heng Li.
These files are generated as output by short read aligners like BWA.
homepage: http://www.htslib.org/
documentation: hhttp://www.htslib.org/doc/samtools.html
doi: 10.1093/bioinformatics/btp352
input:
-
- input:
type: file
description: Input BAM or CRAM file
pattern: "*.{bam,cram}"
output:
-
- index:
type: file
description: BAM or CRAM index file
pattern: "*.{bai}"
authors:
- "@ewels"

View file

@ -1,13 +0,0 @@
#!/usr/bin/env nextflow
echo true
cheers = Channel.from 'Bonjour', 'Ciao', 'Hello', 'Hola'
process sayHello {
input:
val x from cheers
script:
"""
echo '$x world!'
"""
}

View file

@ -1,2 +0,0 @@
docker.enabled = true
params.outdir = './results'