style: Remove newline at end of files

This commit is contained in:
Edmund Miller 2021-02-03 13:22:42 -06:00
parent 5f810beaa4
commit b62d01285e
No known key found for this signature in database
GPG key ID: BD387FF7BC10AA9D
229 changed files with 18304 additions and 18310 deletions

View file

@ -3,7 +3,7 @@ root = true
[*]
charset = utf-8
end_of_line = lf
insert_final_newline = true
insert_final_newline = false
trim_trailing_whitespace = true
indent_size = 4
indent_style = space

View file

@ -40,11 +40,11 @@ We have written a helper command in the `nf-core/tools` package that uses the Gi
```console
$ nf-core modules list
,--./,-.
___ __ __ __ ___ /,-._.--~\
,--./,-.
___ __ __ __ ___ /,-._.--~\
|\ | |__ __ / ` / \ |__) |__ } {
| \| | \__, \__/ | \ |___ \`-._,-`-,
`._,._,'
`._,._,'
nf-core/tools version 1.10.2
@ -67,11 +67,11 @@ We have written a helper command in the `nf-core/tools` package that uses the Gi
```console
$ nf-core modules install . fastqc
,--./,-.
___ __ __ __ ___ /,-._.--~\
,--./,-.
___ __ __ __ ___ /,-._.--~\
|\ | |__ __ / ` / \ |__) |__ } {
| \| | \__, \__/ | \ |___ \`-._,-`-,
`._,._,'
`._,._,'
nf-core/tools version 1.10.2
@ -99,11 +99,11 @@ We have written a helper command in the `nf-core/tools` package that uses the Gi
...truncated...
Commands:
list List available software modules.
install Add a DSL2 software wrapper module to a pipeline.
update Update one or all software wrapper modules. (NOT YET IMPLEMENTED)
remove Remove a software wrapper from a pipeline. (NOT YET IMPLEMENTED)
check Check that imported module code has not been modified. (NOT YET IMPLEMENTED)
list List available software modules.
install Add a DSL2 software wrapper module to a pipeline.
update Update one or all software wrapper modules. (NOT YET IMPLEMENTED)
remove Remove a software wrapper from a pipeline. (NOT YET IMPLEMENTED)
check Check that imported module code has not been modified. (NOT YET IMPLEMENTED)
```
## Adding a new module file

View file

@ -1,5 +1,3 @@
chr1 951 1061
chr1 1300 1420
chr1 1400 1500

View file

@ -41,9 +41,9 @@
background-color: #EEE;
border:0;
margin:0;
padding:0.5em;
padding:0.5em;
height: 1.3em;
overflow:hidden;
overflow:hidden;
font-size: 100%;
font-weight: bold;
position:fixed;
@ -58,15 +58,15 @@
}
@media print {
img {
max-width:100% !important;
page-break-inside: avoid;
}
h2, h3 {
page-break-after: avoid;
}
div.header {
background-color: #FFF;
img {
max-width:100% !important;
page-break-inside: avoid;
}
h2, h3 {
page-break-after: avoid;
}
div.header {
background-color: #FFF;
}
}

View file

@ -41,9 +41,9 @@
background-color: #EEE;
border:0;
margin:0;
padding:0.5em;
padding:0.5em;
height: 1.3em;
overflow:hidden;
overflow:hidden;
font-size: 100%;
font-weight: bold;
position:fixed;
@ -58,15 +58,15 @@
}
@media print {
img {
max-width:100% !important;
page-break-inside: avoid;
}
h2, h3 {
page-break-after: avoid;
}
div.header {
background-color: #FFF;
img {
max-width:100% !important;
page-break-inside: avoid;
}
h2, h3 {
page-break-after: avoid;
}
div.header {
background-color: #FFF;
}
}

View file

@ -12,7 +12,7 @@ workflow test_bowtie_align_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true) ] ]
BOWTIE_ALIGN ( input, BOWTIE_BUILD.out.index )
}
@ -23,7 +23,7 @@ workflow test_bowtie_align_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
BOWTIE_ALIGN ( input, BOWTIE_BUILD.out.index )
}

View file

@ -12,7 +12,7 @@ workflow test_bowtie2_align_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true) ] ]
BOWTIE2_ALIGN ( input, BOWTIE2_BUILD.out.index )
}
@ -23,7 +23,7 @@ workflow test_bowtie2_align_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
BOWTIE2_ALIGN ( input, BOWTIE2_BUILD.out.index )
}

View file

@ -11,7 +11,7 @@ workflow test_bwa_mem_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz", checkIfExists: true) ] ]
BWA_MEM (
input,
@ -27,7 +27,7 @@ workflow test_bwa_mem_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/dna/Ecoli_DNA_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/dna/Ecoli_DNA_R2.fastq.gz", checkIfExists: true) ] ]
BWA_MEM (

View file

@ -11,7 +11,7 @@ workflow test_cutadapt_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
CUTADAPT( input )
}
@ -23,8 +23,7 @@ workflow test_cutadapt_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
CUTADAPT( input )
}

View file

@ -8,7 +8,7 @@ workflow test_dsh_filterbed {
def input = []
input = [ [ id:'A' ], // meta map
[ file("${launchDir}/tests/data/bed/A.bed.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/bed/A.bed.gz", checkIfExists: true) ] ]
DSH_FILTERBED ( input )
}

View file

@ -8,7 +8,7 @@ workflow test_dsh_splitbed {
def input = []
input = [ [ id:'A' ], // meta map
[ file("${launchDir}/tests/data/bed/A.bed.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/bed/A.bed.gz", checkIfExists: true) ] ]
DSH_SPLITBED ( input )
}

View file

@ -11,7 +11,7 @@ workflow test_fastp_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
FASTP ( input )
}
@ -22,8 +22,7 @@ workflow test_fastp_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
FASTP ( input )
}

View file

@ -11,7 +11,7 @@ workflow test_fastqc_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
FASTQC ( input )
}
@ -22,7 +22,7 @@ workflow test_fastqc_paired_end {
def input = []
input = [[id: 'test', single_end: false], // meta map
[file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true)]]
[file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true)]]
FASTQC (input)
}

View file

@ -9,7 +9,7 @@ workflow test_multiqc {
def input = []
input = [ [ id: 'test', single_end: false ],
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
FASTQC ( input )
MULTIQC ( FASTQC.out.zip.collect { it[1] } )

View file

@ -4,4 +4,3 @@
- multiqc
files:
- path: output/multiqc/multiqc_report.html

View file

@ -6,7 +6,7 @@ include { PANGOLIN } from '../../../software/pangolin/main.nf' addParams(options
workflow test_pangolin {
input = [ [ id:'test' ], // meta map
[ file("${launchDir}/tests/data/fasta/sarscov2/GCA_011545545.1_ASM1154554v1_genomic.fna", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fasta/sarscov2/GCA_011545545.1_ASM1154554v1_genomic.fna", checkIfExists: true) ] ]
PANGOLIN( input )
}

View file

@ -8,7 +8,7 @@ workflow test_picard_collectmultiplemetrics {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.name.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.name.sorted.bam", checkIfExists: true) ]
PICARD_COLLECTMULTIPLEMETRICS (
input,

View file

@ -8,7 +8,7 @@ workflow test_picard_markduplicates_sorted_bam {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
PICARD_MARKDUPLICATES ( input )
}
@ -17,7 +17,7 @@ workflow test_picard_markduplicates_unsorted_bam {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.name.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.name.sorted.bam", checkIfExists: true) ]
PICARD_MARKDUPLICATES ( input )
}

View file

@ -8,7 +8,7 @@ workflow test_picard_mergesamfiles {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.name.sorted.bam", checkIfExists: true), ] ]
PICARD_MERGESAMFILES ( input )

View file

@ -11,7 +11,7 @@ workflow test_preseq_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file('https://github.com/smithlabcode/preseq/raw/master/data/SRR1003759_5M_subset.mr', checkIfExists: true), ] ]
[ file('https://github.com/smithlabcode/preseq/raw/master/data/SRR1003759_5M_subset.mr', checkIfExists: true), ] ]
PRESEQ_LCEXTRAP ( input )
}
@ -22,8 +22,7 @@ workflow test_preseq_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file('https://github.com/smithlabcode/preseq/raw/master/data/SRR1003759_5M_subset.mr', checkIfExists: true), ] ]
[ file('https://github.com/smithlabcode/preseq/raw/master/data/SRR1003759_5M_subset.mr', checkIfExists: true), ] ]
PRESEQ_LCEXTRAP ( input )
}

View file

@ -11,7 +11,7 @@ workflow test_salmon_quant_single_end {
def transcript_fasta = file("${launchDir}/tests/data/fasta/sarscov2/GCA_011545545.1_ASM1154554v1_cds_from_genomic.fna", checkIfExists: true)
def gtf = file("${launchDir}/tests/data/gff/sarscov2/GCA_011545545.1_ASM1154554v1_genomic.gtf", checkIfExists: true)
def input = [ [ id:'test', single_end:true ], // meta map
file("${launchDir}/tests/data/fastq/rna/sarscov2/EPI_ISL_486436_1.fastq.gz", checkIfExists: true) ]
file("${launchDir}/tests/data/fastq/rna/sarscov2/EPI_ISL_486436_1.fastq.gz", checkIfExists: true) ]
SALMON_INDEX ( genome_fasta, transcript_fasta )
SALMON_QUANT ( input, SALMON_INDEX.out.index, gtf, transcript_fasta, false )
@ -24,7 +24,7 @@ workflow test_salmon_quant_paired_end {
def transcript_fasta = file("${launchDir}/tests/data/fasta/sarscov2/GCA_011545545.1_ASM1154554v1_cds_from_genomic.fna", checkIfExists: true)
def gtf = file("${launchDir}/tests/data/gff/sarscov2/GCA_011545545.1_ASM1154554v1_genomic.gtf", checkIfExists: true)
def input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/sarscov2/EPI_ISL_486436_1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/sarscov2/EPI_ISL_486436_1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/sarscov2/EPI_ISL_486436_2.fastq.gz", checkIfExists: true) ] ]
SALMON_INDEX ( genome_fasta, transcript_fasta )

View file

@ -8,7 +8,7 @@ workflow test_samtools_flagstat {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
SAMTOOLS_FLAGSTAT ( input )
}

View file

@ -8,7 +8,7 @@ workflow test_samtools_idxstats {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
SAMTOOLS_IDXSTATS ( input )
}

View file

@ -8,6 +8,6 @@ workflow test_samtools_index {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
SAMTOOLS_INDEX ( input )
}

View file

@ -9,7 +9,7 @@ workflow test_samtools_mpileup {
def input = []
def fasta = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
fasta = [ file("${launchDir}/tests/data/fasta/E_coli/NC_010473.fa", checkIfExists: true) ]
SAMTOOLS_MPILEUP ( input, fasta )
}

View file

@ -8,6 +8,6 @@ workflow test_samtools_sort {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
SAMTOOLS_SORT ( input )
}

View file

@ -8,7 +8,7 @@ workflow test_samtools_stats {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true),
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam.bai", checkIfExists: true) ]
SAMTOOLS_STATS ( input )
}

View file

@ -8,6 +8,6 @@ workflow test_samtools_view {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ]
SAMTOOLS_VIEW ( input )
}

View file

@ -8,8 +8,8 @@ workflow test_seacr_callpeak {
def input = []
input = [[ id:'test_1'],
file("${launchDir}/tests/data/bedgraph/K27me3_1_to_chr20.bedgraph", checkIfExists: true),
file("${launchDir}/tests/data/bedgraph/IgG_1_to_chr20.bedgraph", checkIfExists: true) ]
file("${launchDir}/tests/data/bedgraph/K27me3_1_to_chr20.bedgraph", checkIfExists: true),
file("${launchDir}/tests/data/bedgraph/IgG_1_to_chr20.bedgraph", checkIfExists: true) ]
SEACR_CALLPEAK ( input )
}

View file

@ -12,7 +12,7 @@ workflow test_star_alignment_single_end {
STAR_GENOMEGENERATE ( fasta, gtf )
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
STAR_ALIGN ( input, STAR_GENOMEGENERATE.out.index, gtf )
}
@ -23,7 +23,7 @@ workflow test_star_alignment_paired_end {
STAR_GENOMEGENERATE ( fasta, gtf )
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
STAR_ALIGN ( input, STAR_GENOMEGENERATE.out.index, gtf )
}

View file

@ -11,7 +11,7 @@ include { STRINGTIE as STRINGTIE_REVERSE } from '../../../software/stringtie/mai
workflow test_stringtie_forward {
def input = []
input = [ [ id:'test', strandedness:'forward' ], // meta map
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ] ]
STRINGTIE_FORWARD (
input,
@ -25,7 +25,7 @@ workflow test_stringtie_forward {
workflow test_stringtie_reverse {
def input = []
input = [ [ id:'test', strandedness:'reverse' ], // meta map
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/bam/test.paired_end.sorted.bam", checkIfExists: true) ] ]
STRINGTIE_REVERSE (
input,

View file

@ -11,7 +11,7 @@ workflow test_trimgalore_single_end {
def input = []
input = [ [ id:'test', single_end:true ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
[ file("${launchDir}/tests/data/fastq/rna/test_single_end.fastq.gz", checkIfExists: true) ] ]
TRIMGALORE ( input )
}
@ -22,7 +22,7 @@ workflow test_trimgalore_paired_end {
def input = []
input = [ [ id:'test', single_end:false ], // meta map
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
[ file("${launchDir}/tests/data/fastq/rna/test_R1.fastq.gz", checkIfExists: true),
file("${launchDir}/tests/data/fastq/rna/test_R2.fastq.gz", checkIfExists: true) ] ]
TRIMGALORE ( input )

View file

@ -7,7 +7,7 @@ include { UCSC_BEDGRAPHTOBIGWIG } from '../../../../software/ucsc/bedgraphtobig
workflow test_ucsc_bedgraphtobigwig {
def input = []
input = [ [ id:'test' ], // meta map
[ file('https://raw.githubusercontent.com/igvteam/igv.js/master/test/data/wig/bedgraph-example-uscs.bedgraph', checkIfExists: true) ] ]
[ file('https://raw.githubusercontent.com/igvteam/igv.js/master/test/data/wig/bedgraph-example-uscs.bedgraph', checkIfExists: true) ] ]
UCSC_BEDGRAPHTOBIGWIG (
input,