Skip to content

Commit

Permalink
Update reference paths
Browse files Browse the repository at this point in the history
  • Loading branch information
nwiltsie committed Oct 28, 2024
1 parent ff96adf commit cd4d719
Show file tree
Hide file tree
Showing 22 changed files with 206 additions and 206 deletions.
60 changes: 30 additions & 30 deletions config/template.config
Original file line number Diff line number Diff line change
Expand Up @@ -59,24 +59,24 @@ params {
align_DNA {
enable_spark = true
mark_duplicates = true
reference_fasta_bwa = '/hot/ref/tool-specific-input/BWA-MEM2-2.2.1/GRCh38-BI-20160721/alt-aware/genome.fa'
reference_fasta_bwa = '/hot/resource/tool-specific-input/BWA-MEM2-2.2.1/GRCh38-BI-20160721/alt-aware/genome.fa'
aligner = ['BWA-MEM2']
}

recalibrate_BAM {
aligner = "BWA-MEM2-2.2.1"
reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_known_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Homo_sapiens_assembly38.known_indels.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_contest_hapmap_3p3_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Biallelic/hapmap_3.3.hg38.BIALLELIC.PASS.2021-09-01.vcf.gz"
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_known_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Homo_sapiens_assembly38.known_indels.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_contest_hapmap_3p3_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Biallelic/hapmap_3.3.hg38.BIALLELIC.PASS.2021-09-01.vcf.gz"
parallelize_by_chromosome = true
}

calculate_targeted_coverage {
reference_dict = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict'
reference_dbSNP = '/hot/ref/database/dbSNP-155/thinned/GRCh38/dbSNP-155_thinned_hg38.vcf.gz'
genome_sizes = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta.fai'
reference_dict = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict'
reference_dbSNP = '/hot/resource/database/dbSNP-155/thinned/GRCh38/dbSNP-155_thinned_hg38.vcf.gz'
genome_sizes = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta.fai'
target_bed = 'path/to/target/bedfile' //required
bait_bed = '' //optional, path/to/bait/bedfile
collect_metrics = true // whether or not to calculate coverage metrics
Expand All @@ -87,52 +87,52 @@ params {

generate_SQC_BAM {
algorithms = ['stats', 'collectwgsmetrics']
reference = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
reference = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
}

call_gSNP {
reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"
}

call_sSNV {
algorithm = ['somaticsniper', 'strelka2', 'mutect2', 'muse']
reference = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
reference = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exome = false
intersect_regions = '/hot/ref/tool-specific-input/pipeline-call-sSNV-6.0.0/GRCh38-BI-20160721/Homo_sapiens_assembly38_no-decoy.bed.gz'
germline_resource_gnomad_vcf = '/hot/ref/tool-specific-input/GATK/GRCh38/af-only-gnomad.hg38.vcf.gz'
dbSNP = '/hot/ref/database/dbSNP-155/original/GRCh38/GCF_000001405.39.gz'
intersect_regions = '/hot/resource/tool-specific-input/pipeline-call-sSNV-6.0.0/GRCh38-BI-20160721/Homo_sapiens_assembly38_no-decoy.bed.gz'
germline_resource_gnomad_vcf = '/hot/resource/tool-specific-input/GATK/GRCh38/af-only-gnomad.hg38.vcf.gz'
dbSNP = '/hot/resource/database/dbSNP-155/original/GRCh38/GCF_000001405.39.gz'
ncbi_build = 'GRCh38'
}

call_mtSNV {
mt_ref_genome_dir = '/hot/ref/mitochondria_ref/genome_fasta/'
gmapdb = '/hot/ref/mitochondria_ref/gmapdb/gmapdb_2021-03-08/'
mt_ref_genome_dir = '/hot/resource/mitochondria_ref/genome_fasta/'
gmapdb = '/hot/resource/mitochondria_ref/gmapdb/gmapdb_2021-03-08/'
}

call_gSV {
reference_fasta = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/ref/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv'
mappability_map = '/hot/ref/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz'
reference_fasta = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/resource/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv'
mappability_map = '/hot/resource/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz'
}

call_sSV {
algorithm = ['delly', 'manta']
reference_fasta = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/ref/tool-specific-input/Delly/hg38/human.hg38.excl.tsv'
reference_fasta = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/resource/tool-specific-input/Delly/hg38/human.hg38.excl.tsv'
}

call_sCNA {
algorithm = ['battenberg', 'cnv_facets']
sample_sex = "male"
position_scale = "genome-position"
dbSNP_file = "/hot/ref/tool-specific-input/RecSNV/GRCh38/dbsnp_b150_grch38.vcf.gz"
battenberg_reference = "/hot/ref/tool-specific-input/Battenberg/download_202204/GRCh38/battenberg_ref_hg38_chr/"
reference_dict = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict"
dbSNP_file = "/hot/resource/tool-specific-input/RecSNV/GRCh38/dbsnp_b150_grch38.vcf.gz"
battenberg_reference = "/hot/resource/tool-specific-input/Battenberg/download_202204/GRCh38/battenberg_ref_hg38_chr/"
reference_dict = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict"
}

call_SRC {
Expand Down
14 changes: 7 additions & 7 deletions module/call_gSNP/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -33,15 +33,15 @@ params {

// Reference - Used here hg38 decoy version
// GATK requires the reference fasta to be accompanied by a .fai index and .dict dictionary associated with the fasta for fast random access
// These can be found in the same folder as the reference here: /hot/ref/reference/GRCh38-BI-20160721
reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
// These can be found in the same folder as the reference here: /hot/resource/reference-genome/GRCh38-BI-20160721
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"

// GATK bundle - Used here hg38 decoy version
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"

// Base resource allocation updater
// See README for adding parameters to update the base resource allocations
Expand Down
6 changes: 3 additions & 3 deletions module/call_gSV/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -27,10 +27,10 @@ params {
// input_csv = "path/to/input/csv/"
output_dir = ""

reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"

// exclusion_file = "/hot/ref/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv"
// mappability_map = "/hot/ref/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz"
// exclusion_file = "/hot/resource/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv"
// mappability_map = "/hot/resource/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz"

map_qual = 20 // min. paired-end (PE) mapping quality for Delly
}
Expand Down
8 changes: 4 additions & 4 deletions module/call_sSNV/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -12,8 +12,8 @@ includeConfig "${projectDir}/config/methods.config"

params {
algorithm = [] // 'somaticsniper', 'strelka2', 'mutect2', 'muse'
reference = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
intersect_regions = '/hot/ref/tool-specific-input/pipeline-call-sSNV-6.0.0/GRCh38-BI-20160721/Homo_sapiens_assembly38_no-decoy.bed.gz'
reference = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
intersect_regions = '/hot/resource/tool-specific-input/pipeline-call-sSNV-6.0.0/GRCh38-BI-20160721/Homo_sapiens_assembly38_no-decoy.bed.gz'
output_dir = ''
work_dir = ''
dataset_id = ''
Expand All @@ -32,10 +32,10 @@ params {
filter_mutect_calls_extra_args = ''
gatk_command_mem_diff = 500.MB
scatter_count = 50
// germline_resource_gnomad_vcf = '/hot/ref/tool-specific-input/GATK/GRCh38/af-only-gnomad.hg38.vcf.gz'
// germline_resource_gnomad_vcf = '/hot/resource/tool-specific-input/GATK/GRCh38/af-only-gnomad.hg38.vcf.gz'

// MuSE options
// dbSNP = '/hot/ref/database/dbSNP-155/original/GRCh38/GCF_000001405.39.gz'
// dbSNP = '/hot/resource/database/dbSNP-155/original/GRCh38/GCF_000001405.39.gz'

// Intersect options
ncbi_build = 'GRCh38'
Expand Down
4 changes: 2 additions & 2 deletions module/call_sSV/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -11,9 +11,9 @@ params {

blcds_registered_dataset = false

reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"

// exclusion_file = "/hot/ref/tool-specific-input/Delly/hg38/human.hg38.excl.tsv"
// exclusion_file = "/hot/resource/tool-specific-input/Delly/hg38/human.hg38.excl.tsv"

output_dir = ''

Expand Down
2 changes: 1 addition & 1 deletion module/convert_BAM2FASTQ/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -12,7 +12,7 @@ params {
// input_csv = "/absolute/path/to/input.csv"
// output_dir = "/absolute/path/to/output_directory"
// temp_dir = "/scratch/"
reference_genome = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
reference_genome = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"

// processing options
filter_qc_failed_reads = false
Expand Down
2 changes: 1 addition & 1 deletion module/generate_SQC_BAM/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@ includeConfig "${projectDir}/nextflow.config"
// Inputs/parameters of the pipeline
params {
algorithms = ['stats', 'collectwgsmetrics'] // 'stats', 'collectwgsmetrics', 'bamqc'
reference = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
reference = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
blcds_registered_dataset = false // if you want the output to be registered
save_intermediate_files = true

Expand Down
12 changes: 6 additions & 6 deletions module/recalibrate_BAM/default.config
Original file line number Diff line number Diff line change
Expand Up @@ -41,8 +41,8 @@ params {

// Reference - Used here hg38 decoy version
// GATK requires the reference fasta to be accompanied by a .fai index and .dict dictionary associated with the fasta for fast random access
// These can be found in the same folder as the reference here: /hot/ref/reference/GRCh38-BI-20160721
reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
// These can be found in the same folder as the reference here: /hot/resource/reference-genome/GRCh38-BI-20160721
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"

// Whether to parallelize the pipeline by chromosome or by splitting into equal-sized intervals
// The scatter_count and extra args below only go into effect if parallelize_by_chromosome is disabled
Expand All @@ -51,10 +51,10 @@ params {
split_intervals_extra_args = ''

// GATK bundle - Used here hg38 decoy version
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_known_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Homo_sapiens_assembly38.known_indels.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_contest_hapmap_3p3_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Biallelic/hapmap_3.3.hg38.BIALLELIC.PASS.2021-09-01.vcf.gz"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_known_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Homo_sapiens_assembly38.known_indels.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_contest_hapmap_3p3_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Biallelic/hapmap_3.3.hg38.BIALLELIC.PASS.2021-09-01.vcf.gz"

// Base resource allocation updater
// See README for adding parameters to update the base resource allocations
Expand Down
2 changes: 1 addition & 1 deletion test/test-align-DNA/test.config
Original file line number Diff line number Diff line change
Expand Up @@ -10,7 +10,7 @@ params {
enable_spark = true
mark_duplicates = true
subworkflow_cpus = 8
reference_fasta_bwa = '/hot/ref/tool-specific-input/BWA-MEM2-2.2.1/GRCh38-BI-20160721/alt-aware/genome.fa'
reference_fasta_bwa = '/hot/resource/tool-specific-input/BWA-MEM2-2.2.1/GRCh38-BI-20160721/alt-aware/genome.fa'
aligner = ['BWA-MEM2']
}

Expand Down
6 changes: 3 additions & 3 deletions test/test-calculate-targeted-coverage/test.config
Original file line number Diff line number Diff line change
Expand Up @@ -12,9 +12,9 @@ params {

calculate_targeted_coverage {
is_pipeline_enabled = true
reference_dict = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict'
reference_dbSNP = '/hot/ref/database/dbSNP-155/thinned/GRCh38/dbSNP-155_thinned_hg38.vcf.gz'
genome_sizes = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta.fai'
reference_dict = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.dict'
reference_dbSNP = '/hot/resource/database/dbSNP-155/thinned/GRCh38/dbSNP-155_thinned_hg38.vcf.gz'
genome_sizes = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta.fai'
target_bed = '/hot/software/pipeline/metapipeline-DNA/Nextflow/development/input/data/targeted-coverage/small.bed' //required
bait_bed = '' //optional, path/to/bait/bedfile
collect_metrics = true // whether or not to calculate coverage metrics
Expand Down
12 changes: 6 additions & 6 deletions test/test-call-gSNP/test.config
Original file line number Diff line number Diff line change
Expand Up @@ -11,12 +11,12 @@ params {
is_pipeline_enabled = true
subworkflow_cpus = SysHelper.getAvailCpus()
max_number_of_parallel_jobs = 2
reference_fasta = "/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/ref/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"
reference_fasta = "/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta"
bundle_mills_and_1000g_gold_standard_indels_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/Mills_and_1000G_gold_standard.indels.hg38.vcf.gz"
bundle_v0_dbsnp138_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/resources_broad_hg38_v0_Homo_sapiens_assembly38.dbsnp138.vcf.gz"
bundle_hapmap_3p3_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/hapmap_3.3.hg38.vcf.gz"
bundle_omni_1000g_2p5_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_omni2.5.hg38.vcf.gz"
bundle_phase1_1000g_snps_high_conf_vcf_gz = "/hot/resource/tool-specific-input/GATK/GRCh38/1000G_phase1.snps.high_confidence.hg38.vcf.gz"
}

arg_map = [:]
Expand Down
6 changes: 3 additions & 3 deletions test/test-call-gSV/test.config
Original file line number Diff line number Diff line change
Expand Up @@ -8,9 +8,9 @@ params {
call_gSV {
is_pipeline_enabled = true
subworkflow_cpus = 8
reference_fasta = '/hot/ref/reference/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/ref/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv'
mappability_map = '/hot/ref/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz'
reference_fasta = '/hot/resource/reference-genome/GRCh38-BI-20160721/Homo_sapiens_assembly38.fasta'
exclusion_file = '/hot/resource/tool-specific-input/Delly/GRCh38/human.hg38.excl.tsv'
mappability_map = '/hot/resource/tool-specific-input/Delly/GRCh38/Homo_sapiens.GRCh38.dna.primary_assembly.fa.r101.s501.blacklist.gz'
run_delly = false
}

Expand Down
Loading

0 comments on commit cd4d719

Please sign in to comment.