Skip to content

Commit

Permalink
chore: move tests/tools/input to tests/input
Browse files Browse the repository at this point in the history
  • Loading branch information
a-frantz committed Nov 25, 2024
1 parent 48cea9c commit f75b2b9
Show file tree
Hide file tree
Showing 86 changed files with 114 additions and 144 deletions.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
File renamed without changes.
3 changes: 0 additions & 3 deletions tests/tools/input/Aligned.sortedByCoord.out.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/GRCh38.chr1_chr19.fa

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/possorted_genome_bam.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test.bwa_aln_pe.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test.extra_RG.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test.fa

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test.unaccounted_read.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test2.bam

This file was deleted.

3 changes: 0 additions & 3 deletions tests/tools/input/test_rnaseq_variant.bam

This file was deleted.

6 changes: 3 additions & 3 deletions tests/tools/input_json/arriba.json
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
{
"bam": "tests/tools/input/Aligned.sortedByCoord.out.bam",
"gtf": "tests/tools/input/gencode.v31.chr9_chr22.gtf.gz",
"reference_fasta_gz": "tests/tools/input/GRCh38.chr9_chr22.fa.gz",
"bam": "tests/input/Aligned.sortedByCoord.out.bam",
"gtf": "tests/input/gencode.v31.chr9_chr22.gtf.gz",
"reference_fasta_gz": "tests/input/GRCh38.chr9_chr22.fa.gz",
"disable_filters": ["blacklist"],
"prefix": "fusions"
}
4 changes: 2 additions & 2 deletions tests/tools/input_json/bwa_aln.json
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
{
"fastq": "tests/tools/input/test_R1.fq.gz",
"fastq": "tests/input/test_R1.fq.gz",
"read_group": "@RG\\tID:test\\tSM:test",
"bwa_db_tar_gz": "tests/tools/input/bwa_db.tar.gz"
"bwa_db_tar_gz": "tests/input/bwa_db.tar.gz"
}
6 changes: 3 additions & 3 deletions tests/tools/input_json/bwa_aln_pe.json
Original file line number Diff line number Diff line change
@@ -1,6 +1,6 @@
{
"read_one_fastq_gz": "tests/tools/input/test_R1.fq.gz",
"read_two_fastq_gz": "tests/tools/input/test_R2.fq.gz",
"read_one_fastq_gz": "tests/input/test_R1.fq.gz",
"read_two_fastq_gz": "tests/input/test_R2.fq.gz",
"read_group": "@RG\\tID:test\\tSM:test",
"bwa_db_tar_gz": "tests/tools/input/bwa_db.tar.gz"
"bwa_db_tar_gz": "tests/input/bwa_db.tar.gz"
}
4 changes: 2 additions & 2 deletions tests/tools/input_json/bwa_mem.json
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
{
"read_one_fastq_gz": "tests/tools/input/test_R1.fq.gz",
"read_one_fastq_gz": "tests/input/test_R1.fq.gz",
"read_group": "@RG\\tID:test\\tSM:test",
"bwa_db_tar_gz": "tests/tools/input/bwa_db.tar.gz"
"bwa_db_tar_gz": "tests/input/bwa_db.tar.gz"
}
4 changes: 2 additions & 2 deletions tests/tools/input_json/cellranger_count.json
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
{
"fastqs_tar_gz": "tests/tools/input/pbmc_1k_v3.tar.gz",
"transcriptome_tar_gz": "tests/tools/input/GRCh38.tar.gz",
"fastqs_tar_gz": "tests/input/pbmc_1k_v3.tar.gz",
"transcriptome_tar_gz": "tests/input/GRCh38.tar.gz",
"id": "pbmc_1k_v3"
}
6 changes: 3 additions & 3 deletions tests/tools/input_json/gatk4_apply_bqsr.json
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
{
"bam": "tests/tools/input/test_rnaseq_variant.bam",
"bam_index": "tests/tools/input/test_rnaseq_variant.bam.bai",
"recalibration_report": "tests/tools/input/test_rnaseq_variant.recal.txt"
"bam": "tests/input/test_rnaseq_variant.bam",
"bam_index": "tests/input/test_rnaseq_variant.bam.bai",
"recalibration_report": "tests/input/test_rnaseq_variant.recal.txt"
}
18 changes: 9 additions & 9 deletions tests/tools/input_json/gatk4_base_recalibrator.json
Original file line number Diff line number Diff line change
@@ -1,11 +1,11 @@
{
"bam": "tests/tools/input/test_rnaseq_variant.bam",
"bam_index": "tests/tools/input/test_rnaseq_variant.bam.bai",
"fasta": "tests/tools/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/tools/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/tools/input/GRCh38.chr1_chr19.dict",
"dbSNP_vcf":"tests/tools/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf",
"dbSNP_vcf_index": "tests/tools/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf.idx",
"known_indels_sites_vcfs": ["tests/tools/input/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"],
"known_indels_sites_indices": ["tests/tools/input/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz.tbi"]
"bam": "tests/input/test_rnaseq_variant.bam",
"bam_index": "tests/input/test_rnaseq_variant.bam.bai",
"fasta": "tests/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/input/GRCh38.chr1_chr19.dict",
"dbSNP_vcf":"tests/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf",
"dbSNP_vcf_index": "tests/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf.idx",
"known_indels_sites_vcfs": ["tests/input/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"],
"known_indels_sites_indices": ["tests/input/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz.tbi"]
}
16 changes: 8 additions & 8 deletions tests/tools/input_json/gatk4_haplotype_caller.json
Original file line number Diff line number Diff line change
@@ -1,10 +1,10 @@
{
"bam": "tests/tools/input/test_rnaseq_variant.bam",
"bam_index": "tests/tools/input/test_rnaseq_variant.bam.bai",
"fasta": "tests/tools/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/tools/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/tools/input/GRCh38.chr1_chr19.dict",
"dbSNP_vcf": "tests/tools/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf",
"dbSNP_vcf_index": "tests/tools/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf.idx",
"interval_list": "tests/tools/input/chr1.interval_list"
"bam": "tests/input/test_rnaseq_variant.bam",
"bam_index": "tests/input/test_rnaseq_variant.bam.bai",
"fasta": "tests/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/input/GRCh38.chr1_chr19.dict",
"dbSNP_vcf": "tests/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf",
"dbSNP_vcf_index": "tests/input/Homo_sapiens_assembly38.dbsnp138.top5000.vcf.idx",
"interval_list": "tests/input/chr1.interval_list"
}
10 changes: 5 additions & 5 deletions tests/tools/input_json/gatk4_split_n_cigar_reads.json
Original file line number Diff line number Diff line change
@@ -1,8 +1,8 @@
{
"bam": "tests/tools/input/test.bam",
"bam_index": "tests/tools/input/test.bam.bai",
"fasta": "tests/tools/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/tools/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/tools/input/GRCh38.chr1_chr19.dict",
"bam": "tests/input/test.bam",
"bam_index": "tests/input/test.bam.bai",
"fasta": "tests/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/input/GRCh38.chr1_chr19.dict",
"prefix": "split"
}
10 changes: 5 additions & 5 deletions tests/tools/input_json/gatk4_variant_filtration.json
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
{
"vcf": "tests/tools/input/test1.vcf.gz",
"vcf_index": "tests/tools/input/test1.vcf.gz.tbi",
"fasta": "tests/tools/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/tools/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/tools/input/GRCh38.chr1_chr19.dict"
"vcf": "tests/input/test1.vcf.gz",
"vcf_index": "tests/input/test1.vcf.gz.tbi",
"fasta": "tests/input/GRCh38.chr1_chr19.fa",
"fasta_index": "tests/input/GRCh38.chr1_chr19.fa.fai",
"dict": "tests/input/GRCh38.chr1_chr19.dict"
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/kraken_build_db.json
Original file line number Diff line number Diff line change
@@ -1,3 +1,3 @@
{
"tarballs": ["tests/tools/input/kraken2_taxonomy.tar.gz", "tests/tools/input/kraken2_custom_library.tar.gz"]
"tarballs": ["tests/input/kraken2_taxonomy.tar.gz", "tests/input/kraken2_custom_library.tar.gz"]
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/multiqc.json
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
{
"files": ["tests/tools/input/test.bwa_aln_pe.readlength.txt"],
"files": ["tests/input/test.bwa_aln_pe.readlength.txt"],
"prefix": "test.bwa_aln_pe"
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/ngsderive_encoding.json
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
{
"ngs_files": ["tests/tools/input/test.bwa_aln_pe.bam"],
"ngs_files": ["tests/input/test.bwa_aln_pe.bam"],
"outfile_name": "test.bwa_aln_pe.encoding.tsv"
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/picard_merge_sam_files.json
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
{
"bams": ["tests/tools/input/possorted_genome_bam.bam", "tests/tools/input/test.bwa_aln_pe.bam"],
"bams": ["tests/input/possorted_genome_bam.bam", "tests/input/test.bwa_aln_pe.bam"],
"prefix": "test"
}
4 changes: 2 additions & 2 deletions tests/tools/input_json/picard_merge_vcfs.json
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
{
"vcfs": ["tests/tools/input/test1.vcf.gz", "tests/tools/input/test2.vcf.gz"],
"vcfs_indexes": ["tests/tools/input/test1.vcf.gz.tbi", "tests/tools/input/test2.vcf.gz.tbi"],
"vcfs": ["tests/input/test1.vcf.gz", "tests/input/test2.vcf.gz"],
"vcfs_indexes": ["tests/input/test1.vcf.gz.tbi", "tests/input/test2.vcf.gz.tbi"],
"output_vcf_name": "test.vcf.gz"
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/sambamba_merge.json
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
{
"bams": ["tests/tools/input/possorted_genome_bam.bam", "tests/tools/input/test.bwa_aln_pe.bam"],
"bams": ["tests/input/possorted_genome_bam.bam", "tests/input/test.bwa_aln_pe.bam"],
"prefix": "test"
}
2 changes: 1 addition & 1 deletion tests/tools/input_json/samtools_merge.json
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
{
"bams": ["tests/tools/input/test2.bam", "tests/tools/input/test.bwa_aln_pe.bam"],
"bams": ["tests/input/test2.bam", "tests/input/test.bwa_aln_pe.bam"],
"prefix": "test"
}
6 changes: 3 additions & 3 deletions tests/tools/input_json/star_alignment.json
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
{
"read_one_fastqs_gz": ["tests/tools/input/test_R1.fq.gz"],
"read_two_fastqs_gz": ["tests/tools/input/test_R2.fq.gz"],
"star_db_tar_gz": "tests/tools/input/star_db.tar.gz",
"read_one_fastqs_gz": ["tests/input/test_R1.fq.gz"],
"read_two_fastqs_gz": ["tests/input/test_R2.fq.gz"],
"star_db_tar_gz": "tests/input/star_db.tar.gz",
"prefix": "test",
"read_groups": "ID:test"
}
6 changes: 3 additions & 3 deletions tests/tools/test_arriba.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -13,7 +13,7 @@
- miniwdl
- arriba
command: >-
miniwdl run -d test-output/. --task arriba_tsv_to_vcf tools/arriba.wdl fusions="tests/tools/input/fusions.tsv" reference_fasta="tests/tools/input/GRCh38.chr9_chr22.fa.gz"
miniwdl run -d test-output/. --task arriba_tsv_to_vcf tools/arriba.wdl fusions="tests/input/fusions.tsv" reference_fasta="tests/input/GRCh38.chr9_chr22.fa.gz"
files:
- path: test-output/out/fusions_vcf/fusions.vcf

Expand All @@ -22,7 +22,7 @@
- miniwdl
- arriba
command: >-
miniwdl run -d test-output/. --task arriba_extract_fusion_supporting_alignments tools/arriba.wdl fusions="tests/tools/input/fusions.tsv" bam="tests/tools/input/Aligned.sortedByCoord.out.bam" bam_index="tests/tools/input/Aligned.sortedByCoord.out.bam.bai"
miniwdl run -d test-output/. --task arriba_extract_fusion_supporting_alignments tools/arriba.wdl fusions="tests/input/fusions.tsv" bam="tests/input/Aligned.sortedByCoord.out.bam" bam_index="tests/input/Aligned.sortedByCoord.out.bam.bai"
files:
- path: test-output/out/fusion_bams/0/fusions_1.bam

Expand All @@ -31,6 +31,6 @@
- miniwdl
- arriba
command: >-
miniwdl run -d test-output/. --task arriba_annotate_exon_numbers tools/arriba.wdl fusions="tests/tools/input/fusions.tsv" gtf="tests/tools/input/gencode.v31.chr9_chr22.gtf.gz"
miniwdl run -d test-output/. --task arriba_annotate_exon_numbers tools/arriba.wdl fusions="tests/input/fusions.tsv" gtf="tests/input/gencode.v31.chr9_chr22.gtf.gz"
files:
- path: test-output/out/fusion_tsv/fusions.annotated.tsv
2 changes: 1 addition & 1 deletion tests/tools/test_bwa.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -31,6 +31,6 @@
- bwa
- reference
command: >-
miniwdl run --verbose -d test-output/. --task build_bwa_db tools/bwa.wdl reference_fasta="tests/tools/input/GRCh38.chrY_chrM.fa.gz"
miniwdl run --verbose -d test-output/. --task build_bwa_db tools/bwa.wdl reference_fasta="tests/input/GRCh38.chrY_chrM.fa.gz"
files:
- path: test-output/out/bwa_db_tar_gz/bwa_db.tar.gz
2 changes: 1 addition & 1 deletion tests/tools/test_cellranger.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -25,7 +25,7 @@
- miniwdl
- cellranger
command: >-
miniwdl run --verbose -d test-output/. --task bamtofastq tools/cellranger.wdl bam="tests/tools/input/possorted_genome_bam.bam"
miniwdl run --verbose -d test-output/. --task bamtofastq tools/cellranger.wdl bam="tests/input/possorted_genome_bam.bam"
files:
- path: test-output/out/fastqs/0/bamtofastq_S1_L001_R1_001.fastq.gz
- path: test-output/out/fastqs/1/bamtofastq_S1_L001_R2_001.fastq.gz
Expand Down
2 changes: 1 addition & 1 deletion tests/tools/test_deeptools.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,6 +3,6 @@
- miniwdl
- deeptools
command: >-
miniwdl run --verbose -d test-output/. --task bam_coverage tools/deeptools.wdl bam="tests/tools/input/test.bwa_aln_pe.bam" bam_index="tests/tools/input/test.bwa_aln_pe.bam.bai"
miniwdl run --verbose -d test-output/. --task bam_coverage tools/deeptools.wdl bam="tests/input/test.bwa_aln_pe.bam" bam_index="tests/input/test.bwa_aln_pe.bam.bai"
files:
- path: test-output/out/bigwig/test.bwa_aln_pe.bw
2 changes: 1 addition & 1 deletion tests/tools/test_estimate.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -5,6 +5,6 @@
- estimate
- deprecated
command: >-
miniwdl run --verbose -d test-output/. --task run_estimate tools/estimate.wdl gene_expression_file="tests/tools/input/test.bwa_aln_pe.TPM.txt"
miniwdl run --verbose -d test-output/. --task run_estimate tools/estimate.wdl gene_expression_file="tests/input/test.bwa_aln_pe.TPM.txt"
files:
- path: test-output/out/estimate_file/test.bwa_aln_pe.ESTIMATE.gct
2 changes: 1 addition & 1 deletion tests/tools/test_fastqc.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- fastqc
command: >-
miniwdl run --verbose -d test-output/. --task fastqc tools/fastqc.wdl bam="tests/tools/input/test.bwa_aln_pe.bam"
miniwdl run --verbose -d test-output/. --task fastqc tools/fastqc.wdl bam="tests/input/test.bwa_aln_pe.bam"
files:
- path: test-output/out/raw_data/test.bwa_aln_pe_fastqc.zip
- path: test-output/out/results/test.bwa_aln_pe.fastqc_results.tar.gz
6 changes: 3 additions & 3 deletions tests/tools/test_fq.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- fq
command: >-
miniwdl run --verbose -d test-output/. --task fqlint tools/fq.wdl read_one_fastq=tests/tools/input/test_R1.fq.gz read_two_fastq=tests/tools/input/test_R2.fq.gz
miniwdl run --verbose -d test-output/. --task fqlint tools/fq.wdl read_one_fastq=tests/input/test_R1.fq.gz read_two_fastq=tests/input/test_R2.fq.gz
stdout:
contains_regex:
- "passed"
Expand All @@ -13,7 +13,7 @@
- miniwdl
- fq
command: >-
miniwdl run --verbose -d test-output/. --task subsample tools/fq.wdl read_one_fastq=tests/tools/input/test_R1.fq.gz read_two_fastq=tests/tools/input/test_R2.fq.gz record_count=1000
miniwdl run --verbose -d test-output/. --task subsample tools/fq.wdl read_one_fastq=tests/input/test_R1.fq.gz read_two_fastq=tests/input/test_R2.fq.gz record_count=1000
files:
- path: test-output/out/subsampled_read1/test_R1.subsampled.fastq.gz
- path: test-output/out/subsampled_read2/test_R2.subsampled.fastq.gz
Expand All @@ -23,7 +23,7 @@
- miniwdl
- fq
command: >-
miniwdl run --verbose -d test-output/. --task subsample tools/fq.wdl read_one_fastq=tests/tools/input/test_R1.fq.gz read_two_fastq=tests/tools/input/test_R2.fq.gz probability=0.01
miniwdl run --verbose -d test-output/. --task subsample tools/fq.wdl read_one_fastq=tests/input/test_R1.fq.gz read_two_fastq=tests/input/test_R2.fq.gz probability=0.01
files:
- path: test-output/out/subsampled_read1/test_R1.subsampled.fastq.gz
- path: test-output/out/subsampled_read2/test_R2.subsampled.fastq.gz
2 changes: 1 addition & 1 deletion tests/tools/test_gatk4.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -53,7 +53,7 @@
- miniwdl
- gatk4
command: >-
miniwdl run --verbose -d test-output/. --task mark_duplicates_spark tools/gatk4.wdl bam="tests/tools/input/test.bwa_aln_pe.bam"
miniwdl run --verbose -d test-output/. --task mark_duplicates_spark tools/gatk4.wdl bam="tests/input/test.bwa_aln_pe.bam"
files:
- path: test-output/out/duplicate_marked_bam/test.bwa_aln_pe.MarkDuplicates.bam
- path: test-output/out/duplicate_marked_bam_index/test.bwa_aln_pe.MarkDuplicates.bam.bai
Expand Down
4 changes: 2 additions & 2 deletions tests/tools/test_htseq.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- htseq
command: >-
miniwdl run --verbose -d test-output/. --task count tools/htseq.wdl bam="tests/tools/input/test.bwa_aln_pe.bam" gtf="tests/tools/input/genes.gtf.gz" strandedness="no"
miniwdl run --verbose -d test-output/. --task count tools/htseq.wdl bam="tests/input/test.bwa_aln_pe.bam" gtf="tests/input/genes.gtf.gz" strandedness="no"
files:
- path: test-output/out/feature_counts/test.bwa_aln_pe.feature-counts.txt

Expand All @@ -12,6 +12,6 @@
- miniwdl
- htseq
command: >-
miniwdl run --verbose -d test-output/. --task calc_tpm tools/htseq.wdl counts="tests/tools/input/test.bwa_aln_pe.feature-counts.txt" gene_lengths="tests/tools/input/genes.genelengths.txt"
miniwdl run --verbose -d test-output/. --task calc_tpm tools/htseq.wdl counts="tests/input/test.bwa_aln_pe.feature-counts.txt" gene_lengths="tests/input/genes.genelengths.txt"
files:
- path: test-output/out/tpm_file/test.bwa_aln_pe.TPM.txt
2 changes: 1 addition & 1 deletion tests/tools/test_kraken2.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -43,6 +43,6 @@
- miniwdl
- kraken
command: >-
miniwdl run --verbose -d test-output/. --task kraken tools/kraken2.wdl read_one_fastq_gz="tests/tools/input/test_R1.fq.gz" read_two_fastq_gz="tests/tools/input/test_R2.fq.gz" db="tests/tools/input/kraken2_db.tar.gz"
miniwdl run --verbose -d test-output/. --task kraken tools/kraken2.wdl read_one_fastq_gz="tests/input/test_R1.fq.gz" read_two_fastq_gz="tests/input/test_R2.fq.gz" db="tests/input/kraken2_db.tar.gz"
files:
- path: test-output/out/report/test.kraken2.txt
2 changes: 1 addition & 1 deletion tests/tools/test_librarian.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- librarian
command: >-
miniwdl run --verbose -d test-output/. --task librarian tools/librarian.wdl read_one_fastq="tests/tools/input/test_R1.fq.gz"
miniwdl run --verbose -d test-output/. --task librarian tools/librarian.wdl read_one_fastq="tests/input/test_R1.fq.gz"
files:
- path: test-output/out/report/test.librarian.tar.gz
- path: test-output/out/raw_data/librarian_heatmap.txt
2 changes: 1 addition & 1 deletion tests/tools/test_md5sum.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- md5sum
command: >-
miniwdl run --verbose -d test-output/. --task compute_checksum tools/md5sum.wdl file="tests/tools/input/test.bwa_aln_pe.bam"
miniwdl run --verbose -d test-output/. --task compute_checksum tools/md5sum.wdl file="tests/input/test.bwa_aln_pe.bam"
files:
- path: test-output/out/md5sum/test.bwa_aln_pe.bam.md5
contains:
Expand Down
2 changes: 1 addition & 1 deletion tests/tools/test_mosdepth.yaml
Original file line number Diff line number Diff line change
Expand Up @@ -3,7 +3,7 @@
- miniwdl
- mosdepth
command: >-
miniwdl run --verbose -d test-output/. --task coverage tools/mosdepth.wdl bam="tests/tools/input/test.bwa_aln_pe.bam" bam_index="tests/tools/input/test.bwa_aln_pe.bam.bai"
miniwdl run --verbose -d test-output/. --task coverage tools/mosdepth.wdl bam="tests/input/test.bwa_aln_pe.bam" bam_index="tests/input/test.bwa_aln_pe.bam.bai"
files:
- path: test-output/out/summary/test.bwa_aln_pe.mosdepth.summary.txt
- path: test-output/out/global_dist/test.bwa_aln_pe.mosdepth.global.dist.txt
Loading

0 comments on commit f75b2b9

Please sign in to comment.