From d2335b5200757e8b429a5f20464ec04b59d1a220 Mon Sep 17 00:00:00 2001
From: Helene RIMBERT <helene.rimbert@inrae.fr>
Date: Fri, 9 Jun 2023 16:10:20 +0200
Subject: [PATCH 1/9] IMPROVE: add conda pragma into all rules and docler path
 for use with --singularity option

---
 Snakefile                               |  2 ++
 environment.yml => envs/environment.yml |  0
 rules/bedtoolsClosest.smk               |  5 +++++
 rules/checkCds.smk                      |  2 ++
 rules/geneAnchoring.smk                 | 16 +++++++++++++-
 rules/preprocessGenomes.smk             | 29 +++++++++++++++----------
 rules/preprocessISBP.smk                |  4 ++++
 7 files changed, 45 insertions(+), 13 deletions(-)
 rename environment.yml => envs/environment.yml (100%)

diff --git a/Snakefile b/Snakefile
index f84f158..bb0ca3c 100644
--- a/Snakefile
+++ b/Snakefile
@@ -1,5 +1,7 @@
 configfile: "config.yaml"
 
+container: "docker://continuumio/miniconda3:4.4.10"
+
 rule all: 
 	input:
 		config['finalPrefix']+'_HC.gff3',
diff --git a/environment.yml b/envs/environment.yml
similarity index 100%
rename from environment.yml
rename to envs/environment.yml
diff --git a/rules/bedtoolsClosest.smk b/rules/bedtoolsClosest.smk
index 87c12ba..fd41ff2 100644
--- a/rules/bedtoolsClosest.smk
+++ b/rules/bedtoolsClosest.smk
@@ -1,5 +1,6 @@
 rule selectMappedISBP:
 	message: " Select only mapped ISBPS on new refseq"
+	conda: "envs/environment.yml"
 	input: mapped=config['results']+'/1.filteredISBPs/{chrom}/sorted.bed',
 		 original=config['isbpBed']
 	output: config['results']+'/2.mappedISBPs/{chrom}/coordsOnQuery.bed'
@@ -12,6 +13,7 @@ rule selectMappedISBP:
 
 rule keepMappedOnSameChrom:
 	message: " Select Mapped ISBPs on same chromosome (or on unknown chromosome)"
+	conda: "envs/environment.yml"
 	input: isbpOnQuery=config['results']+'/2.mappedISBPs/{chrom}/coordsOnQuery.bed', 
 		isbpOnTarget=config['results']+'/1.filteredISBPs/{chrom}/sorted.bed',
 	output: config['results']+'/2.mappedISBPs/{chrom}/OnSameChrom.bed'
@@ -23,6 +25,7 @@ rule keepMappedOnSameChrom:
 
 rule upstreamClosest:
 	message: " Collect closest marker upstream of genes"
+	conda: "envs/environment.yml"
 	input: annot=config['results']+"/1.features/{chrom}.bed", 
 		markers=config['results']+'/2.mappedISBPs/{chrom}/OnSameChrom.bed'
 	output: config['results']+'/2.closestbed/{chrom}/upstream.txt'
@@ -34,6 +37,7 @@ rule upstreamClosest:
 
 rule downstreamClosest:
 	message: " Collect Downstream marker downstream of genes"
+	conda: "envs/environment.yml"
 	input: annot=config['results']+"/1.features/{chrom}.bed", 
 			markers=config['results']+'/2.mappedISBPs/{chrom}/OnSameChrom.bed'
 	output: config['results']+'/2.closestbed/{chrom}/downstream.txt'
@@ -45,6 +49,7 @@ rule downstreamClosest:
 
 # rule splitPerChrom:
 # 	message: "Split data per chromosome"
+	conda: "envs/environment.yml"
 # 	input: 
 # 		upstream=config['results']+'/2.closestbed/{chrom}/upstream.txt',
 # 		downstream=config['results']+'/2.closestbed/{chrom}/downstream.txt'
diff --git a/rules/checkCds.smk b/rules/checkCds.smk
index cd57e43..b45b60d 100644
--- a/rules/checkCds.smk
+++ b/rules/checkCds.smk
@@ -1,5 +1,6 @@
 rule validateCdsHC:
 	message: " check CDS integrity for HC genes"
+	conda: "envs/environment.yml"
 	input: config['finalPrefix']+'_HC.cds.fasta'
 	output: fasta=config['finalPrefix']+'_HC.cds.valid.fasta',
 		csv=config['finalPrefix']+'_HC.cds.valid.explained.txt'
@@ -10,6 +11,7 @@ rule validateCdsHC:
 
 rule validateCdsLC:
 	message: " check CDS integrity for LC genes"
+	conda: "envs/environment.yml"
 	input: config['finalPrefix']+'_LC.cds.fasta'
 	output: fasta=config['finalPrefix']+'_LC.cds.valid.fasta',
 		csv=config['finalPrefix']+'_LC.cds.valid.explained.txt'
diff --git a/rules/geneAnchoring.smk b/rules/geneAnchoring.smk
index fdc4db3..73a20e3 100644
--- a/rules/geneAnchoring.smk
+++ b/rules/geneAnchoring.smk
@@ -1,5 +1,6 @@
 rule mapHomologousRegions:
 	message: " mapping homologous regions of both references using ISBPs markers as anchors for chromosome {wildcards.chrom}"
+	conda: "envs/environment.yml"
 	input:
 		#closestMarkers=config['results']+'/2.mergedClosestMarkers.txt',
 		marker5prime=config['results']+'/2.closestbed/{chrom}/upstream.txt',
@@ -22,6 +23,7 @@ rule mapHomologousRegions:
 
 rule recalcBlatMapped:
 	message: " Recalc the coordinates of genes mapped with the Blat pipeline for chromosome {wildcards.chrom}"
+	conda: "envs/environment.yml"
 	input:
 		allBlat=config['results']+'/3.mapping/{chrom}/allBlat.csv',
 		summary=config['results']+'/3.mapping/{chrom}/mappingSummary.csv',
@@ -41,6 +43,7 @@ rule recalcBlatMapped:
 
 rule gtCleanBlatGff:
 	message: " Clean the gff file recalculated based on Blat fine mapping for chromosome {wildcards.chrom}"
+	conda: "envs/environment.yml"
 	input: gff=config['results']+'/4.recalcBlat/{chrom}/RecalcAnnotOnTarget.gff3',
 		mapping=config['results']+'/3.mapping/{chrom}/temp'
 	output: config['results']+'/4.recalcBlat/{chrom}/RecalcAnnotOnTarget-clean.gff3'
@@ -52,6 +55,7 @@ rule gtCleanBlatGff:
 
 rule gmapRescue:
 	message: " Rescue anchoring of failed genes with gmap for chrom {wildcards.chrom}"
+	conda: "envs/environment.yml"
 	input: blat=config['results']+'/3.mapping/{chrom}/allBlat.csv',
 		wholeGenomeFasta=config['targetFasta'],
 		mapping=config['results']+'/3.mapping/{chrom}/temp'
@@ -71,6 +75,7 @@ rule gmapRescue:
 
 rule recalcGmapRescue:
 	message: "Recalc the coordinates of the GMAP on target GFF3 files for chromosome {wildcards.chrom}"
+	conda: "envs/environment.yml"
 	input: gff=config['results']+'/4.gmapRescue/{chrom}.target.gff3',
 		mapping=config['results']+'/3.mapping/{chrom}/temp'
 	output: config['results']+'/4.recalcGmap/{chrom}/recalc.gff3'
@@ -84,6 +89,7 @@ rule recalcGmapRescue:
 
 rule saveGmapWG:
 	message: "Save the GMAP results of genes mapped on Whole Genome"
+	conda: "envs/environment.yml"
 	input: gff=config['results']+'/4.gmapRescue/{chrom}.wholeGenome.gff3',
 		map=config['chromMapID'],
 		mapping=config['results']+'/3.mapping/{chrom}/temp'
@@ -99,6 +105,7 @@ rule saveGmapWG:
 
 rule mergeFinalGff3:
 	message: " Merge Final GFF3 files: blat.gff3, rescue.gff3 and wholeGenome.gff3"
+	conda: "envs/environment.yml"
 	input: blat=config['results']+'/4.recalcBlat/{chrom}/RecalcAnnotOnTarget-clean.gff3',
 		rescue=config['results']+'/4.recalcGmap/{chrom}/recalc.gff3',
 		wg=config['results']+'/4.gmapWholeGenome/{chrom}.wholeGenome.gff3',
@@ -110,7 +117,8 @@ rule mergeFinalGff3:
 		gt gff3 -sort -fixregionboundaries -tidy -retainids {input.blat} {input.rescue} {input.wg} 1> {output.annot} 2> {log.annot}
 		"""
 rule checkMissing:
-	message: ""
+	message: " Check missing transfered genes"
+	conda: "envs/environment.yml"
 	input: gff=config['results']+'/5.FINAL/{chrom}/annotation.gff3',
 		ref=config['results']+"/1.features/{chrom}.bed"
 	output: config['results']+'/5.FINAL/{chrom}/missing.txt'
@@ -122,6 +130,7 @@ rule checkMissing:
 
 rule concatAllChromResults:
 	message: " concat all per chromosome results"
+	conda: "envs/environment.yml"
 	input: annot=expand(config['results']+'/5.FINAL/{chrom}/annotation.gff3',chrom=config['chromosomes']),
 		differentChrom=expand(config['results']+'/4.gmapWholeGenome/{chrom}.wholeGenome_differentChrom.txt',chrom=config['chromosomes']),
 		missing=expand(config['results']+'/5.FINAL/{chrom}/missing.txt', chrom=config['chromosomes']),
@@ -139,6 +148,7 @@ rule concatAllChromResults:
 
 rule renameGeneIds:
 	message: " set final gene IDs for the new annotation"
+	conda: "envs/environment.yml"
 	input: gff=config['finalPrefix']+'tmp.gff3',
 		map=config['chromMapID']
 	output: gffhc=config['finalPrefix']+'_HC.gff3',
@@ -154,6 +164,7 @@ rule renameGeneIds:
 
 rule generateFastaSequencesHC:
 	message: "generate fasta sequences using gffread for HC genes"
+	conda: "envs/environment.yml"
 	input: gff=config['finalPrefix']+'_HC.gff3',
 		fastaref=config['targetFasta']
 	output: mrna=config['finalPrefix']+'_HC.transcripts.fasta',
@@ -166,6 +177,7 @@ rule generateFastaSequencesHC:
 		"""
 rule generateFastaSequencesLC:
 	message: "generate fasta sequences using gffread for LC genes"
+	conda: "envs/environment.yml"
 	input:
 		gff=config['finalPrefix']+'_LC.gff3',
 		fastaref=config['targetFasta']
@@ -180,6 +192,7 @@ rule generateFastaSequencesLC:
 
 rule concatblatSummary:
 	message: " Concat all Blat summary"
+	conda: "envs/environment.yml"
 	input:blat=expand(config['results']+'/3.mapping/{chrom}/allBlat.csv', chrom=config['chromosomes']),
 		mapping=expand(config['results']+'/3.mapping/{chrom}/temp', chrom=config['chromosomes'])
 	output: config['finalPrefix']+'_blatSummary.csv'
@@ -190,6 +203,7 @@ rule concatblatSummary:
 
 rule concatAnchoringSummary:
 	message: " Concat all Anchoring summary"
+	conda: "envs/environment.yml"
 	input:anchoring=expand(config['results']+'/3.mapping/{chrom}/mappingSummary.csv', chrom=config['chromosomes']),
 		mapping=expand(config['results']+'/3.mapping/{chrom}/temp', chrom=config['chromosomes'])
 	output: config['finalPrefix']+'_anchoringSummary.csv'
diff --git a/rules/preprocessGenomes.smk b/rules/preprocessGenomes.smk
index 3e21db8..f966cef 100644
--- a/rules/preprocessGenomes.smk
+++ b/rules/preprocessGenomes.smk
@@ -1,33 +1,38 @@
 rule grepGffFeature:
-        message: " Collect selected features from GFF file"
-        input: config['annotationQuery']
-        params: config['featureType']
-        output: temp(config['results']+"/1.features.bed")
-        log: config['results']+"/1.grepGffFeature.log"
-        shell: "bin/gff2bed.sh {params} {input} 1> {output} 2> {log}"
+    message: " Collect selected features from GFF file"
+	conda: "envs/environment.yml"
+    input: config['annotationQuery']
+    params: config['featureType']
+    output: temp(config['results']+"/1.features.bed")
+    log: config['results']+"/1.grepGffFeature.log"
+    shell: "bin/gff2bed.sh {params} {input} 1> {output} 2> {log}"
 
 rule splitGffPerChrom:
-        message: "Split Gff Features per chromosome: current is {wildcards.chrom}"
-        input: config['results']+"/1.features.bed"
-        output: temp(config['results']+"/1.features/{chrom}.bed")
-        log: config['results']+"/1.features/{chrom}.fgrep.log"
-        params: "chr{chrom}"
-        shell:  "fgrep -i {params} {input} 1> {output} 2> {log}"
+    message: "Split Gff Features per chromosome: current is {wildcards.chrom}"
+	conda: "envs/environment.yml"
+    input: config['results']+"/1.features.bed"
+    output: temp(config['results']+"/1.features/{chrom}.bed")
+    log: config['results']+"/1.features/{chrom}.fgrep.log"
+    params: "chr{chrom}"
+    shell:  "fgrep -i {params} {input} 1> {output} 2> {log}"
 
 rule indexQuery:
 	message: " Indexing Query fasta file using samtools faidx"
+	conda: "envs/environment.yml"
 	input: config['queryFasta']
 	output: config['queryFasta']+'.fai'
 	shell: "samtools faidx {input}"
 
 rule indexTarget:
 	message: " Indexing Target fasta file using samtools faidx"
+	conda: "envs/environment.yml"
 	input: config['targetFasta']
 	output: config['targetFasta']+'.fai'
 	shell: "samtools faidx {input}"
 
 rule gmapIndexTarget:
 	message: " Create Gmap Index for rescue"
+	conda: "envs/environment.yml"
 	input: config['targetFasta']
 	output: directory(config['results']+"/target_gmapindex")
 	params: indexname="target_gmapindex", indexPath=config['results']
diff --git a/rules/preprocessISBP.smk b/rules/preprocessISBP.smk
index 455ee4d..ac1b4f0 100644
--- a/rules/preprocessISBP.smk
+++ b/rules/preprocessISBP.smk
@@ -1,5 +1,6 @@
 rule filterBam:
 	message: "Filtering BAM file of ISBPs"
+	conda: "envs/environment.yml"
 	input: config['isbpBam']
 	output: config['results']+'/1.filteredISBPs.bam'
 	params: mapq=config['mapq'], mismatches=config['mismatches']
@@ -8,6 +9,7 @@ rule filterBam:
 
 rule bam2bed:
 	message: "Convert Filtered BAM file into BED"
+	conda: "envs/environment.yml"
 	input: config['results']+"/1.filteredISBPs.bam"
 	output: config['results']+"/1.filteredISBPs/{chrom}/sorted.bed"
 	log: config['results']+"/1.filteredISBPs/{chrom}/sorted.log"
@@ -17,12 +19,14 @@ rule bam2bed:
 
 #rule dumpISBPsID:
 #	message: "Dump ISBPs IDs"
+	conda: "envs/environment.yml"
 #	input: config['results']+"/1.filteredISBPs.bed"
 #	output: config['results']+"/1.filteredISBPs.ids"
 #	shell: " cut -f 4 {input} > {output}"
 
 #rule splitISBP:
 #	message: "Split isbps per chromosome"
+	conda: "envs/environment.yml"
 #	input: config['results']+"/1.filteredISBPs.bed"
 #	output: config['results']+"/1.filteredISBPs/{chrom}/sorted.bed"
 #	log: config['results']+"/1.filteredISBPs/{chrom}/sorted.log"
-- 
GitLab


From de255dfd20043fd5caa06bc62a5deffd6d6dd254 Mon Sep 17 00:00:00 2001
From: Matthaus Sirvent <matthaus.sirvent@inrae.fr>
Date: Fri, 9 Jun 2023 16:25:23 +0200
Subject: [PATCH 2/9] UPDATE: typo in rules.smk - remove conda lines in
 commented tasks

---
 rules/bedtoolsClosest.smk   | 1 -
 rules/preprocessGenomes.smk | 4 ++--
 rules/preprocessISBP.smk    | 4 ++--
 3 files changed, 4 insertions(+), 5 deletions(-)

diff --git a/rules/bedtoolsClosest.smk b/rules/bedtoolsClosest.smk
index fd41ff2..9b56af2 100644
--- a/rules/bedtoolsClosest.smk
+++ b/rules/bedtoolsClosest.smk
@@ -49,7 +49,6 @@ rule downstreamClosest:
 
 # rule splitPerChrom:
 # 	message: "Split data per chromosome"
-	conda: "envs/environment.yml"
 # 	input: 
 # 		upstream=config['results']+'/2.closestbed/{chrom}/upstream.txt',
 # 		downstream=config['results']+'/2.closestbed/{chrom}/downstream.txt'
diff --git a/rules/preprocessGenomes.smk b/rules/preprocessGenomes.smk
index f966cef..0c02209 100644
--- a/rules/preprocessGenomes.smk
+++ b/rules/preprocessGenomes.smk
@@ -1,6 +1,6 @@
 rule grepGffFeature:
     message: " Collect selected features from GFF file"
-	conda: "envs/environment.yml"
+    conda: "envs/environment.yml"
     input: config['annotationQuery']
     params: config['featureType']
     output: temp(config['results']+"/1.features.bed")
@@ -9,7 +9,7 @@ rule grepGffFeature:
 
 rule splitGffPerChrom:
     message: "Split Gff Features per chromosome: current is {wildcards.chrom}"
-	conda: "envs/environment.yml"
+    conda: "envs/environment.yml"
     input: config['results']+"/1.features.bed"
     output: temp(config['results']+"/1.features/{chrom}.bed")
     log: config['results']+"/1.features/{chrom}.fgrep.log"
diff --git a/rules/preprocessISBP.smk b/rules/preprocessISBP.smk
index ac1b4f0..5eba2d3 100644
--- a/rules/preprocessISBP.smk
+++ b/rules/preprocessISBP.smk
@@ -19,14 +19,14 @@ rule bam2bed:
 
 #rule dumpISBPsID:
 #	message: "Dump ISBPs IDs"
-	conda: "envs/environment.yml"
+#	conda: "envs/environment.yml"
 #	input: config['results']+"/1.filteredISBPs.bed"
 #	output: config['results']+"/1.filteredISBPs.ids"
 #	shell: " cut -f 4 {input} > {output}"
 
 #rule splitISBP:
 #	message: "Split isbps per chromosome"
-	conda: "envs/environment.yml"
+#	conda: "envs/environment.yml"
 #	input: config['results']+"/1.filteredISBPs.bed"
 #	output: config['results']+"/1.filteredISBPs/{chrom}/sorted.bed"
 #	log: config['results']+"/1.filteredISBPs/{chrom}/sorted.log"
-- 
GitLab


From d60479d5360dcaeb9f367c8d02ca3a6896660b61 Mon Sep 17 00:00:00 2001
From: Matthaus Sirvent <matthaus.sirvent@inrae.fr>
Date: Fri, 9 Jun 2023 16:58:34 +0200
Subject: [PATCH 3/9] IMPROVE: remove 'Chr' strings in grep commands

---
 .gitignore                  |  2 +-
 config.yaml                 | 24 ++++++++++++------------
 rules/envs                  |  1 +
 rules/preprocessGenomes.smk |  2 +-
 rules/preprocessISBP.smk    |  2 +-
 5 files changed, 16 insertions(+), 15 deletions(-)
 create mode 120000 rules/envs

diff --git a/.gitignore b/.gitignore
index dab4880..478366b 100644
--- a/.gitignore
+++ b/.gitignore
@@ -5,4 +5,4 @@ resultsDEV
 .snakemake
 pipeline_v0.1.tar.gz
 run_*
-slurm-*.out
+slurm*
diff --git a/config.yaml b/config.yaml
index d90ce66..c1281e5 100644
--- a/config.yaml
+++ b/config.yaml
@@ -1,28 +1,28 @@
 ##### QUERY related files/parameters (refseqv2.1)
 # GFF annotatin to transfert
-annotationQuery: 'data/IWGSC_refseqv2.1/IWGSC_refseqv2.1_annotation.gff3'
+annotationQuery: 'data/IWGSC_refseqv2.1_annotation_200916_HC.gff3'
 # feature type used for anchoring on target genome
 featureType: 'gene'
 # FASTA of the query (used to check the sequences after the coordinates are calculated on the target genome)
-queryFasta: '/home/herimbert/gdec/shared/triticum_aestivum/chinese_spring/iwgsc/REFSEQV2/v2.1/CS_pseudo_v2.1.fa'
+queryFasta: 'data/CS_pesudo_v2.1.fa'
 # blastdb of all mrnas. used to rescue genes which have failed in the transfert using the targeted approache
-blastdb: 'data/IWGSC_refseqv2.1/IWGSC_refseqv2.1_mrna.fa'
+blastdb: 'data/IWGSC_refseqv2.1_annotation_200916_HC_mrna.fasta'
 # map of all chromosome ids --> NEED TO BE UPDATED in another version WITH ONE ARRAY FOR THE QUERY AND ONE ARRAY FOR THE TARGET GENOME ASSEMBLY
 chromosomes: ['1A', '2A', '3A', '4A', '5A', '6A', '7A', '1B', '2B', '3B', '4B', '5B', '6B', '7B', '1D', '2D', '3D', '4D', '5D', '6D', '7D']
-refChrom: ['chr1A', 'chr1B', 'chr1D', 'chr2A', 'chr2B', 'chr2D', 'chr3A', 'chr3B', 'chr3D', 'chr4A', 'chr4B', 'chr4D', 'chr5A', 'chr5B', 'chr5D', 'chr6A', 'chr6B', 'chr6D', 'chr7A', 'chr7B', 'chr7D', 'chrUn']
+refChrom: ['Chr1A', 'Chr1B', 'Chr1D', 'Chr2A', 'Chr2B', 'Chr2D', 'Chr3A', 'Chr3B', 'Chr3D', 'Chr4A', 'Chr4B', 'Chr4D', 'Chr5A', 'Chr5B', 'Chr5D', 'Chr6A', 'Chr6B', 'Chr6D', 'Chr7A', 'Chr7B', 'Chr7D', 'ChrUn']
 
 ##### Transfert mode
 # transfert all isoforms (all) or only the '.1' (first)
 transferType: 'first'
 
-##### TARGET related files/parameters (julius)
-targetFasta: 'data/Renan_pseudo.fasta'
+##### TARGET related files/parameters
+targetFasta: 'data/Triticum_aestivum_arinalrfor.PGSBv2.1.dna.toplevel.fa'
 
 ##### ISBP/markers related config and parameters
-# BAM file of markers/ISBPs mapped on the target genome (Julius)
-isbpBam: 'data/Renan_isbps.bam'
+# BAM file of markers/ISBPs mapped on the target genome
+isbpBam: '/home/masirvent/wheat10plus-pangenome/data/mappingISBP/session2/arina/arina_CS_ISBP.bam'
 # BED file of coordinates on the query genome (REFSEQ v2.1)
-isbpBed: 'data/IWGSC_refseqv2.1/IWGSC_refseqv2.1_isbp.bed'
+isbpBed: 'data/Tae.Chinese_Spring.refSeqv2.1.ISBPs.bed'
 # minimum mapping quality of markers on the target genome
 mapq: 30
 # max mismatches per ISBP/marker
@@ -30,13 +30,13 @@ mismatches: 2
 
 ##### OUTPUT directory
 results: 'results'
-finalPrefix: 'TaeRenan_magatt_2109'
+finalPrefix: 'arina_magatt'
 # this file contains two columns: the first is the chromosome name as it appears in the genome.fasta of the new reference,
 # and the second the chromosome name as it will appear in the new gene Names
-chromMapID: 'data/chromosomeMappingID.csv'
+chromMapID: '/home/masirvent/wheat10plus-pangenome/data/liftoff/arina/chromstab.txt'
 
 ##### Nomenclature for final gene IDs
 # used in rule renameGeneIds (rules/geneAnchoring.smk)
-gff_prefix: 'TraesRN'
+gff_prefix: 'TraesAR'
 gff_version: '01G'
 gff_source: 'MAGATT-IWGSCCSv2.1'
diff --git a/rules/envs b/rules/envs
new file mode 120000
index 0000000..2e543f2
--- /dev/null
+++ b/rules/envs
@@ -0,0 +1 @@
+../envs
\ No newline at end of file
diff --git a/rules/preprocessGenomes.smk b/rules/preprocessGenomes.smk
index 0c02209..3d1de9e 100644
--- a/rules/preprocessGenomes.smk
+++ b/rules/preprocessGenomes.smk
@@ -13,7 +13,7 @@ rule splitGffPerChrom:
     input: config['results']+"/1.features.bed"
     output: temp(config['results']+"/1.features/{chrom}.bed")
     log: config['results']+"/1.features/{chrom}.fgrep.log"
-    params: "chr{chrom}"
+    params: "{chrom}"
     shell:  "fgrep -i {params} {input} 1> {output} 2> {log}"
 
 rule indexQuery:
diff --git a/rules/preprocessISBP.smk b/rules/preprocessISBP.smk
index 5eba2d3..45fa89e 100644
--- a/rules/preprocessISBP.smk
+++ b/rules/preprocessISBP.smk
@@ -13,7 +13,7 @@ rule bam2bed:
 	input: config['results']+"/1.filteredISBPs.bam"
 	output: config['results']+"/1.filteredISBPs/{chrom}/sorted.bed"
 	log: config['results']+"/1.filteredISBPs/{chrom}/sorted.log"
-        params: 'Chr{chrom}'
+        params: '{chrom}'
 	shell: "bamToBed -i {input} |fgrep -i {params}|cut -d ':' -f 1|sort -k1,1 -k2,2n  1> {output} 2> {log}"
 
 
-- 
GitLab


From 1553a64b4b6264af21cb0cc0d0cc47115345614d Mon Sep 17 00:00:00 2001
From: Matthaus Sirvent <matthaus.sirvent@inrae.fr>
Date: Wed, 21 Jun 2023 10:11:34 +0200
Subject: [PATCH 4/9] BUG: change keys in mappingChrom dict with target
 chromosome IDs instead of reference IDs

---
 bin/renameGffID.py | 9 ++++++---
 1 file changed, 6 insertions(+), 3 deletions(-)

diff --git a/bin/renameGffID.py b/bin/renameGffID.py
index 0b7ee73..22184bf 100755
--- a/bin/renameGffID.py
+++ b/bin/renameGffID.py
@@ -289,9 +289,12 @@ class renameIDs (object):
 			for line in maprecord.readlines():
 				if not line.startswith('#'):
 					(name, id) = line.rstrip('\n').split('\t')
-					self.chromosomeMap[name] = id
-					self.geneMapCoord[name] = defaultdict()
-					self.newGeneMapCoord[name] = defaultdict()
+					#self.chromosomeMap[name] = id
+					#self.geneMapCoord[name] = defaultdict()
+					#self.newGeneMapCoord[name] = defaultdict()
+					self.chromosomeMap[id] = name
+					self.geneMapCoord[id] = defaultdict()
+					self.newGeneMapCoord[id] = defaultdict()
 		sys.stdout.write(' found {} chromosome records in file {}\n'.format(len(self.chromosomeMap.keys()),self.options.map ))
 		pprint(self.chromosomeMap)
 
-- 
GitLab


From 5b2c2706555a4ff047c4678e258843c31d6f4940 Mon Sep 17 00:00:00 2001
From: Helene RIMBERT <helene.rimbert@inrae.fr>
Date: Thu, 29 Jun 2023 15:31:50 +0200
Subject: [PATCH 5/9] IMPROVE: initialise chromosomeMap dict while reading
 input GFF

---
 bin/renameGffID.py | 13 +++++++++----
 1 file changed, 9 insertions(+), 4 deletions(-)

diff --git a/bin/renameGffID.py b/bin/renameGffID.py
index 22184bf..e80826a 100755
--- a/bin/renameGffID.py
+++ b/bin/renameGffID.py
@@ -24,7 +24,7 @@ class renameIDs (object):
 		self.checkInputs()
 
 		# load inputs
-		self.loadChromosomeMap()
+		#self.loadChromosomeMap()
 
 		# open filehandler for output files
 		self.prepareOutputFiles()
@@ -251,6 +251,14 @@ class renameIDs (object):
 					coord=line.rstrip('\n').split('\t')[3]
 					stop=line.rstrip('\n').split('\t')[4]
 					geneId=self.getFeatureAttribute(gff=line, attribute='ID')
+
+
+					# check if this chromosome is in the mapping dictionaries
+					if (chrom not in self.chromosomeMap.keys()):
+						self.chromosomeMap[chrom] = chrom
+						self.geneMapCoord[chrom] = defaultdict()
+						self.newGeneMapCoord[chrom] = defaultdict()
+						
 					if featureType == 'gene':
 						while coord in self.geneMapCoord[chrom].keys():
 							sys.stderr.write(" WARNING: gene {} has same coordinate as gene {} \n".format(geneId, self.geneMapCoord[chrom][coord]))
@@ -289,9 +297,6 @@ class renameIDs (object):
 			for line in maprecord.readlines():
 				if not line.startswith('#'):
 					(name, id) = line.rstrip('\n').split('\t')
-					#self.chromosomeMap[name] = id
-					#self.geneMapCoord[name] = defaultdict()
-					#self.newGeneMapCoord[name] = defaultdict()
 					self.chromosomeMap[id] = name
 					self.geneMapCoord[id] = defaultdict()
 					self.newGeneMapCoord[id] = defaultdict()
-- 
GitLab


From 50257cadc3d52b5475585eb4ca23a1cc813f448e Mon Sep 17 00:00:00 2001
From: Helene RIMBERT <helene.rimbert@inrae.fr>
Date: Mon, 3 Jul 2023 17:50:10 +0200
Subject: [PATCH 6/9] IMPROVE: gmapl rescue run at the end of each chomosome
 batch rather than for every gene

---
 bin/gmapRescue.sh | 28 +++++++++++++++++++---------
 1 file changed, 19 insertions(+), 9 deletions(-)

diff --git a/bin/gmapRescue.sh b/bin/gmapRescue.sh
index 308ce18..8e9422e 100755
--- a/bin/gmapRescue.sh
+++ b/bin/gmapRescue.sh
@@ -5,10 +5,14 @@ blastdb=$2
 gmapdb=$3
 gmapdbdir=$4
 outputRescueGff=$5
-outputRescueWholeGenomeGff=$6
 wholegenomeFasta=$7
 mode=$8
 
+# files for unanchored genes: will be mapped with gmapl on whole genome
+unmappedMrnaFasta=$inputDir'/missing.fasta'
+outputRescueWholeGenomeGff=$6
+
+
 querylist=($(find  $inputDir  -type f -name 'query.fasta'))
 targetlist=($(find $inputDir -type f -name 'target.fasta'))
 
@@ -47,11 +51,13 @@ do
 	if [ -f "$rootdir/UNMAPPED" ]
 	then
 		echo " Gene $geneid has status UNMAPPED: mapping on the whole genome"
-		targetindex=$gmapdb
-		targetindexdir=$gmapdbdir
-		targetgff=$rootdir'/gmap.wholeGenome.gff3'
-		gmapexe='gmapl'
-		eval $gmapexe --min-identity 0.80 --min-trimmed-coverage 0.50 --ordered -n 1 -d $targetindex -D $targetindexdir -f 2 $rootdir'/query.mrna.fasta' 1> $targetgff 2> $rootdir'/gmap.wg.log' && rm $rootdir'/query.mrna.fasta'
+
+		cat $rootdir'/query.mrna.fasta' >> $unmappedMrnaFasta && rm $rootdir'/query.mrna.fasta'
+		#targetindex=$gmapdb
+		#targetindexdir=$gmapdbdir
+		#targetgff=$rootdir'/gmap.wholeGenome.gff3'
+		#gmapexe='gmapl'
+		#eval $gmapexe --min-identity 0.80 --min-trimmed-coverage 0.50 --ordered -n 1 -d $targetindex -D $targetindexdir -f 2 $rootdir'/query.mrna.fasta' 1> $targetgff 2> $rootdir'/gmap.wg.log' && rm $rootdir'/query.mrna.fasta'
 	else
 		echo "running gmap on target"
 		eval gmap --ordered --min-identity 0.80 --min-trimmed-coverage 0.50 -n 1 -g $rootdir'/target.fasta' -f 2 $rootdir'/query.mrna.fasta' 1> $targetgff 2> $rootdir'/gmap.target.log' && rm $rootdir'/query.mrna.fasta'
@@ -98,8 +104,12 @@ gffList=($(find $inputDir -type f -name "gmap.target.gff3" ))
 gt gff3 -sort -tidy -retainids "${gffList[@]}" 1> $outputRescueGff 2> $outputRescueGff.log
 
 # for genes mapped on whole genome
-echo "Now concat all GFF of gmap on whole genome"
-gffList=($(find $inputDir -type f -name "gmap.wholeGenome.gff3" ))
-gt gff3 -sort -tidy -retainids "${gffList[@]}" 1> $outputRescueWholeGenomeGff 2> $outputRescueWholeGenomeGff.log
+echo "Now map missing/unanchored genes with GMAPL on whole genome"
+cmd="gmapl --min-identity 0.80 --min-trimmed-coverage 0.50 --ordered -n 1 -d $gmapdb -D $gmapdbdir -f 2 $unmappedMrnaFasta 1> $inputDir'/gmap.wholeGenome.gff3' 2> $inputDir'/gmap.wg.log' && rm $unmappedMrnaFasta"
+eval $cmd
+echo "Now sort and tidy all GFF of gmap on whole genome"
+#gffList=($(find $inputDir -type f -name "gmap.wholeGenome.gff3" ))
+#gt gff3 -sort -tidy -retainids "${gffList[@]}" 1> $outputRescueWholeGenomeGff 2> $outputRescueWholeGenomeGff.log
+gt gff3 -sort -tidy -retainids $inputDir'/gmap.wholeGenome.gff3' 1> $outputRescueWholeGenomeGff 2> $outputRescueWholeGenomeGff.log
 
 echo "ENDED AT `date`"
-- 
GitLab


From fde7ff34faa5f51ecfac1f8c8832a9ace6e40267 Mon Sep 17 00:00:00 2001
From: Helene Rimbert <helene.rimbert@inra.fr>
Date: Wed, 5 Jul 2023 15:03:10 +0200
Subject: [PATCH 7/9] IMPROVE: refactor GMAP index management with parameters
 in config.yaml

---
 config.yaml                 |  5 +++++
 rules/geneAnchoring.smk     |  6 ++++--
 rules/preprocessGenomes.smk | 16 ++++++++--------
 3 files changed, 17 insertions(+), 10 deletions(-)

diff --git a/config.yaml b/config.yaml
index c1281e5..3aa0624 100644
--- a/config.yaml
+++ b/config.yaml
@@ -16,7 +16,12 @@ refChrom: ['Chr1A', 'Chr1B', 'Chr1D', 'Chr2A', 'Chr2B', 'Chr2D', 'Chr3A', 'Chr3B
 transferType: 'first'
 
 ##### TARGET related files/parameters
+# FASTA of the target genome
 targetFasta: 'data/Triticum_aestivum_arinalrfor.PGSBv2.1.dna.toplevel.fa'
+#GMAP index of the genome for -d option
+targetGmapIndex: 'ensembl_Triticum_aestivum_julius_2022-9-16'
+#GMAP index: path to the gmapindex directory, for -D option
+targetGmapIndexPath: '/home/herimbert/gdec/shared/triticum_aestivum/julius/current/gmapdb/all/'
 
 ##### ISBP/markers related config and parameters
 # BAM file of markers/ISBPs mapped on the target genome
diff --git a/rules/geneAnchoring.smk b/rules/geneAnchoring.smk
index 73a20e3..acdb7a3 100644
--- a/rules/geneAnchoring.smk
+++ b/rules/geneAnchoring.smk
@@ -64,8 +64,10 @@ rule gmapRescue:
 		wholegenomegff=config['results']+'/4.gmapRescue/{chrom}.wholeGenome.gff3'
 	params: blastdb=config['blastdb'], 
 		anchoringDir=config['results']+'/3.mapping/{chrom}/', 
-		gmapIndexDir=config['results'], 
-		gmapindex="target_gmapindex", 
+		#gmapIndexDir=config['results'], 
+		#gmapindex="target_gmapindex",
+		gmapIndexDir=config['targetGmapIndexPath'], 
+		gmapindex=config['targetGmapIndex'], 
 		mode=config['transferType']
 	log: config['results']+'/4.gmapRescue/{chrom}.log'
 	shell:
diff --git a/rules/preprocessGenomes.smk b/rules/preprocessGenomes.smk
index 3d1de9e..d9926d2 100644
--- a/rules/preprocessGenomes.smk
+++ b/rules/preprocessGenomes.smk
@@ -30,11 +30,11 @@ rule indexTarget:
 	output: config['targetFasta']+'.fai'
 	shell: "samtools faidx {input}"
 
-rule gmapIndexTarget:
-	message: " Create Gmap Index for rescue"
-	conda: "envs/environment.yml"
-	input: config['targetFasta']
-	output: directory(config['results']+"/target_gmapindex")
-	params: indexname="target_gmapindex", indexPath=config['results']
-	log: config['results']+"/target_gmapindex.log"
-	shell: "gmap_build -D {params.indexPath} -d {params.indexname} {input} &> {log}"
+#rule gmapIndexTarget:
+#	message: " Create Gmap Index for rescue"
+#	conda: "envs/environment.yml"
+#	input: config['targetFasta']
+#	output: directory(config['results']+"/target_gmapindex")
+#	params: indexname="target_gmapindex", indexPath=config['results']
+#	log: config['results']+"/target_gmapindex.log"
+#	shell: "gmap_build -D {params.indexPath} -d {params.indexname} {input} &> {log}"
-- 
GitLab


From 9c972d27e65dcd18b8d1f21d9b451668af9b92cb Mon Sep 17 00:00:00 2001
From: Helene Rimbert <helene.rimbert@inra.fr>
Date: Wed, 5 Jul 2023 15:30:26 +0200
Subject: [PATCH 8/9] IMPROVE: create rulegraph and full DAG in dot format

---
 README.md            |    4 +-
 Snakefile            |   10 +-
 report/dag.dot       | 1083 +++++++
 report/dag.svg       | 6521 ++++++++++++++++++++++++++++++++++++++++++
 report/rulegraph.dot |   83 +
 report/rulegraph.svg |  479 ++++
 6 files changed, 8173 insertions(+), 7 deletions(-)
 create mode 100644 report/dag.dot
 create mode 100644 report/dag.svg
 create mode 100644 report/rulegraph.dot
 create mode 100644 report/rulegraph.svg

diff --git a/README.md b/README.md
index fcd486e..544c532 100644
--- a/README.md
+++ b/README.md
@@ -192,11 +192,11 @@ You can generate the diagram of all the processes and dependancies of you analys
 $ snakemake --dag |dot -T png > dag.png
 ```
 This will generate a PNG file of your diagram.  
-![dag.png](report/dag.png)
+![dag.svg](report/dag.svg)
 
 If you simply want the global process of the pipeline, you may run:
 ```bash
 $ snakemake --rulegraph |dot -T png > rulegraph.png
 ```
 This will generate a PNG file of your diagram.  
-![rulegraph.png](report/rulegraph.png)
+![rulegraph.svg](report/rulegraph.svg)
diff --git a/Snakefile b/Snakefile
index bb0ca3c..194b5c8 100644
--- a/Snakefile
+++ b/Snakefile
@@ -18,16 +18,16 @@ rule all:
 		config['finalPrefix']+'_gmap_differentChrom.txt',
 		config['finalPrefix']+'_anchoringSummary.csv',
 		config['finalPrefix']+'_blatSummary.csv',
-		'report/dag.png',
-		'report/rulegraph.png'
+		'report/dag.dot',
+		'report/rulegraph.dot'
 
 rule createDiagrams:
 	message: "Create dag and rulegraph of the pipeline"
-	output: dag='report/dag.png', rulegraphe='report/rulegraph.png'
+	output: dag='report/dag.dot', rulegraph='report/rulegraph.dot'
 	shell:
 		"""
-		snakemake --dag |dot -T png > {output.dag}
-		snakemake --rulegraph |dot -T png > {output.rulegraphe}
+		snakemake --dag > {output.dag}
+		snakemake --rulegraph > {output.rulegraph}
 		"""
 
 include: "rules/preprocessISBP.smk"
diff --git a/report/dag.dot b/report/dag.dot
new file mode 100644
index 0000000..e293147
--- /dev/null
+++ b/report/dag.dot
@@ -0,0 +1,1083 @@
+digraph snakemake_dag {
+    graph[bgcolor=white, margin=0];
+    node[shape=box, style=rounded, fontname=sans,                 fontsize=10, penwidth=2];
+    edge[penwidth=2, color=grey];
+	0[label = "all", color = "0.39 0.6 0.85", style="rounded"];
+	1[label = "renameGeneIds", color = "0.16 0.6 0.85", style="rounded"];
+	2[label = "concatAllChromResults", color = "0.11 0.6 0.85", style="rounded"];
+	3[label = "generateFastaSequencesHC", color = "0.23 0.6 0.85", style="rounded"];
+	4[label = "validateCdsHC", color = "0.25 0.6 0.85", style="rounded"];
+	5[label = "generateFastaSequencesLC", color = "0.28 0.6 0.85", style="rounded"];
+	6[label = "validateCdsLC", color = "0.48 0.6 0.85", style="rounded"];
+	7[label = "concatAnchoringSummary", color = "0.18 0.6 0.85", style="rounded"];
+	8[label = "concatblatSummary", color = "0.44 0.6 0.85", style="rounded"];
+	9[label = "createDiagrams", color = "0.07 0.6 0.85", style="rounded,dashed"];
+	10[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	11[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	12[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	13[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	14[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	15[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	16[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	17[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	18[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	19[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	20[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	21[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	22[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	23[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	24[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	25[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	26[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	27[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	28[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	29[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	30[label = "mergeFinalGff3", color = "0.09 0.6 0.85", style="rounded"];
+	31[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	32[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	33[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	34[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	35[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	36[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	37[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	38[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	39[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	40[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	41[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	42[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	43[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	44[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	45[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	46[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	47[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	48[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	49[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	50[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	51[label = "saveGmapWG", color = "0.41 0.6 0.85", style="rounded"];
+	52[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	53[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	54[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	55[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	56[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	57[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	58[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	59[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	60[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	61[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	62[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	63[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	64[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	65[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	66[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	67[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	68[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	69[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	70[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	71[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	72[label = "checkMissing", color = "0.46 0.6 0.85", style="rounded"];
+	73[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	74[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	75[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	76[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	77[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	78[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	79[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	80[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	81[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	82[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	83[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	84[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	85[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	86[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	87[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	88[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	89[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	90[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	91[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	92[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	93[label = "mapHomologousRegions", color = "0.62 0.6 0.85", style="rounded"];
+	94[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	95[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	96[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	97[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	98[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	99[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	100[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	101[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	102[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	103[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	104[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	105[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	106[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	107[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	108[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	109[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	110[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	111[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	112[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	113[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	114[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	115[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	116[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	117[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	118[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	119[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	120[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	121[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	122[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	123[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	124[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	125[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	126[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	127[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	128[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	129[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	130[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	131[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	132[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	133[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	134[label = "gtCleanBlatGff", color = "0.55 0.6 0.85", style="rounded"];
+	135[label = "recalcGmapRescue", color = "0.57 0.6 0.85", style="rounded"];
+	136[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	137[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	138[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	139[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	140[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	141[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	142[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	143[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	144[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	145[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	146[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	147[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	148[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	149[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	150[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	151[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	152[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	153[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	154[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	155[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	156[label = "gmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	157[label = "splitGffPerChrom\nchrom: 1A", color = "0.21 0.6 0.85", style="rounded"];
+	158[label = "splitGffPerChrom\nchrom: 2A", color = "0.21 0.6 0.85", style="rounded"];
+	159[label = "splitGffPerChrom\nchrom: 3A", color = "0.21 0.6 0.85", style="rounded"];
+	160[label = "splitGffPerChrom\nchrom: 4A", color = "0.21 0.6 0.85", style="rounded"];
+	161[label = "splitGffPerChrom\nchrom: 5A", color = "0.21 0.6 0.85", style="rounded"];
+	162[label = "splitGffPerChrom\nchrom: 6A", color = "0.21 0.6 0.85", style="rounded"];
+	163[label = "splitGffPerChrom\nchrom: 7A", color = "0.21 0.6 0.85", style="rounded"];
+	164[label = "splitGffPerChrom\nchrom: 1B", color = "0.21 0.6 0.85", style="rounded"];
+	165[label = "splitGffPerChrom\nchrom: 2B", color = "0.21 0.6 0.85", style="rounded"];
+	166[label = "splitGffPerChrom\nchrom: 3B", color = "0.21 0.6 0.85", style="rounded"];
+	167[label = "splitGffPerChrom\nchrom: 4B", color = "0.21 0.6 0.85", style="rounded"];
+	168[label = "splitGffPerChrom\nchrom: 5B", color = "0.21 0.6 0.85", style="rounded"];
+	169[label = "splitGffPerChrom\nchrom: 6B", color = "0.21 0.6 0.85", style="rounded"];
+	170[label = "splitGffPerChrom\nchrom: 7B", color = "0.21 0.6 0.85", style="rounded"];
+	171[label = "splitGffPerChrom\nchrom: 1D", color = "0.21 0.6 0.85", style="rounded"];
+	172[label = "splitGffPerChrom\nchrom: 2D", color = "0.21 0.6 0.85", style="rounded"];
+	173[label = "splitGffPerChrom\nchrom: 3D", color = "0.21 0.6 0.85", style="rounded"];
+	174[label = "splitGffPerChrom\nchrom: 4D", color = "0.21 0.6 0.85", style="rounded"];
+	175[label = "splitGffPerChrom\nchrom: 5D", color = "0.21 0.6 0.85", style="rounded"];
+	176[label = "splitGffPerChrom\nchrom: 6D", color = "0.21 0.6 0.85", style="rounded"];
+	177[label = "splitGffPerChrom\nchrom: 7D", color = "0.21 0.6 0.85", style="rounded"];
+	178[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	179[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	180[label = "indexQuery", color = "0.64 0.6 0.85", style="rounded,dashed"];
+	181[label = "indexTarget", color = "0.30 0.6 0.85", style="rounded,dashed"];
+	182[label = "bam2bed\nchrom: 1A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	183[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	184[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	185[label = "bam2bed\nchrom: 2A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	186[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	187[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	188[label = "bam2bed\nchrom: 3A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	189[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	190[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	191[label = "bam2bed\nchrom: 4A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	192[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	193[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	194[label = "bam2bed\nchrom: 5A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	195[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	196[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	197[label = "bam2bed\nchrom: 6A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	198[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	199[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	200[label = "bam2bed\nchrom: 7A", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	201[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	202[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	203[label = "bam2bed\nchrom: 1B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	204[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	205[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	206[label = "bam2bed\nchrom: 2B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	207[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	208[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	209[label = "bam2bed\nchrom: 3B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	210[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	211[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	212[label = "bam2bed\nchrom: 4B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	213[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	214[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	215[label = "bam2bed\nchrom: 5B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	216[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	217[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	218[label = "bam2bed\nchrom: 6B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	219[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	220[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	221[label = "bam2bed\nchrom: 7B", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	222[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	223[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	224[label = "bam2bed\nchrom: 1D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	225[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	226[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	227[label = "bam2bed\nchrom: 2D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	228[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	229[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	230[label = "bam2bed\nchrom: 3D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	231[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	232[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	233[label = "bam2bed\nchrom: 4D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	234[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	235[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	236[label = "bam2bed\nchrom: 5D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	237[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	238[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	239[label = "bam2bed\nchrom: 6D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	240[label = "upstreamClosest", color = "0.32 0.6 0.85", style="rounded"];
+	241[label = "downstreamClosest", color = "0.37 0.6 0.85", style="rounded"];
+	242[label = "bam2bed\nchrom: 7D", color = "0.14 0.6 0.85", style="rounded,dashed"];
+	243[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	244[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	245[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	246[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	247[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	248[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	249[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	250[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	251[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	252[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	253[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	254[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	255[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	256[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	257[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	258[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	259[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	260[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	261[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	262[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	263[label = "recalcBlatMapped", color = "0.51 0.6 0.85", style="rounded"];
+	264[label = "grepGffFeature", color = "0.02 0.6 0.85", style="rounded"];
+	265[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	266[label = "filterBam", color = "0.60 0.6 0.85", style="rounded,dashed"];
+	267[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	268[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	269[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	270[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	271[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	272[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	273[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	274[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	275[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	276[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	277[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	278[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	279[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	280[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	281[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	282[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	283[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	284[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	285[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	286[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded,dashed"];
+	287[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	288[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	289[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	290[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	291[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	292[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	293[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	294[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	295[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	296[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	297[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	298[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	299[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	300[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	301[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	302[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	303[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	304[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	305[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	306[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	307[label = "selectMappedISBP", color = "0.34 0.6 0.85", style="rounded,dashed"];
+	1 -> 0
+	2 -> 0
+	3 -> 0
+	4 -> 0
+	5 -> 0
+	6 -> 0
+	7 -> 0
+	8 -> 0
+	9 -> 0
+	2 -> 1
+	10 -> 2
+	11 -> 2
+	12 -> 2
+	13 -> 2
+	14 -> 2
+	15 -> 2
+	16 -> 2
+	17 -> 2
+	18 -> 2
+	19 -> 2
+	20 -> 2
+	21 -> 2
+	22 -> 2
+	23 -> 2
+	24 -> 2
+	25 -> 2
+	26 -> 2
+	27 -> 2
+	28 -> 2
+	29 -> 2
+	30 -> 2
+	31 -> 2
+	32 -> 2
+	33 -> 2
+	34 -> 2
+	35 -> 2
+	36 -> 2
+	37 -> 2
+	38 -> 2
+	39 -> 2
+	40 -> 2
+	41 -> 2
+	42 -> 2
+	43 -> 2
+	44 -> 2
+	45 -> 2
+	46 -> 2
+	47 -> 2
+	48 -> 2
+	49 -> 2
+	50 -> 2
+	51 -> 2
+	52 -> 2
+	53 -> 2
+	54 -> 2
+	55 -> 2
+	56 -> 2
+	57 -> 2
+	58 -> 2
+	59 -> 2
+	60 -> 2
+	61 -> 2
+	62 -> 2
+	63 -> 2
+	64 -> 2
+	65 -> 2
+	66 -> 2
+	67 -> 2
+	68 -> 2
+	69 -> 2
+	70 -> 2
+	71 -> 2
+	72 -> 2
+	73 -> 2
+	74 -> 2
+	75 -> 2
+	76 -> 2
+	77 -> 2
+	78 -> 2
+	79 -> 2
+	80 -> 2
+	81 -> 2
+	82 -> 2
+	83 -> 2
+	84 -> 2
+	85 -> 2
+	86 -> 2
+	87 -> 2
+	88 -> 2
+	89 -> 2
+	90 -> 2
+	91 -> 2
+	92 -> 2
+	93 -> 2
+	1 -> 3
+	3 -> 4
+	1 -> 5
+	5 -> 6
+	73 -> 7
+	74 -> 7
+	75 -> 7
+	76 -> 7
+	77 -> 7
+	78 -> 7
+	79 -> 7
+	80 -> 7
+	81 -> 7
+	82 -> 7
+	83 -> 7
+	84 -> 7
+	85 -> 7
+	86 -> 7
+	87 -> 7
+	88 -> 7
+	89 -> 7
+	90 -> 7
+	91 -> 7
+	92 -> 7
+	93 -> 7
+	73 -> 8
+	74 -> 8
+	75 -> 8
+	76 -> 8
+	77 -> 8
+	78 -> 8
+	79 -> 8
+	80 -> 8
+	81 -> 8
+	82 -> 8
+	83 -> 8
+	84 -> 8
+	85 -> 8
+	86 -> 8
+	87 -> 8
+	88 -> 8
+	89 -> 8
+	90 -> 8
+	91 -> 8
+	92 -> 8
+	93 -> 8
+	94 -> 10
+	95 -> 10
+	31 -> 10
+	73 -> 10
+	96 -> 11
+	97 -> 11
+	32 -> 11
+	74 -> 11
+	98 -> 12
+	99 -> 12
+	33 -> 12
+	75 -> 12
+	100 -> 13
+	101 -> 13
+	34 -> 13
+	76 -> 13
+	102 -> 14
+	103 -> 14
+	35 -> 14
+	77 -> 14
+	104 -> 15
+	105 -> 15
+	36 -> 15
+	78 -> 15
+	106 -> 16
+	107 -> 16
+	37 -> 16
+	79 -> 16
+	108 -> 17
+	109 -> 17
+	38 -> 17
+	80 -> 17
+	110 -> 18
+	111 -> 18
+	39 -> 18
+	81 -> 18
+	112 -> 19
+	113 -> 19
+	40 -> 19
+	82 -> 19
+	114 -> 20
+	115 -> 20
+	41 -> 20
+	83 -> 20
+	116 -> 21
+	117 -> 21
+	42 -> 21
+	84 -> 21
+	118 -> 22
+	119 -> 22
+	43 -> 22
+	85 -> 22
+	120 -> 23
+	121 -> 23
+	44 -> 23
+	86 -> 23
+	122 -> 24
+	123 -> 24
+	45 -> 24
+	87 -> 24
+	124 -> 25
+	125 -> 25
+	46 -> 25
+	88 -> 25
+	126 -> 26
+	127 -> 26
+	47 -> 26
+	89 -> 26
+	128 -> 27
+	129 -> 27
+	48 -> 27
+	90 -> 27
+	130 -> 28
+	131 -> 28
+	49 -> 28
+	91 -> 28
+	132 -> 29
+	133 -> 29
+	50 -> 29
+	92 -> 29
+	134 -> 30
+	135 -> 30
+	51 -> 30
+	93 -> 30
+	136 -> 31
+	73 -> 31
+	137 -> 32
+	74 -> 32
+	138 -> 33
+	75 -> 33
+	139 -> 34
+	76 -> 34
+	140 -> 35
+	77 -> 35
+	141 -> 36
+	78 -> 36
+	142 -> 37
+	79 -> 37
+	143 -> 38
+	80 -> 38
+	144 -> 39
+	81 -> 39
+	145 -> 40
+	82 -> 40
+	146 -> 41
+	83 -> 41
+	147 -> 42
+	84 -> 42
+	148 -> 43
+	85 -> 43
+	149 -> 44
+	86 -> 44
+	150 -> 45
+	87 -> 45
+	151 -> 46
+	88 -> 46
+	152 -> 47
+	89 -> 47
+	153 -> 48
+	90 -> 48
+	154 -> 49
+	91 -> 49
+	155 -> 50
+	92 -> 50
+	156 -> 51
+	93 -> 51
+	10 -> 52
+	157 -> 52
+	11 -> 53
+	158 -> 53
+	12 -> 54
+	159 -> 54
+	13 -> 55
+	160 -> 55
+	14 -> 56
+	161 -> 56
+	15 -> 57
+	162 -> 57
+	16 -> 58
+	163 -> 58
+	17 -> 59
+	164 -> 59
+	18 -> 60
+	165 -> 60
+	19 -> 61
+	166 -> 61
+	20 -> 62
+	167 -> 62
+	21 -> 63
+	168 -> 63
+	22 -> 64
+	169 -> 64
+	23 -> 65
+	170 -> 65
+	24 -> 66
+	171 -> 66
+	25 -> 67
+	172 -> 67
+	26 -> 68
+	173 -> 68
+	27 -> 69
+	174 -> 69
+	28 -> 70
+	175 -> 70
+	29 -> 71
+	176 -> 71
+	30 -> 72
+	177 -> 72
+	178 -> 73
+	179 -> 73
+	180 -> 73
+	181 -> 73
+	182 -> 73
+	183 -> 74
+	184 -> 74
+	180 -> 74
+	181 -> 74
+	185 -> 74
+	186 -> 75
+	187 -> 75
+	180 -> 75
+	181 -> 75
+	188 -> 75
+	189 -> 76
+	190 -> 76
+	180 -> 76
+	181 -> 76
+	191 -> 76
+	192 -> 77
+	193 -> 77
+	180 -> 77
+	181 -> 77
+	194 -> 77
+	195 -> 78
+	196 -> 78
+	180 -> 78
+	181 -> 78
+	197 -> 78
+	198 -> 79
+	199 -> 79
+	180 -> 79
+	181 -> 79
+	200 -> 79
+	201 -> 80
+	202 -> 80
+	180 -> 80
+	181 -> 80
+	203 -> 80
+	204 -> 81
+	205 -> 81
+	180 -> 81
+	181 -> 81
+	206 -> 81
+	207 -> 82
+	208 -> 82
+	180 -> 82
+	181 -> 82
+	209 -> 82
+	210 -> 83
+	211 -> 83
+	180 -> 83
+	181 -> 83
+	212 -> 83
+	213 -> 84
+	214 -> 84
+	180 -> 84
+	181 -> 84
+	215 -> 84
+	216 -> 85
+	217 -> 85
+	180 -> 85
+	181 -> 85
+	218 -> 85
+	219 -> 86
+	220 -> 86
+	180 -> 86
+	181 -> 86
+	221 -> 86
+	222 -> 87
+	223 -> 87
+	180 -> 87
+	181 -> 87
+	224 -> 87
+	225 -> 88
+	226 -> 88
+	180 -> 88
+	181 -> 88
+	227 -> 88
+	228 -> 89
+	229 -> 89
+	180 -> 89
+	181 -> 89
+	230 -> 89
+	231 -> 90
+	232 -> 90
+	180 -> 90
+	181 -> 90
+	233 -> 90
+	234 -> 91
+	235 -> 91
+	180 -> 91
+	181 -> 91
+	236 -> 91
+	237 -> 92
+	238 -> 92
+	180 -> 92
+	181 -> 92
+	239 -> 92
+	240 -> 93
+	241 -> 93
+	180 -> 93
+	181 -> 93
+	242 -> 93
+	243 -> 94
+	73 -> 94
+	136 -> 95
+	73 -> 95
+	244 -> 96
+	74 -> 96
+	137 -> 97
+	74 -> 97
+	245 -> 98
+	75 -> 98
+	138 -> 99
+	75 -> 99
+	246 -> 100
+	76 -> 100
+	139 -> 101
+	76 -> 101
+	247 -> 102
+	77 -> 102
+	140 -> 103
+	77 -> 103
+	248 -> 104
+	78 -> 104
+	141 -> 105
+	78 -> 105
+	249 -> 106
+	79 -> 106
+	142 -> 107
+	79 -> 107
+	250 -> 108
+	80 -> 108
+	143 -> 109
+	80 -> 109
+	251 -> 110
+	81 -> 110
+	144 -> 111
+	81 -> 111
+	252 -> 112
+	82 -> 112
+	145 -> 113
+	82 -> 113
+	253 -> 114
+	83 -> 114
+	146 -> 115
+	83 -> 115
+	254 -> 116
+	84 -> 116
+	147 -> 117
+	84 -> 117
+	255 -> 118
+	85 -> 118
+	148 -> 119
+	85 -> 119
+	256 -> 120
+	86 -> 120
+	149 -> 121
+	86 -> 121
+	257 -> 122
+	87 -> 122
+	150 -> 123
+	87 -> 123
+	258 -> 124
+	88 -> 124
+	151 -> 125
+	88 -> 125
+	259 -> 126
+	89 -> 126
+	152 -> 127
+	89 -> 127
+	260 -> 128
+	90 -> 128
+	153 -> 129
+	90 -> 129
+	261 -> 130
+	91 -> 130
+	154 -> 131
+	91 -> 131
+	262 -> 132
+	92 -> 132
+	155 -> 133
+	92 -> 133
+	263 -> 134
+	93 -> 134
+	156 -> 135
+	93 -> 135
+	73 -> 136
+	74 -> 137
+	75 -> 138
+	76 -> 139
+	77 -> 140
+	78 -> 141
+	79 -> 142
+	80 -> 143
+	81 -> 144
+	82 -> 145
+	83 -> 146
+	84 -> 147
+	85 -> 148
+	86 -> 149
+	87 -> 150
+	88 -> 151
+	89 -> 152
+	90 -> 153
+	91 -> 154
+	92 -> 155
+	93 -> 156
+	264 -> 157
+	264 -> 158
+	264 -> 159
+	264 -> 160
+	264 -> 161
+	264 -> 162
+	264 -> 163
+	264 -> 164
+	264 -> 165
+	264 -> 166
+	264 -> 167
+	264 -> 168
+	264 -> 169
+	264 -> 170
+	264 -> 171
+	264 -> 172
+	264 -> 173
+	264 -> 174
+	264 -> 175
+	264 -> 176
+	264 -> 177
+	157 -> 178
+	265 -> 178
+	157 -> 179
+	265 -> 179
+	266 -> 182
+	158 -> 183
+	267 -> 183
+	158 -> 184
+	267 -> 184
+	266 -> 185
+	159 -> 186
+	268 -> 186
+	159 -> 187
+	268 -> 187
+	266 -> 188
+	160 -> 189
+	269 -> 189
+	160 -> 190
+	269 -> 190
+	266 -> 191
+	161 -> 192
+	270 -> 192
+	161 -> 193
+	270 -> 193
+	266 -> 194
+	162 -> 195
+	271 -> 195
+	162 -> 196
+	271 -> 196
+	266 -> 197
+	163 -> 198
+	272 -> 198
+	163 -> 199
+	272 -> 199
+	266 -> 200
+	164 -> 201
+	273 -> 201
+	164 -> 202
+	273 -> 202
+	266 -> 203
+	165 -> 204
+	274 -> 204
+	165 -> 205
+	274 -> 205
+	266 -> 206
+	166 -> 207
+	275 -> 207
+	166 -> 208
+	275 -> 208
+	266 -> 209
+	167 -> 210
+	276 -> 210
+	167 -> 211
+	276 -> 211
+	266 -> 212
+	168 -> 213
+	277 -> 213
+	168 -> 214
+	277 -> 214
+	266 -> 215
+	169 -> 216
+	278 -> 216
+	169 -> 217
+	278 -> 217
+	266 -> 218
+	170 -> 219
+	279 -> 219
+	170 -> 220
+	279 -> 220
+	266 -> 221
+	171 -> 222
+	280 -> 222
+	171 -> 223
+	280 -> 223
+	266 -> 224
+	172 -> 225
+	281 -> 225
+	172 -> 226
+	281 -> 226
+	266 -> 227
+	173 -> 228
+	282 -> 228
+	173 -> 229
+	282 -> 229
+	266 -> 230
+	174 -> 231
+	283 -> 231
+	174 -> 232
+	283 -> 232
+	266 -> 233
+	175 -> 234
+	284 -> 234
+	175 -> 235
+	284 -> 235
+	266 -> 236
+	176 -> 237
+	285 -> 237
+	176 -> 238
+	285 -> 238
+	266 -> 239
+	177 -> 240
+	286 -> 240
+	177 -> 241
+	286 -> 241
+	266 -> 242
+	73 -> 243
+	180 -> 243
+	181 -> 243
+	74 -> 244
+	180 -> 244
+	181 -> 244
+	75 -> 245
+	180 -> 245
+	181 -> 245
+	76 -> 246
+	180 -> 246
+	181 -> 246
+	77 -> 247
+	180 -> 247
+	181 -> 247
+	78 -> 248
+	180 -> 248
+	181 -> 248
+	79 -> 249
+	180 -> 249
+	181 -> 249
+	80 -> 250
+	180 -> 250
+	181 -> 250
+	81 -> 251
+	180 -> 251
+	181 -> 251
+	82 -> 252
+	180 -> 252
+	181 -> 252
+	83 -> 253
+	180 -> 253
+	181 -> 253
+	84 -> 254
+	180 -> 254
+	181 -> 254
+	85 -> 255
+	180 -> 255
+	181 -> 255
+	86 -> 256
+	180 -> 256
+	181 -> 256
+	87 -> 257
+	180 -> 257
+	181 -> 257
+	88 -> 258
+	180 -> 258
+	181 -> 258
+	89 -> 259
+	180 -> 259
+	181 -> 259
+	90 -> 260
+	180 -> 260
+	181 -> 260
+	91 -> 261
+	180 -> 261
+	181 -> 261
+	92 -> 262
+	180 -> 262
+	181 -> 262
+	93 -> 263
+	180 -> 263
+	181 -> 263
+	287 -> 265
+	182 -> 265
+	288 -> 267
+	185 -> 267
+	289 -> 268
+	188 -> 268
+	290 -> 269
+	191 -> 269
+	291 -> 270
+	194 -> 270
+	292 -> 271
+	197 -> 271
+	293 -> 272
+	200 -> 272
+	294 -> 273
+	203 -> 273
+	295 -> 274
+	206 -> 274
+	296 -> 275
+	209 -> 275
+	297 -> 276
+	212 -> 276
+	298 -> 277
+	215 -> 277
+	299 -> 278
+	218 -> 278
+	300 -> 279
+	221 -> 279
+	301 -> 280
+	224 -> 280
+	302 -> 281
+	227 -> 281
+	303 -> 282
+	230 -> 282
+	304 -> 283
+	233 -> 283
+	305 -> 284
+	236 -> 284
+	306 -> 285
+	239 -> 285
+	307 -> 286
+	242 -> 286
+	182 -> 287
+	185 -> 288
+	188 -> 289
+	191 -> 290
+	194 -> 291
+	197 -> 292
+	200 -> 293
+	203 -> 294
+	206 -> 295
+	209 -> 296
+	212 -> 297
+	215 -> 298
+	218 -> 299
+	221 -> 300
+	224 -> 301
+	227 -> 302
+	230 -> 303
+	233 -> 304
+	236 -> 305
+	239 -> 306
+	242 -> 307
+}            
diff --git a/report/dag.svg b/report/dag.svg
new file mode 100644
index 0000000..ee4ed3b
--- /dev/null
+++ b/report/dag.svg
@@ -0,0 +1,6521 @@
+<?xml version="1.0" encoding="UTF-8" standalone="no"?>
+<!DOCTYPE svg PUBLIC "-//W3C//DTD SVG 1.1//EN" "http://www.w3.org/Graphics/SVG/1.1/DTD/svg11.dtd">
+<!-- Generated by graphviz version 2.40.1 (20161225.0304)
+ -->
+<!-- Title: snakemake_dag Pages: 1 -->
+<svg width="9135pt" height="1052pt" viewBox="0.00 0.00 9135.00 1052.00" xmlns="http://www.w3.org/2000/svg" xmlns:xlink="http://www.w3.org/1999/xlink">
+<g id="graph0" class="graph" transform="scale(1 1) rotate(0) translate(4 1048)">
+<title>snakemake_dag</title>
+<polygon fill="#ffffff" stroke="transparent" points="-4,4 -4,-1048 9131,-1048 9131,4 -4,4"/>
+<!-- 0 -->
+<g id="node1" class="node">
+<title>0</title>
+<path fill="none" stroke="#56d882" stroke-width="2" d="M4685,-36C4685,-36 4655,-36 4655,-36 4649,-36 4643,-30 4643,-24 4643,-24 4643,-12 4643,-12 4643,-6 4649,0 4655,0 4655,0 4685,0 4685,0 4691,0 4697,-6 4697,-12 4697,-12 4697,-24 4697,-24 4697,-30 4691,-36 4685,-36"/>
+<text text-anchor="middle" x="4670" y="-15" font-family="sans" font-size="10.00" fill="#000000">all</text>
+</g>
+<!-- 1 -->
+<g id="node2" class="node">
+<title>1</title>
+<path fill="none" stroke="#d8d356" stroke-width="2" d="M4562.2404,-252C4562.2404,-252 4507.7596,-252 4507.7596,-252 4501.7596,-252 4495.7596,-246 4495.7596,-240 4495.7596,-240 4495.7596,-228 4495.7596,-228 4495.7596,-222 4501.7596,-216 4507.7596,-216 4507.7596,-216 4562.2404,-216 4562.2404,-216 4568.2404,-216 4574.2404,-222 4574.2404,-228 4574.2404,-228 4574.2404,-240 4574.2404,-240 4574.2404,-246 4568.2404,-252 4562.2404,-252"/>
+<text text-anchor="middle" x="4535" y="-231" font-family="sans" font-size="10.00" fill="#000000">renameGeneIds</text>
+</g>
+<!-- 1&#45;&gt;0 -->
+<g id="edge1" class="edge">
+<title>1-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4515.95,-215.8859C4507.143,-206.1885 4497.6254,-193.4808 4493,-180 4487.8074,-164.866 4488.1473,-159.2463 4493,-144 4504.8936,-106.6326 4513.5004,-96.6485 4544,-72 4570.3435,-50.7103 4606.3381,-36.4026 4633.1115,-27.8937"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4634.3377,-31.1789 4642.8818,-24.914 4632.2957,-24.4834 4634.3377,-31.1789"/>
+</g>
+<!-- 3 -->
+<g id="node4" class="node">
+<title>3</title>
+<path fill="none" stroke="#a7d856" stroke-width="2" d="M4617.561,-180C4617.561,-180 4514.439,-180 4514.439,-180 4508.439,-180 4502.439,-174 4502.439,-168 4502.439,-168 4502.439,-156 4502.439,-156 4502.439,-150 4508.439,-144 4514.439,-144 4514.439,-144 4617.561,-144 4617.561,-144 4623.561,-144 4629.561,-150 4629.561,-156 4629.561,-156 4629.561,-168 4629.561,-168 4629.561,-174 4623.561,-180 4617.561,-180"/>
+<text text-anchor="middle" x="4566" y="-159" font-family="sans" font-size="10.00" fill="#000000">generateFastaSequencesHC</text>
+</g>
+<!-- 1&#45;&gt;3 -->
+<g id="edge95" class="edge">
+<title>1-&gt;3</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4542.8226,-215.8314C4546.2109,-207.9617 4550.2541,-198.5712 4554.0076,-189.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4557.3321,-190.9822 4558.0721,-180.4133 4550.9027,-188.214 4557.3321,-190.9822"/>
+</g>
+<!-- 5 -->
+<g id="node6" class="node">
+<title>5</title>
+<path fill="none" stroke="#80d856" stroke-width="2" d="M4761.951,-180C4761.951,-180 4660.049,-180 4660.049,-180 4654.049,-180 4648.049,-174 4648.049,-168 4648.049,-168 4648.049,-156 4648.049,-156 4648.049,-150 4654.049,-144 4660.049,-144 4660.049,-144 4761.951,-144 4761.951,-144 4767.951,-144 4773.951,-150 4773.951,-156 4773.951,-156 4773.951,-168 4773.951,-168 4773.951,-174 4767.951,-180 4761.951,-180"/>
+<text text-anchor="middle" x="4711" y="-159" font-family="sans" font-size="10.00" fill="#000000">generateFastaSequencesLC</text>
+</g>
+<!-- 1&#45;&gt;5 -->
+<g id="edge97" class="edge">
+<title>1-&gt;5</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4574.4978,-217.8418C4598.9594,-207.8348 4630.6922,-194.8532 4657.405,-183.9252"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4659.0664,-187.0272 4666.9966,-180.0014 4656.4159,-180.5484 4659.0664,-187.0272"/>
+</g>
+<!-- 2 -->
+<g id="node3" class="node">
+<title>2</title>
+<path fill="none" stroke="#d8ac56" stroke-width="2" d="M4480.094,-324C4480.094,-324 4391.906,-324 4391.906,-324 4385.906,-324 4379.906,-318 4379.906,-312 4379.906,-312 4379.906,-300 4379.906,-300 4379.906,-294 4385.906,-288 4391.906,-288 4391.906,-288 4480.094,-288 4480.094,-288 4486.094,-288 4492.094,-294 4492.094,-300 4492.094,-300 4492.094,-312 4492.094,-312 4492.094,-318 4486.094,-324 4480.094,-324"/>
+<text text-anchor="middle" x="4436" y="-303" font-family="sans" font-size="10.00" fill="#000000">concatAllChromResults</text>
+</g>
+<!-- 2&#45;&gt;0 -->
+<g id="edge2" class="edge">
+<title>2-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4435.9466,-287.996C4436.8138,-244.6817 4445.108,-133.6879 4505,-72 4522.8825,-53.5813 4590.0228,-35.7652 4632.9505,-25.9048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4633.785,-29.3046 4642.7701,-23.6905 4632.2451,-22.476 4633.785,-29.3046"/>
+</g>
+<!-- 2&#45;&gt;1 -->
+<g id="edge10" class="edge">
+<title>2-&gt;1</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4460.9819,-287.8314C4473.2928,-278.8779 4488.3107,-267.9558 4501.5937,-258.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4503.9973,-260.8752 4510.0261,-252.1628 4499.8801,-255.214 4503.9973,-260.8752"/>
+</g>
+<!-- 3&#45;&gt;0 -->
+<g id="edge3" class="edge">
+<title>3-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4557.3962,-143.9269C4549.5657,-124.5985 4541.1583,-93.7912 4555,-72 4572.0407,-45.1725 4606.3315,-31.4374 4633.055,-24.5557"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4633.9447,-27.9419 4642.8748,-22.2407 4632.3385,-21.1287 4633.9447,-27.9419"/>
+</g>
+<!-- 4 -->
+<g id="node5" class="node">
+<title>4</title>
+<path fill="none" stroke="#97d856" stroke-width="2" d="M4629.6001,-108C4629.6001,-108 4576.3999,-108 4576.3999,-108 4570.3999,-108 4564.3999,-102 4564.3999,-96 4564.3999,-96 4564.3999,-84 4564.3999,-84 4564.3999,-78 4570.3999,-72 4576.3999,-72 4576.3999,-72 4629.6001,-72 4629.6001,-72 4635.6001,-72 4641.6001,-78 4641.6001,-84 4641.6001,-84 4641.6001,-96 4641.6001,-96 4641.6001,-102 4635.6001,-108 4629.6001,-108"/>
+<text text-anchor="middle" x="4603" y="-87" font-family="sans" font-size="10.00" fill="#000000">validateCdsHC</text>
+</g>
+<!-- 3&#45;&gt;4 -->
+<g id="edge96" class="edge">
+<title>3-&gt;4</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4575.3367,-143.8314C4579.4243,-135.8771 4584.3104,-126.369 4588.8309,-117.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4592.0799,-118.9074 4593.5376,-108.4133 4585.8539,-115.7078 4592.0799,-118.9074"/>
+</g>
+<!-- 4&#45;&gt;0 -->
+<g id="edge4" class="edge">
+<title>4-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4619.9069,-71.8314C4627.7813,-63.3694 4637.292,-53.1489 4645.9013,-43.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4648.6153,-46.1183 4652.8654,-36.4133 4643.4908,-41.3497 4648.6153,-46.1183"/>
+</g>
+<!-- 5&#45;&gt;0 -->
+<g id="edge5" class="edge">
+<title>5-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4702.6344,-143.8016C4698.1264,-133.467 4692.7385,-120.195 4689,-108 4682.7689,-87.6744 4677.8804,-64.1504 4674.6232,-46.2509"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4678.0299,-45.4142 4672.8523,-36.1706 4671.1355,-46.6254 4678.0299,-45.4142"/>
+</g>
+<!-- 6 -->
+<g id="node7" class="node">
+<title>6</title>
+<path fill="none" stroke="#56d8c9" stroke-width="2" d="M4761.99,-108C4761.99,-108 4710.01,-108 4710.01,-108 4704.01,-108 4698.01,-102 4698.01,-96 4698.01,-96 4698.01,-84 4698.01,-84 4698.01,-78 4704.01,-72 4710.01,-72 4710.01,-72 4761.99,-72 4761.99,-72 4767.99,-72 4773.99,-78 4773.99,-84 4773.99,-84 4773.99,-96 4773.99,-96 4773.99,-102 4767.99,-108 4761.99,-108"/>
+<text text-anchor="middle" x="4736" y="-87" font-family="sans" font-size="10.00" fill="#000000">validateCdsLC</text>
+</g>
+<!-- 5&#45;&gt;6 -->
+<g id="edge98" class="edge">
+<title>5-&gt;6</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4717.3086,-143.8314C4720.0117,-136.0463 4723.2316,-126.7729 4726.231,-118.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4729.6327,-119.0081 4729.6065,-108.4133 4723.02,-116.7119 4729.6327,-119.0081"/>
+</g>
+<!-- 6&#45;&gt;0 -->
+<g id="edge6" class="edge">
+<title>6-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4719.3454,-71.8314C4711.5886,-63.3694 4702.2198,-53.1489 4693.739,-43.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4696.2162,-41.4198 4686.8788,-36.4133 4691.0561,-46.1499 4696.2162,-41.4198"/>
+</g>
+<!-- 7 -->
+<g id="node8" class="node">
+<title>7</title>
+<path fill="none" stroke="#ced856" stroke-width="2" d="M4710.7473,-612C4710.7473,-612 4611.2527,-612 4611.2527,-612 4605.2527,-612 4599.2527,-606 4599.2527,-600 4599.2527,-600 4599.2527,-588 4599.2527,-588 4599.2527,-582 4605.2527,-576 4611.2527,-576 4611.2527,-576 4710.7473,-576 4710.7473,-576 4716.7473,-576 4722.7473,-582 4722.7473,-588 4722.7473,-588 4722.7473,-600 4722.7473,-600 4722.7473,-606 4716.7473,-612 4710.7473,-612"/>
+<text text-anchor="middle" x="4661" y="-591" font-family="sans" font-size="10.00" fill="#000000">concatAnchoringSummary</text>
+</g>
+<!-- 7&#45;&gt;0 -->
+<g id="edge7" class="edge">
+<title>7-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4698.7854,-575.8986C4740.5513,-552.947 4802,-509.1314 4802,-450 4802,-450 4802,-450 4802,-162 4802,-121.1184 4808.2756,-104.1318 4783,-72 4764.2141,-48.1182 4732.2653,-34.2184 4707.1224,-26.5191"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4707.7464,-23.0575 4697.1698,-23.6799 4705.826,-29.7889 4707.7464,-23.0575"/>
+</g>
+<!-- 8 -->
+<g id="node9" class="node">
+<title>8</title>
+<path fill="none" stroke="#56d8a9" stroke-width="2" d="M4824.978,-612C4824.978,-612 4753.022,-612 4753.022,-612 4747.022,-612 4741.022,-606 4741.022,-600 4741.022,-600 4741.022,-588 4741.022,-588 4741.022,-582 4747.022,-576 4753.022,-576 4753.022,-576 4824.978,-576 4824.978,-576 4830.978,-576 4836.978,-582 4836.978,-588 4836.978,-588 4836.978,-600 4836.978,-600 4836.978,-606 4830.978,-612 4824.978,-612"/>
+<text text-anchor="middle" x="4789" y="-591" font-family="sans" font-size="10.00" fill="#000000">concatblatSummary</text>
+</g>
+<!-- 8&#45;&gt;0 -->
+<g id="edge8" class="edge">
+<title>8-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4809.6421,-575.7555C4835.9336,-550.391 4878,-501.7256 4878,-450 4878,-450 4878,-450 4878,-162 4878,-79.7931 4766.8103,-40.8183 4707.0214,-25.8031"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4707.7341,-22.3747 4697.1924,-23.434 4706.0938,-29.1798 4707.7341,-22.3747"/>
+</g>
+<!-- 9 -->
+<g id="node10" class="node">
+<title>9</title>
+<path fill="none" stroke="#d88d56" stroke-width="2" stroke-dasharray="5,2" d="M4972.2374,-108C4972.2374,-108 4917.7626,-108 4917.7626,-108 4911.7626,-108 4905.7626,-102 4905.7626,-96 4905.7626,-96 4905.7626,-84 4905.7626,-84 4905.7626,-78 4911.7626,-72 4917.7626,-72 4917.7626,-72 4972.2374,-72 4972.2374,-72 4978.2374,-72 4984.2374,-78 4984.2374,-84 4984.2374,-84 4984.2374,-96 4984.2374,-96 4984.2374,-102 4978.2374,-108 4972.2374,-108"/>
+<text text-anchor="middle" x="4945" y="-87" font-family="sans" font-size="10.00" fill="#000000">createDiagrams</text>
+</g>
+<!-- 9&#45;&gt;0 -->
+<g id="edge9" class="edge">
+<title>9-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4905.7614,-76.2407C4901.1415,-74.7494 4896.4789,-73.3025 4892,-72 4827.649,-53.2861 4751.5413,-35.7528 4707.2249,-25.993"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4707.7191,-22.5184 4697.202,-23.799 4706.2222,-29.3565 4707.7191,-22.5184"/>
+</g>
+<!-- 10 -->
+<g id="node11" class="node">
+<title>10</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M284.4201,-468C284.4201,-468 227.5799,-468 227.5799,-468 221.5799,-468 215.5799,-462 215.5799,-456 215.5799,-456 215.5799,-444 215.5799,-444 215.5799,-438 221.5799,-432 227.5799,-432 227.5799,-432 284.4201,-432 284.4201,-432 290.4201,-432 296.4201,-438 296.4201,-444 296.4201,-444 296.4201,-456 296.4201,-456 296.4201,-462 290.4201,-468 284.4201,-468"/>
+<text text-anchor="middle" x="256" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 10&#45;&gt;2 -->
+<g id="edge11" class="edge">
+<title>10-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M262.5002,-431.8761C271.3298,-410.3027 289.3778,-375.2792 318,-360 411.2311,-310.231 3846.6635,-306.3312 4369.5644,-306.0259"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9478,-309.5258 4379.9458,-306.0201 4369.9438,-302.5258 4369.9478,-309.5258"/>
+</g>
+<!-- 52 -->
+<g id="node53" class="node">
+<title>52</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M386.5435,-396C386.5435,-396 339.4565,-396 339.4565,-396 333.4565,-396 327.4565,-390 327.4565,-384 327.4565,-384 327.4565,-372 327.4565,-372 327.4565,-366 333.4565,-360 339.4565,-360 339.4565,-360 386.5435,-360 386.5435,-360 392.5435,-360 398.5435,-366 398.5435,-372 398.5435,-372 398.5435,-384 398.5435,-384 398.5435,-390 392.5435,-396 386.5435,-396"/>
+<text text-anchor="middle" x="363" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 10&#45;&gt;52 -->
+<g id="edge267" class="edge">
+<title>10-&gt;52</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M283.0006,-431.8314C296.4331,-422.7927 312.8473,-411.7476 327.3039,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="329.6654,-404.6494 336.008,-396.1628 325.7575,-398.8418 329.6654,-404.6494"/>
+</g>
+<!-- 11 -->
+<g id="node12" class="node">
+<title>11</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M710.4201,-468C710.4201,-468 653.5799,-468 653.5799,-468 647.5799,-468 641.5799,-462 641.5799,-456 641.5799,-456 641.5799,-444 641.5799,-444 641.5799,-438 647.5799,-432 653.5799,-432 653.5799,-432 710.4201,-432 710.4201,-432 716.4201,-432 722.4201,-438 722.4201,-444 722.4201,-444 722.4201,-456 722.4201,-456 722.4201,-462 716.4201,-468 710.4201,-468"/>
+<text text-anchor="middle" x="682" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 11&#45;&gt;2 -->
+<g id="edge12" class="edge">
+<title>11-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M687.7434,-431.9225C695.6632,-410.3959 712.204,-375.4195 740,-360 822.5569,-314.2026 3877.9815,-306.9709 4369.5585,-306.1032"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.6872,-309.6031 4379.6811,-306.0856 4369.675,-302.6031 4369.6872,-309.6031"/>
+</g>
+<!-- 53 -->
+<g id="node54" class="node">
+<title>53</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M808.5435,-396C808.5435,-396 761.4565,-396 761.4565,-396 755.4565,-396 749.4565,-390 749.4565,-384 749.4565,-384 749.4565,-372 749.4565,-372 749.4565,-366 755.4565,-360 761.4565,-360 761.4565,-360 808.5435,-360 808.5435,-360 814.5435,-360 820.5435,-366 820.5435,-372 820.5435,-372 820.5435,-384 820.5435,-384 820.5435,-390 814.5435,-396 808.5435,-396"/>
+<text text-anchor="middle" x="785" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 11&#45;&gt;53 -->
+<g id="edge269" class="edge">
+<title>11-&gt;53</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M707.9912,-431.8314C720.9216,-422.7927 736.7222,-411.7476 750.6383,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="752.8263,-404.7608 759.0171,-396.1628 748.8157,-399.0235 752.8263,-404.7608"/>
+</g>
+<!-- 12 -->
+<g id="node13" class="node">
+<title>12</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M2401.4201,-468C2401.4201,-468 2344.5799,-468 2344.5799,-468 2338.5799,-468 2332.5799,-462 2332.5799,-456 2332.5799,-456 2332.5799,-444 2332.5799,-444 2332.5799,-438 2338.5799,-432 2344.5799,-432 2344.5799,-432 2401.4201,-432 2401.4201,-432 2407.4201,-432 2413.4201,-438 2413.4201,-444 2413.4201,-444 2413.4201,-456 2413.4201,-456 2413.4201,-462 2407.4201,-468 2401.4201,-468"/>
+<text text-anchor="middle" x="2373" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 12&#45;&gt;2 -->
+<g id="edge13" class="edge">
+<title>12-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2376.3418,-431.7535C2381.3246,-410.4042 2392.9487,-375.9496 2418,-360 2460.1069,-333.1916 4026.3158,-311.3215 4369.843,-306.8409"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9317,-310.3402 4379.8854,-306.7104 4369.8407,-303.3408 4369.9317,-310.3402"/>
+</g>
+<!-- 54 -->
+<g id="node55" class="node">
+<title>54</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M2486.5435,-396C2486.5435,-396 2439.4565,-396 2439.4565,-396 2433.4565,-396 2427.4565,-390 2427.4565,-384 2427.4565,-384 2427.4565,-372 2427.4565,-372 2427.4565,-366 2433.4565,-360 2439.4565,-360 2439.4565,-360 2486.5435,-360 2486.5435,-360 2492.5435,-360 2498.5435,-366 2498.5435,-372 2498.5435,-372 2498.5435,-384 2498.5435,-384 2498.5435,-390 2492.5435,-396 2486.5435,-396"/>
+<text text-anchor="middle" x="2463" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 12&#45;&gt;54 -->
+<g id="edge271" class="edge">
+<title>12-&gt;54</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2395.7108,-431.8314C2406.796,-422.9632 2420.2954,-412.1637 2432.2852,-402.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2434.6742,-405.1429 2440.2965,-396.1628 2430.3013,-399.6768 2434.6742,-405.1429"/>
+</g>
+<!-- 13 -->
+<g id="node14" class="node">
+<title>13</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M3684.4201,-468C3684.4201,-468 3627.5799,-468 3627.5799,-468 3621.5799,-468 3615.5799,-462 3615.5799,-456 3615.5799,-456 3615.5799,-444 3615.5799,-444 3615.5799,-438 3621.5799,-432 3627.5799,-432 3627.5799,-432 3684.4201,-432 3684.4201,-432 3690.4201,-432 3696.4201,-438 3696.4201,-444 3696.4201,-444 3696.4201,-456 3696.4201,-456 3696.4201,-462 3690.4201,-468 3684.4201,-468"/>
+<text text-anchor="middle" x="3656" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 13&#45;&gt;2 -->
+<g id="edge14" class="edge">
+<title>13-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3662.238,-431.8141C3670.5988,-410.5246 3687.6386,-376.1288 3715,-360 3770.5736,-327.241 4201.8153,-312.273 4369.5581,-307.6472"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8408,-311.1409 4379.7419,-307.3702 4369.6504,-304.1435 4369.8408,-311.1409"/>
+</g>
+<!-- 55 -->
+<g id="node56" class="node">
+<title>55</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M3783.5435,-396C3783.5435,-396 3736.4565,-396 3736.4565,-396 3730.4565,-396 3724.4565,-390 3724.4565,-384 3724.4565,-384 3724.4565,-372 3724.4565,-372 3724.4565,-366 3730.4565,-360 3736.4565,-360 3736.4565,-360 3783.5435,-360 3783.5435,-360 3789.5435,-360 3795.5435,-366 3795.5435,-372 3795.5435,-372 3795.5435,-384 3795.5435,-384 3795.5435,-390 3789.5435,-396 3783.5435,-396"/>
+<text text-anchor="middle" x="3760" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 13&#45;&gt;55 -->
+<g id="edge273" class="edge">
+<title>13-&gt;55</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3682.2436,-431.8314C3695.2995,-422.7927 3711.2535,-411.7476 3725.3047,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3727.5351,-404.7326 3733.7648,-396.1628 3723.5506,-398.9773 3727.5351,-404.7326"/>
+</g>
+<!-- 14 -->
+<g id="node15" class="node">
+<title>14</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M4487.4201,-468C4487.4201,-468 4430.5799,-468 4430.5799,-468 4424.5799,-468 4418.5799,-462 4418.5799,-456 4418.5799,-456 4418.5799,-444 4418.5799,-444 4418.5799,-438 4424.5799,-432 4430.5799,-432 4430.5799,-432 4487.4201,-432 4487.4201,-432 4493.4201,-432 4499.4201,-438 4499.4201,-444 4499.4201,-444 4499.4201,-456 4499.4201,-456 4499.4201,-462 4493.4201,-468 4487.4201,-468"/>
+<text text-anchor="middle" x="4459" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 14&#45;&gt;2 -->
+<g id="edge15" class="edge">
+<title>14-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4456.087,-431.7623C4452.1468,-407.0928 4445.0818,-362.8598 4440.4679,-333.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4443.9228,-333.4124 4438.8893,-324.0896 4437.0104,-334.5165 4443.9228,-333.4124"/>
+</g>
+<!-- 56 -->
+<g id="node57" class="node">
+<title>56</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M4523.5435,-396C4523.5435,-396 4476.4565,-396 4476.4565,-396 4470.4565,-396 4464.4565,-390 4464.4565,-384 4464.4565,-384 4464.4565,-372 4464.4565,-372 4464.4565,-366 4470.4565,-360 4476.4565,-360 4476.4565,-360 4523.5435,-360 4523.5435,-360 4529.5435,-360 4535.5435,-366 4535.5435,-372 4535.5435,-372 4535.5435,-384 4535.5435,-384 4535.5435,-390 4529.5435,-396 4523.5435,-396"/>
+<text text-anchor="middle" x="4500" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 14&#45;&gt;56 -->
+<g id="edge275" class="edge">
+<title>14-&gt;56</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4469.346,-431.8314C4473.9237,-423.7925 4479.4052,-414.1666 4484.4588,-405.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4487.6077,-406.8351 4489.5147,-396.4133 4481.5248,-403.3712 4487.6077,-406.8351"/>
+</g>
+<!-- 15 -->
+<g id="node16" class="node">
+<title>15</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M1132.4201,-468C1132.4201,-468 1075.5799,-468 1075.5799,-468 1069.5799,-468 1063.5799,-462 1063.5799,-456 1063.5799,-456 1063.5799,-444 1063.5799,-444 1063.5799,-438 1069.5799,-432 1075.5799,-432 1075.5799,-432 1132.4201,-432 1132.4201,-432 1138.4201,-432 1144.4201,-438 1144.4201,-444 1144.4201,-444 1144.4201,-456 1144.4201,-456 1144.4201,-462 1138.4201,-468 1132.4201,-468"/>
+<text text-anchor="middle" x="1104" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 15&#45;&gt;2 -->
+<g id="edge16" class="edge">
+<title>15-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1109.7482,-431.9312C1117.6728,-410.4133 1134.2185,-375.4456 1162,-360 1234.6928,-319.5851 3912.0039,-307.9299 4369.7557,-306.2308"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8518,-309.7306 4379.8388,-306.1937 4369.826,-302.7306 4369.8518,-309.7306"/>
+</g>
+<!-- 57 -->
+<g id="node58" class="node">
+<title>57</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M1230.5435,-396C1230.5435,-396 1183.4565,-396 1183.4565,-396 1177.4565,-396 1171.4565,-390 1171.4565,-384 1171.4565,-384 1171.4565,-372 1171.4565,-372 1171.4565,-366 1177.4565,-360 1183.4565,-360 1183.4565,-360 1230.5435,-360 1230.5435,-360 1236.5435,-360 1242.5435,-366 1242.5435,-372 1242.5435,-372 1242.5435,-384 1242.5435,-384 1242.5435,-390 1236.5435,-396 1230.5435,-396"/>
+<text text-anchor="middle" x="1207" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 15&#45;&gt;57 -->
+<g id="edge277" class="edge">
+<title>15-&gt;57</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1129.9912,-431.8314C1142.9216,-422.7927 1158.7222,-411.7476 1172.6383,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1174.8263,-404.7608 1181.0171,-396.1628 1170.8157,-399.0235 1174.8263,-404.7608"/>
+</g>
+<!-- 16 -->
+<g id="node17" class="node">
+<title>16</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M1986.4201,-468C1986.4201,-468 1929.5799,-468 1929.5799,-468 1923.5799,-468 1917.5799,-462 1917.5799,-456 1917.5799,-456 1917.5799,-444 1917.5799,-444 1917.5799,-438 1923.5799,-432 1929.5799,-432 1929.5799,-432 1986.4201,-432 1986.4201,-432 1992.4201,-432 1998.4201,-438 1998.4201,-444 1998.4201,-444 1998.4201,-456 1998.4201,-456 1998.4201,-462 1992.4201,-468 1986.4201,-468"/>
+<text text-anchor="middle" x="1958" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 16&#45;&gt;2 -->
+<g id="edge17" class="edge">
+<title>16-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1960.7239,-431.777C1964.9855,-410.4509 1975.4518,-376.019 2000,-360 2051.0279,-326.7017 3984.3982,-309.593 4369.6322,-306.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8068,-310.0097 4379.7786,-306.43 4369.751,-303.0099 4369.8068,-310.0097"/>
+</g>
+<!-- 58 -->
+<g id="node59" class="node">
+<title>58</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M2068.5435,-396C2068.5435,-396 2021.4565,-396 2021.4565,-396 2015.4565,-396 2009.4565,-390 2009.4565,-384 2009.4565,-384 2009.4565,-372 2009.4565,-372 2009.4565,-366 2015.4565,-360 2021.4565,-360 2021.4565,-360 2068.5435,-360 2068.5435,-360 2074.5435,-360 2080.5435,-366 2080.5435,-372 2080.5435,-372 2080.5435,-384 2080.5435,-384 2080.5435,-390 2074.5435,-396 2068.5435,-396"/>
+<text text-anchor="middle" x="2045" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 16&#45;&gt;58 -->
+<g id="edge279" class="edge">
+<title>16-&gt;58</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1979.9538,-431.8314C1990.6695,-422.9632 2003.7189,-412.1637 2015.309,-402.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2017.5808,-405.2349 2023.0533,-396.1628 2013.1178,-399.8422 2017.5808,-405.2349"/>
+</g>
+<!-- 17 -->
+<g id="node18" class="node">
+<title>17</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M2829.4201,-468C2829.4201,-468 2772.5799,-468 2772.5799,-468 2766.5799,-468 2760.5799,-462 2760.5799,-456 2760.5799,-456 2760.5799,-444 2760.5799,-444 2760.5799,-438 2766.5799,-432 2772.5799,-432 2772.5799,-432 2829.4201,-432 2829.4201,-432 2835.4201,-432 2841.4201,-438 2841.4201,-444 2841.4201,-444 2841.4201,-456 2841.4201,-456 2841.4201,-462 2835.4201,-468 2829.4201,-468"/>
+<text text-anchor="middle" x="2801" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 17&#45;&gt;2 -->
+<g id="edge18" class="edge">
+<title>17-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2805.1615,-431.7329C2811.1018,-410.3635 2824.2657,-375.8889 2850,-360 2915.5574,-319.5234 4077.8026,-308.5517 4369.8444,-306.4285"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8883,-309.9284 4379.8629,-306.3567 4369.838,-302.9285 4369.8883,-309.9284"/>
+</g>
+<!-- 59 -->
+<g id="node60" class="node">
+<title>59</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M2918.5435,-396C2918.5435,-396 2871.4565,-396 2871.4565,-396 2865.4565,-396 2859.4565,-390 2859.4565,-384 2859.4565,-384 2859.4565,-372 2859.4565,-372 2859.4565,-366 2865.4565,-360 2871.4565,-360 2871.4565,-360 2918.5435,-360 2918.5435,-360 2924.5435,-360 2930.5435,-366 2930.5435,-372 2930.5435,-372 2930.5435,-384 2930.5435,-384 2930.5435,-390 2924.5435,-396 2918.5435,-396"/>
+<text text-anchor="middle" x="2895" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 17&#45;&gt;59 -->
+<g id="edge281" class="edge">
+<title>17-&gt;59</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2824.7202,-431.8314C2836.4094,-422.8779 2850.6688,-411.9558 2863.2809,-402.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2865.4769,-405.0222 2871.2874,-396.1628 2861.2203,-399.4651 2865.4769,-405.0222"/>
+</g>
+<!-- 18 -->
+<g id="node19" class="node">
+<title>18</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M1567.4201,-468C1567.4201,-468 1510.5799,-468 1510.5799,-468 1504.5799,-468 1498.5799,-462 1498.5799,-456 1498.5799,-456 1498.5799,-444 1498.5799,-444 1498.5799,-438 1504.5799,-432 1510.5799,-432 1510.5799,-432 1567.4201,-432 1567.4201,-432 1573.4201,-432 1579.4201,-438 1579.4201,-444 1579.4201,-444 1579.4201,-456 1579.4201,-456 1579.4201,-462 1573.4201,-468 1567.4201,-468"/>
+<text text-anchor="middle" x="1539" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 18&#45;&gt;2 -->
+<g id="edge19" class="edge">
+<title>18-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1542.3207,-431.7203C1547.2828,-410.3383 1558.8865,-375.8515 1584,-360 1644.8359,-321.6008 3946.1997,-308.415 4369.4675,-306.3125"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7164,-309.8114 4379.6989,-306.262 4369.6818,-302.8115 4369.7164,-309.8114"/>
+</g>
+<!-- 60 -->
+<g id="node61" class="node">
+<title>60</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M1652.5435,-396C1652.5435,-396 1605.4565,-396 1605.4565,-396 1599.4565,-396 1593.4565,-390 1593.4565,-384 1593.4565,-384 1593.4565,-372 1593.4565,-372 1593.4565,-366 1599.4565,-360 1605.4565,-360 1605.4565,-360 1652.5435,-360 1652.5435,-360 1658.5435,-360 1664.5435,-366 1664.5435,-372 1664.5435,-372 1664.5435,-384 1664.5435,-384 1664.5435,-390 1658.5435,-396 1652.5435,-396"/>
+<text text-anchor="middle" x="1629" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 18&#45;&gt;60 -->
+<g id="edge283" class="edge">
+<title>18-&gt;60</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1561.7108,-431.8314C1572.796,-422.9632 1586.2954,-412.1637 1598.2852,-402.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1600.6742,-405.1429 1606.2965,-396.1628 1596.3013,-399.6768 1600.6742,-405.1429"/>
+</g>
+<!-- 19 -->
+<g id="node20" class="node">
+<title>19</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M3242.4201,-468C3242.4201,-468 3185.5799,-468 3185.5799,-468 3179.5799,-468 3173.5799,-462 3173.5799,-456 3173.5799,-456 3173.5799,-444 3173.5799,-444 3173.5799,-438 3179.5799,-432 3185.5799,-432 3185.5799,-432 3242.4201,-432 3242.4201,-432 3248.4201,-432 3254.4201,-438 3254.4201,-444 3254.4201,-444 3254.4201,-456 3254.4201,-456 3254.4201,-462 3248.4201,-468 3242.4201,-468"/>
+<text text-anchor="middle" x="3214" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 19&#45;&gt;2 -->
+<g id="edge20" class="edge">
+<title>19-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3219.9667,-431.6913C3228.0228,-410.2809 3244.6134,-375.766 3272,-360 3319.7508,-332.5107 4129.4197,-312.697 4369.4537,-307.4065"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8559,-310.8986 4379.7768,-307.1802 4369.7024,-303.9003 4369.8559,-310.8986"/>
+</g>
+<!-- 61 -->
+<g id="node62" class="node">
+<title>61</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M3340.5435,-396C3340.5435,-396 3293.4565,-396 3293.4565,-396 3287.4565,-396 3281.4565,-390 3281.4565,-384 3281.4565,-384 3281.4565,-372 3281.4565,-372 3281.4565,-366 3287.4565,-360 3293.4565,-360 3293.4565,-360 3340.5435,-360 3340.5435,-360 3346.5435,-360 3352.5435,-366 3352.5435,-372 3352.5435,-372 3352.5435,-384 3352.5435,-384 3352.5435,-390 3346.5435,-396 3340.5435,-396"/>
+<text text-anchor="middle" x="3317" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 19&#45;&gt;61 -->
+<g id="edge285" class="edge">
+<title>19-&gt;61</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3239.9912,-431.8314C3252.9216,-422.7927 3268.7222,-411.7476 3282.6383,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3284.8263,-404.7608 3291.0171,-396.1628 3280.8157,-399.0235 3284.8263,-404.7608"/>
+</g>
+<!-- 20 -->
+<g id="node21" class="node">
+<title>20</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M4032.4201,-468C4032.4201,-468 3975.5799,-468 3975.5799,-468 3969.5799,-468 3963.5799,-462 3963.5799,-456 3963.5799,-456 3963.5799,-444 3963.5799,-444 3963.5799,-438 3969.5799,-432 3975.5799,-432 3975.5799,-432 4032.4201,-432 4032.4201,-432 4038.4201,-432 4044.4201,-438 4044.4201,-444 4044.4201,-444 4044.4201,-456 4044.4201,-456 4044.4201,-462 4038.4201,-468 4032.4201,-468"/>
+<text text-anchor="middle" x="4004" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 20&#45;&gt;2 -->
+<g id="edge21" class="edge">
+<title>20-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4003.1019,-431.7829C4003.1641,-411.1249 4006.7372,-377.9857 4027,-360 4052.135,-337.6897 4260.2748,-319.0663 4369.5552,-310.7166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4370.1051,-314.1851 4379.8126,-309.9408 4369.5771,-307.205 4370.1051,-314.1851"/>
+</g>
+<!-- 62 -->
+<g id="node63" class="node">
+<title>62</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M4095.5435,-396C4095.5435,-396 4048.4565,-396 4048.4565,-396 4042.4565,-396 4036.4565,-390 4036.4565,-384 4036.4565,-384 4036.4565,-372 4036.4565,-372 4036.4565,-366 4042.4565,-360 4048.4565,-360 4048.4565,-360 4095.5435,-360 4095.5435,-360 4101.5435,-360 4107.5435,-366 4107.5435,-372 4107.5435,-372 4107.5435,-384 4107.5435,-384 4107.5435,-390 4101.5435,-396 4095.5435,-396"/>
+<text text-anchor="middle" x="4072" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 20&#45;&gt;62 -->
+<g id="edge287" class="edge">
+<title>20-&gt;62</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4021.1593,-431.8314C4029.1511,-423.3694 4038.8038,-413.1489 4047.5416,-403.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4050.288,-406.0866 4054.6097,-396.4133 4045.1989,-401.2802 4050.288,-406.0866"/>
+</g>
+<!-- 21 -->
+<g id="node22" class="node">
+<title>21</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M6761.4201,-468C6761.4201,-468 6704.5799,-468 6704.5799,-468 6698.5799,-468 6692.5799,-462 6692.5799,-456 6692.5799,-456 6692.5799,-444 6692.5799,-444 6692.5799,-438 6698.5799,-432 6704.5799,-432 6704.5799,-432 6761.4201,-432 6761.4201,-432 6767.4201,-432 6773.4201,-438 6773.4201,-444 6773.4201,-444 6773.4201,-456 6773.4201,-456 6773.4201,-462 6767.4201,-468 6761.4201,-468"/>
+<text text-anchor="middle" x="6733" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 21&#45;&gt;2 -->
+<g id="edge22" class="edge">
+<title>21-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6727.2323,-431.9661C6719.288,-410.4835 6702.7224,-375.5514 6675,-360 6626.4015,-332.7378 4868.6131,-310.9906 4502.4203,-306.7502"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.288,-303.2486 4492.2482,-306.6328 4502.2071,-310.2481 4502.288,-303.2486"/>
+</g>
+<!-- 63 -->
+<g id="node64" class="node">
+<title>63</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M6653.5435,-396C6653.5435,-396 6606.4565,-396 6606.4565,-396 6600.4565,-396 6594.4565,-390 6594.4565,-384 6594.4565,-384 6594.4565,-372 6594.4565,-372 6594.4565,-366 6600.4565,-360 6606.4565,-360 6606.4565,-360 6653.5435,-360 6653.5435,-360 6659.5435,-360 6665.5435,-366 6665.5435,-372 6665.5435,-372 6665.5435,-384 6665.5435,-384 6665.5435,-390 6659.5435,-396 6653.5435,-396"/>
+<text text-anchor="middle" x="6630" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 21&#45;&gt;63 -->
+<g id="edge289" class="edge">
+<title>21-&gt;63</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6707.0088,-431.8314C6694.0784,-422.7927 6678.2778,-411.7476 6664.3617,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6666.1843,-399.0235 6655.9829,-396.1628 6662.1737,-404.7608 6666.1843,-399.0235"/>
+</g>
+<!-- 22 -->
+<g id="node23" class="node">
+<title>22</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M5045.4201,-468C5045.4201,-468 4988.5799,-468 4988.5799,-468 4982.5799,-468 4976.5799,-462 4976.5799,-456 4976.5799,-456 4976.5799,-444 4976.5799,-444 4976.5799,-438 4982.5799,-432 4988.5799,-432 4988.5799,-432 5045.4201,-432 5045.4201,-432 5051.4201,-432 5057.4201,-438 5057.4201,-444 5057.4201,-444 5057.4201,-456 5057.4201,-456 5057.4201,-462 5051.4201,-468 5045.4201,-468"/>
+<text text-anchor="middle" x="5017" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 22&#45;&gt;2 -->
+<g id="edge23" class="edge">
+<title>22-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4976.5378,-434.5386C4923.8803,-414.8996 4828.6952,-381.0393 4745,-360 4662.3247,-339.2171 4565.2231,-323.6602 4502.2494,-314.7087"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.4478,-311.2023 4492.0578,-313.2754 4501.4729,-318.134 4502.4478,-311.2023"/>
+</g>
+<!-- 64 -->
+<g id="node65" class="node">
+<title>64</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M4723.5435,-396C4723.5435,-396 4676.4565,-396 4676.4565,-396 4670.4565,-396 4664.4565,-390 4664.4565,-384 4664.4565,-384 4664.4565,-372 4664.4565,-372 4664.4565,-366 4670.4565,-360 4676.4565,-360 4676.4565,-360 4723.5435,-360 4723.5435,-360 4729.5435,-360 4735.5435,-366 4735.5435,-372 4735.5435,-372 4735.5435,-384 4735.5435,-384 4735.5435,-390 4729.5435,-396 4723.5435,-396"/>
+<text text-anchor="middle" x="4700" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 22&#45;&gt;64 -->
+<g id="edge291" class="edge">
+<title>22-&gt;64</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4976.7292,-441.6102C4962.0276,-438.5626 4945.2656,-435.1057 4930,-432 4850.0534,-415.7352 4828.5964,-417.8771 4750,-396 4748.5279,-395.5903 4747.037,-395.1582 4745.5359,-394.7084"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4746.1626,-391.2346 4735.5719,-391.5315 4744.0361,-397.9039 4746.1626,-391.2346"/>
+</g>
+<!-- 23 -->
+<g id="node24" class="node">
+<title>23</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M6339.4201,-468C6339.4201,-468 6282.5799,-468 6282.5799,-468 6276.5799,-468 6270.5799,-462 6270.5799,-456 6270.5799,-456 6270.5799,-444 6270.5799,-444 6270.5799,-438 6276.5799,-432 6282.5799,-432 6282.5799,-432 6339.4201,-432 6339.4201,-432 6345.4201,-432 6351.4201,-438 6351.4201,-444 6351.4201,-444 6351.4201,-456 6351.4201,-456 6351.4201,-462 6345.4201,-468 6339.4201,-468"/>
+<text text-anchor="middle" x="6311" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 23&#45;&gt;2 -->
+<g id="edge24" class="edge">
+<title>23-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6305.2179,-431.9918C6297.259,-410.535 6280.6788,-375.6289 6253,-360 6175.4319,-316.201 4820.9887,-307.655 4502.6119,-306.2485"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1829,-302.7467 4492.1678,-306.2033 4502.1525,-309.7466 4502.1829,-302.7467"/>
+</g>
+<!-- 65 -->
+<g id="node66" class="node">
+<title>65</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M6231.5435,-396C6231.5435,-396 6184.4565,-396 6184.4565,-396 6178.4565,-396 6172.4565,-390 6172.4565,-384 6172.4565,-384 6172.4565,-372 6172.4565,-372 6172.4565,-366 6178.4565,-360 6184.4565,-360 6184.4565,-360 6231.5435,-360 6231.5435,-360 6237.5435,-360 6243.5435,-366 6243.5435,-372 6243.5435,-372 6243.5435,-384 6243.5435,-384 6243.5435,-390 6237.5435,-396 6231.5435,-396"/>
+<text text-anchor="middle" x="6208" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 23&#45;&gt;65 -->
+<g id="edge293" class="edge">
+<title>23-&gt;65</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6285.0088,-431.8314C6272.0784,-422.7927 6256.2778,-411.7476 6242.3617,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6244.1843,-399.0235 6233.9829,-396.1628 6240.1737,-404.7608 6244.1843,-399.0235"/>
+</g>
+<!-- 24 -->
+<g id="node25" class="node">
+<title>24</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M5487.4201,-468C5487.4201,-468 5430.5799,-468 5430.5799,-468 5424.5799,-468 5418.5799,-462 5418.5799,-456 5418.5799,-456 5418.5799,-444 5418.5799,-444 5418.5799,-438 5424.5799,-432 5430.5799,-432 5430.5799,-432 5487.4201,-432 5487.4201,-432 5493.4201,-432 5499.4201,-438 5499.4201,-444 5499.4201,-444 5499.4201,-456 5499.4201,-456 5499.4201,-462 5493.4201,-468 5487.4201,-468"/>
+<text text-anchor="middle" x="5459" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 24&#45;&gt;2 -->
+<g id="edge25" class="edge">
+<title>24-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5453.0077,-431.7355C5444.9264,-410.3686 5428.3111,-375.8965 5401,-360 5362.208,-337.421 4713.9654,-314.8573 4502.2817,-308.0607"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.344,-304.561 4492.2372,-307.7395 4502.1202,-311.5574 4502.344,-304.561"/>
+</g>
+<!-- 66 -->
+<g id="node67" class="node">
+<title>66</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M5379.5435,-396C5379.5435,-396 5332.4565,-396 5332.4565,-396 5326.4565,-396 5320.4565,-390 5320.4565,-384 5320.4565,-384 5320.4565,-372 5320.4565,-372 5320.4565,-366 5326.4565,-360 5332.4565,-360 5332.4565,-360 5379.5435,-360 5379.5435,-360 5385.5435,-360 5391.5435,-366 5391.5435,-372 5391.5435,-372 5391.5435,-384 5391.5435,-384 5391.5435,-390 5385.5435,-396 5379.5435,-396"/>
+<text text-anchor="middle" x="5356" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 24&#45;&gt;66 -->
+<g id="edge295" class="edge">
+<title>24-&gt;66</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5433.0088,-431.8314C5420.0784,-422.7927 5404.2778,-411.7476 5390.3617,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5392.1843,-399.0235 5381.9829,-396.1628 5388.1737,-404.7608 5392.1843,-399.0235"/>
+</g>
+<!-- 25 -->
+<g id="node26" class="node">
+<title>25</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M7605.4201,-468C7605.4201,-468 7548.5799,-468 7548.5799,-468 7542.5799,-468 7536.5799,-462 7536.5799,-456 7536.5799,-456 7536.5799,-444 7536.5799,-444 7536.5799,-438 7542.5799,-432 7548.5799,-432 7548.5799,-432 7605.4201,-432 7605.4201,-432 7611.4201,-432 7617.4201,-438 7617.4201,-444 7617.4201,-444 7617.4201,-456 7617.4201,-456 7617.4201,-462 7611.4201,-468 7605.4201,-468"/>
+<text text-anchor="middle" x="7577" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 25&#45;&gt;2 -->
+<g id="edge26" class="edge">
+<title>25-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7572.2874,-431.6236C7565.6918,-410.1466 7551.4348,-375.5661 7525,-360 7457.5747,-320.2968 4945.1623,-308.1025 4502.3272,-306.2597"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.268,-302.7595 4492.2536,-306.2181 4502.239,-309.7595 4502.268,-302.7595"/>
+</g>
+<!-- 67 -->
+<g id="node68" class="node">
+<title>67</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M7503.5435,-396C7503.5435,-396 7456.4565,-396 7456.4565,-396 7450.4565,-396 7444.4565,-390 7444.4565,-384 7444.4565,-384 7444.4565,-372 7444.4565,-372 7444.4565,-366 7450.4565,-360 7456.4565,-360 7456.4565,-360 7503.5435,-360 7503.5435,-360 7509.5435,-360 7515.5435,-366 7515.5435,-372 7515.5435,-372 7515.5435,-384 7515.5435,-384 7515.5435,-390 7509.5435,-396 7503.5435,-396"/>
+<text text-anchor="middle" x="7480" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 25&#45;&gt;67 -->
+<g id="edge297" class="edge">
+<title>25-&gt;67</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7552.5228,-431.8314C7540.4605,-422.8779 7525.746,-411.9558 7512.7314,-402.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7514.5852,-399.3127 7504.4694,-396.1628 7510.413,-404.9335 7514.5852,-399.3127"/>
+</g>
+<!-- 26 -->
+<g id="node27" class="node">
+<title>26</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M5904.4201,-468C5904.4201,-468 5847.5799,-468 5847.5799,-468 5841.5799,-468 5835.5799,-462 5835.5799,-456 5835.5799,-456 5835.5799,-444 5835.5799,-444 5835.5799,-438 5841.5799,-432 5847.5799,-432 5847.5799,-432 5904.4201,-432 5904.4201,-432 5910.4201,-432 5916.4201,-438 5916.4201,-444 5916.4201,-444 5916.4201,-456 5916.4201,-456 5916.4201,-462 5910.4201,-468 5904.4201,-468"/>
+<text text-anchor="middle" x="5876" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 26&#45;&gt;2 -->
+<g id="edge27" class="edge">
+<title>26-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5871.8256,-431.7537C5865.8727,-410.4047 5852.6963,-375.9502 5827,-360 5770.173,-324.7264 4771.2064,-310.0753 4502.2351,-306.7595"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.2671,-303.2597 4492.225,-306.6372 4502.1815,-310.2592 4502.2671,-303.2597"/>
+</g>
+<!-- 68 -->
+<g id="node69" class="node">
+<title>68</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M5805.5435,-396C5805.5435,-396 5758.4565,-396 5758.4565,-396 5752.4565,-396 5746.4565,-390 5746.4565,-384 5746.4565,-384 5746.4565,-372 5746.4565,-372 5746.4565,-366 5752.4565,-360 5758.4565,-360 5758.4565,-360 5805.5435,-360 5805.5435,-360 5811.5435,-360 5817.5435,-366 5817.5435,-372 5817.5435,-372 5817.5435,-384 5817.5435,-384 5817.5435,-390 5811.5435,-396 5805.5435,-396"/>
+<text text-anchor="middle" x="5782" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 26&#45;&gt;68 -->
+<g id="edge299" class="edge">
+<title>26-&gt;68</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5852.2798,-431.8314C5840.5906,-422.8779 5826.3312,-411.9558 5813.7191,-402.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5815.7797,-399.4651 5805.7126,-396.1628 5811.5231,-405.0222 5815.7797,-399.4651"/>
+</g>
+<!-- 27 -->
+<g id="node28" class="node">
+<title>27</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M7189.4201,-468C7189.4201,-468 7132.5799,-468 7132.5799,-468 7126.5799,-468 7120.5799,-462 7120.5799,-456 7120.5799,-456 7120.5799,-444 7120.5799,-444 7120.5799,-438 7126.5799,-432 7132.5799,-432 7132.5799,-432 7189.4201,-432 7189.4201,-432 7195.4201,-432 7201.4201,-438 7201.4201,-444 7201.4201,-444 7201.4201,-456 7201.4201,-456 7201.4201,-462 7195.4201,-468 7189.4201,-468"/>
+<text text-anchor="middle" x="7161" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 27&#45;&gt;2 -->
+<g id="edge28" class="edge">
+<title>27-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7154.2925,-431.9009C7145.2172,-410.3526 7126.774,-375.3543 7098,-360 7038.961,-328.4959 4907.4799,-309.7938 4502.1792,-306.5185"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1149,-303.0179 4492.087,-306.4372 4502.0585,-310.0177 4502.1149,-303.0179"/>
+</g>
+<!-- 69 -->
+<g id="node70" class="node">
+<title>69</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M7076.5435,-396C7076.5435,-396 7029.4565,-396 7029.4565,-396 7023.4565,-396 7017.4565,-390 7017.4565,-384 7017.4565,-384 7017.4565,-372 7017.4565,-372 7017.4565,-366 7023.4565,-360 7029.4565,-360 7029.4565,-360 7076.5435,-360 7076.5435,-360 7082.5435,-360 7088.5435,-366 7088.5435,-372 7088.5435,-372 7088.5435,-384 7088.5435,-384 7088.5435,-390 7082.5435,-396 7076.5435,-396"/>
+<text text-anchor="middle" x="7053" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 27&#45;&gt;69 -->
+<g id="edge301" class="edge">
+<title>27-&gt;69</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7133.747,-431.8314C7120.0611,-422.7074 7103.3085,-411.539 7088.6173,-401.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7090.5062,-398.7977 7080.2442,-396.1628 7086.6233,-404.6221 7090.5062,-398.7977"/>
+</g>
+<!-- 28 -->
+<g id="node29" class="node">
+<title>28</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M8019.4201,-468C8019.4201,-468 7962.5799,-468 7962.5799,-468 7956.5799,-468 7950.5799,-462 7950.5799,-456 7950.5799,-456 7950.5799,-444 7950.5799,-444 7950.5799,-438 7956.5799,-432 7962.5799,-432 7962.5799,-432 8019.4201,-432 8019.4201,-432 8025.4201,-432 8031.4201,-438 8031.4201,-444 8031.4201,-444 8031.4201,-456 8031.4201,-456 8031.4201,-462 8025.4201,-468 8019.4201,-468"/>
+<text text-anchor="middle" x="7991" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 28&#45;&gt;2 -->
+<g id="edge29" class="edge">
+<title>28-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7987.0876,-431.6645C7981.4302,-410.2276 7968.6941,-375.6867 7943,-360 7866.721,-313.4303 4979.4297,-306.8596 4502.4174,-306.0914"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.2602,-302.5912 4492.2546,-306.0753 4502.249,-309.5912 4502.2602,-302.5912"/>
+</g>
+<!-- 70 -->
+<g id="node71" class="node">
+<title>70</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M7921.5435,-396C7921.5435,-396 7874.4565,-396 7874.4565,-396 7868.4565,-396 7862.4565,-390 7862.4565,-384 7862.4565,-384 7862.4565,-372 7862.4565,-372 7862.4565,-366 7868.4565,-360 7874.4565,-360 7874.4565,-360 7921.5435,-360 7921.5435,-360 7927.5435,-360 7933.5435,-366 7933.5435,-372 7933.5435,-372 7933.5435,-384 7933.5435,-384 7933.5435,-390 7927.5435,-396 7921.5435,-396"/>
+<text text-anchor="middle" x="7898" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 28&#45;&gt;70 -->
+<g id="edge303" class="edge">
+<title>28-&gt;70</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7967.5322,-431.8314C7955.9673,-422.8779 7941.8596,-411.9558 7929.3817,-402.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7931.5102,-399.5171 7921.4603,-396.1628 7927.225,-405.0521 7931.5102,-399.5171"/>
+</g>
+<!-- 29 -->
+<g id="node30" class="node">
+<title>29</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M8450.4201,-468C8450.4201,-468 8393.5799,-468 8393.5799,-468 8387.5799,-468 8381.5799,-462 8381.5799,-456 8381.5799,-456 8381.5799,-444 8381.5799,-444 8381.5799,-438 8387.5799,-432 8393.5799,-432 8393.5799,-432 8450.4201,-432 8450.4201,-432 8456.4201,-432 8462.4201,-438 8462.4201,-444 8462.4201,-444 8462.4201,-456 8462.4201,-456 8462.4201,-462 8456.4201,-468 8450.4201,-468"/>
+<text text-anchor="middle" x="8422" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 29&#45;&gt;2 -->
+<g id="edge30" class="edge">
+<title>29-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8418.292,-431.6705C8412.8734,-410.2395 8400.5217,-375.7044 8375,-360 8332.0083,-333.5457 5015.47,-309.9403 4502.3592,-306.4449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1881,-302.9438 4492.1645,-306.3756 4502.1404,-309.9436 4502.1881,-302.9438"/>
+</g>
+<!-- 71 -->
+<g id="node72" class="node">
+<title>71</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M8353.5435,-396C8353.5435,-396 8306.4565,-396 8306.4565,-396 8300.4565,-396 8294.4565,-390 8294.4565,-384 8294.4565,-384 8294.4565,-372 8294.4565,-372 8294.4565,-366 8300.4565,-360 8306.4565,-360 8306.4565,-360 8353.5435,-360 8353.5435,-360 8359.5435,-360 8365.5435,-366 8365.5435,-372 8365.5435,-372 8365.5435,-384 8365.5435,-384 8365.5435,-390 8359.5435,-396 8353.5435,-396"/>
+<text text-anchor="middle" x="8330" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 29&#45;&gt;71 -->
+<g id="edge305" class="edge">
+<title>29-&gt;71</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8398.7845,-431.8314C8387.453,-422.9632 8373.6536,-412.1637 8361.3973,-402.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8363.2402,-399.5697 8353.2081,-396.1628 8358.926,-405.0822 8363.2402,-399.5697"/>
+</g>
+<!-- 30 -->
+<g id="node31" class="node">
+<title>30</title>
+<path fill="none" stroke="#d89c56" stroke-width="2" d="M8880.4201,-468C8880.4201,-468 8823.5799,-468 8823.5799,-468 8817.5799,-468 8811.5799,-462 8811.5799,-456 8811.5799,-456 8811.5799,-444 8811.5799,-444 8811.5799,-438 8817.5799,-432 8823.5799,-432 8823.5799,-432 8880.4201,-432 8880.4201,-432 8886.4201,-432 8892.4201,-438 8892.4201,-444 8892.4201,-444 8892.4201,-456 8892.4201,-456 8892.4201,-462 8886.4201,-468 8880.4201,-468"/>
+<text text-anchor="middle" x="8852" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 30&#45;&gt;2 -->
+<g id="edge31" class="edge">
+<title>30-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8846.8373,-431.9444C8839.6129,-410.4399 8824.2156,-375.4857 8797,-360 8748.2112,-332.2391 5044.7609,-309.5566 4502.0769,-306.3804"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.0856,-302.8805 4492.0653,-306.322 4502.0447,-309.8804 4502.0856,-302.8805"/>
+</g>
+<!-- 72 -->
+<g id="node73" class="node">
+<title>72</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M8775.5435,-396C8775.5435,-396 8728.4565,-396 8728.4565,-396 8722.4565,-396 8716.4565,-390 8716.4565,-384 8716.4565,-384 8716.4565,-372 8716.4565,-372 8716.4565,-366 8722.4565,-360 8728.4565,-360 8728.4565,-360 8775.5435,-360 8775.5435,-360 8781.5435,-360 8787.5435,-366 8787.5435,-372 8787.5435,-372 8787.5435,-384 8787.5435,-384 8787.5435,-390 8781.5435,-396 8775.5435,-396"/>
+<text text-anchor="middle" x="8752" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 30&#45;&gt;72 -->
+<g id="edge307" class="edge">
+<title>30-&gt;72</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8826.7658,-431.8314C8814.212,-422.7927 8798.8717,-411.7476 8785.3609,-402.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8787.3866,-399.1655 8777.2261,-396.1628 8783.2964,-404.8463 8787.3866,-399.1655"/>
+</g>
+<!-- 31 -->
+<g id="node32" class="node">
+<title>31</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M90.3621,-540C90.3621,-540 39.6379,-540 39.6379,-540 33.6379,-540 27.6379,-534 27.6379,-528 27.6379,-528 27.6379,-516 27.6379,-516 27.6379,-510 33.6379,-504 39.6379,-504 39.6379,-504 90.3621,-504 90.3621,-504 96.3621,-504 102.3621,-510 102.3621,-516 102.3621,-516 102.3621,-528 102.3621,-528 102.3621,-534 96.3621,-540 90.3621,-540"/>
+<text text-anchor="middle" x="65" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 31&#45;&gt;2 -->
+<g id="edge32" class="edge">
+<title>31-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M81.0211,-503.8118C113.8741,-468.0467 193.0516,-389.4856 279,-360 379.9625,-325.3636 3845.6387,-308.6226 4369.8549,-306.2861"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9155,-309.786 4379.8999,-306.2415 4369.8844,-302.7861 4369.9155,-309.786"/>
+</g>
+<!-- 31&#45;&gt;10 -->
+<g id="edge143" class="edge">
+<title>31-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M102.636,-507.2146C105.4643,-506.1214 108.2761,-505.0401 111,-504 142.5404,-491.9569 178.0604,-478.7234 206.0505,-468.371"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="207.4508,-471.585 215.618,-464.8361 205.0247,-465.0188 207.4508,-471.585"/>
+</g>
+<!-- 32 -->
+<g id="node33" class="node">
+<title>32</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M517.3621,-540C517.3621,-540 466.6379,-540 466.6379,-540 460.6379,-540 454.6379,-534 454.6379,-528 454.6379,-528 454.6379,-516 454.6379,-516 454.6379,-510 460.6379,-504 466.6379,-504 466.6379,-504 517.3621,-504 517.3621,-504 523.3621,-504 529.3621,-510 529.3621,-516 529.3621,-516 529.3621,-528 529.3621,-528 529.3621,-534 523.3621,-540 517.3621,-540"/>
+<text text-anchor="middle" x="492" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 32&#45;&gt;2 -->
+<g id="edge33" class="edge">
+<title>32-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M507.6477,-503.8287C539.7539,-468.0941 617.2245,-389.5851 702,-360 792.1006,-328.5565 3876.5652,-309.2651 4369.7867,-306.3782"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9609,-309.8773 4379.9402,-306.3189 4369.92,-302.8775 4369.9609,-309.8773"/>
+</g>
+<!-- 32&#45;&gt;11 -->
+<g id="edge147" class="edge">
+<title>32-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M529.6387,-507.2216C532.4663,-506.1268 535.2772,-505.0432 538,-504 569.2243,-492.037 604.3601,-478.8556 632.108,-468.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="633.4468,-471.7471 641.5962,-464.9766 631.0034,-465.1874 633.4468,-471.7471"/>
+</g>
+<!-- 33 -->
+<g id="node34" class="node">
+<title>33</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M2199.3621,-540C2199.3621,-540 2148.6379,-540 2148.6379,-540 2142.6379,-540 2136.6379,-534 2136.6379,-528 2136.6379,-528 2136.6379,-516 2136.6379,-516 2136.6379,-510 2142.6379,-504 2148.6379,-504 2148.6379,-504 2199.3621,-504 2199.3621,-504 2205.3621,-504 2211.3621,-510 2211.3621,-516 2211.3621,-516 2211.3621,-528 2211.3621,-528 2211.3621,-534 2205.3621,-540 2199.3621,-540"/>
+<text text-anchor="middle" x="2174" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 33&#45;&gt;2 -->
+<g id="edge34" class="edge">
+<title>33-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2189.8665,-503.9118C2222.4039,-468.3266 2300.8266,-390.073 2386,-360 2481.5283,-326.2709 4028.1426,-309.8284 4369.6227,-306.5994"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8784,-310.0973 4379.845,-306.5033 4369.8126,-303.0976 4369.8784,-310.0973"/>
+</g>
+<!-- 33&#45;&gt;12 -->
+<g id="edge151" class="edge">
+<title>33-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2211.366,-507.2571C2214.2831,-506.1433 2217.1868,-505.0465 2220,-504 2254.156,-491.2939 2292.8653,-477.6388 2322.8022,-467.239"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2324.2971,-470.4252 2332.5992,-463.843 2322.0044,-463.8113 2324.2971,-470.4252"/>
+</g>
+<!-- 34 -->
+<g id="node35" class="node">
+<title>34</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M3471.3621,-540C3471.3621,-540 3420.6379,-540 3420.6379,-540 3414.6379,-540 3408.6379,-534 3408.6379,-528 3408.6379,-528 3408.6379,-516 3408.6379,-516 3408.6379,-510 3414.6379,-504 3420.6379,-504 3420.6379,-504 3471.3621,-504 3471.3621,-504 3477.3621,-504 3483.3621,-510 3483.3621,-516 3483.3621,-516 3483.3621,-528 3483.3621,-528 3483.3621,-534 3477.3621,-540 3471.3621,-540"/>
+<text text-anchor="middle" x="3446" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 34&#45;&gt;2 -->
+<g id="edge35" class="edge">
+<title>34-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3464.0456,-503.9652C3500.5217,-468.8356 3587.2232,-391.8899 3677,-360 3741.3124,-337.1554 4196.3855,-316.0046 4369.4359,-308.6993"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8382,-312.1856 4379.6825,-308.2691 4369.5445,-305.1918 4369.8382,-312.1856"/>
+</g>
+<!-- 34&#45;&gt;13 -->
+<g id="edge155" class="edge">
+<title>34-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3483.5921,-507.0962C3486.4305,-506.0303 3489.2566,-504.9876 3492,-504 3529.9567,-490.3364 3573.3284,-476.1153 3605.9323,-465.699"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3607.2202,-468.9621 3615.6871,-462.5933 3605.0966,-462.292 3607.2202,-468.9621"/>
+</g>
+<!-- 35 -->
+<g id="node36" class="node">
+<title>35</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M4316.3621,-540C4316.3621,-540 4265.6379,-540 4265.6379,-540 4259.6379,-540 4253.6379,-534 4253.6379,-528 4253.6379,-528 4253.6379,-516 4253.6379,-516 4253.6379,-510 4259.6379,-504 4265.6379,-504 4265.6379,-504 4316.3621,-504 4316.3621,-504 4322.3621,-504 4328.3621,-510 4328.3621,-516 4328.3621,-516 4328.3621,-528 4328.3621,-528 4328.3621,-534 4322.3621,-540 4316.3621,-540"/>
+<text text-anchor="middle" x="4291" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 35&#45;&gt;2 -->
+<g id="edge36" class="edge">
+<title>35-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4303.1132,-503.9555C4328.6481,-465.9173 4388.1077,-377.3431 4418.0679,-332.7127"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4421.1516,-334.3986 4423.8193,-324.1451 4415.3397,-330.497 4421.1516,-334.3986"/>
+</g>
+<!-- 35&#45;&gt;14 -->
+<g id="edge159" class="edge">
+<title>35-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4328.7025,-505.8418C4352.5691,-495.6133 4383.6872,-482.2769 4409.5276,-471.2025"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4410.973,-474.391 4418.7857,-467.2347 4408.2155,-467.957 4410.973,-474.391"/>
+</g>
+<!-- 36 -->
+<g id="node37" class="node">
+<title>36</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M939.3621,-540C939.3621,-540 888.6379,-540 888.6379,-540 882.6379,-540 876.6379,-534 876.6379,-528 876.6379,-528 876.6379,-516 876.6379,-516 876.6379,-510 882.6379,-504 888.6379,-504 888.6379,-504 939.3621,-504 939.3621,-504 945.3621,-504 951.3621,-510 951.3621,-516 951.3621,-516 951.3621,-528 951.3621,-528 951.3621,-534 945.3621,-540 939.3621,-540"/>
+<text text-anchor="middle" x="914" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 36&#45;&gt;2 -->
+<g id="edge37" class="edge">
+<title>36-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M929.6524,-503.842C961.767,-468.1313 1039.2518,-389.6632 1124,-360 1203.4343,-332.1968 3908.3609,-310.0782 4369.4829,-306.5053"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.6663,-310.0041 4379.6389,-306.4268 4369.6121,-303.0043 4369.6663,-310.0041"/>
+</g>
+<!-- 36&#45;&gt;15 -->
+<g id="edge163" class="edge">
+<title>36-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M951.6387,-507.2216C954.4663,-506.1268 957.2772,-505.0432 960,-504 991.2243,-492.037 1026.3601,-478.8556 1054.108,-468.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1055.4468,-471.7471 1063.5962,-464.9766 1053.0034,-465.1874 1055.4468,-471.7471"/>
+</g>
+<!-- 37 -->
+<g id="node38" class="node">
+<title>37</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M1783.3621,-540C1783.3621,-540 1732.6379,-540 1732.6379,-540 1726.6379,-540 1720.6379,-534 1720.6379,-528 1720.6379,-528 1720.6379,-516 1720.6379,-516 1720.6379,-510 1726.6379,-504 1732.6379,-504 1732.6379,-504 1783.3621,-504 1783.3621,-504 1789.3621,-504 1795.3621,-510 1795.3621,-516 1795.3621,-516 1795.3621,-528 1795.3621,-528 1795.3621,-534 1789.3621,-540 1783.3621,-540"/>
+<text text-anchor="middle" x="1758" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 37&#45;&gt;2 -->
+<g id="edge38" class="edge">
+<title>37-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1773.7609,-503.8809C1806.0894,-468.2401 1884.0476,-389.8915 1969,-360 2085.3224,-319.0706 3988.4953,-308.0815 4369.8004,-306.2864"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8624,-309.7862 4379.846,-306.2395 4369.8297,-302.7863 4369.8624,-309.7862"/>
+</g>
+<!-- 37&#45;&gt;16 -->
+<g id="edge167" class="edge">
+<title>37-&gt;16</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1795.3637,-507.2507C1798.2812,-506.1384 1801.1858,-505.0436 1804,-504 1838.6369,-491.1552 1877.9409,-477.3863 1908.1723,-466.9669"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1909.3333,-470.2689 1917.6515,-463.7071 1907.0568,-463.6494 1909.3333,-470.2689"/>
+</g>
+<!-- 38 -->
+<g id="node39" class="node">
+<title>38</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M2617.3621,-540C2617.3621,-540 2566.6379,-540 2566.6379,-540 2560.6379,-540 2554.6379,-534 2554.6379,-528 2554.6379,-528 2554.6379,-516 2554.6379,-516 2554.6379,-510 2560.6379,-504 2566.6379,-504 2566.6379,-504 2617.3621,-504 2617.3621,-504 2623.3621,-504 2629.3621,-510 2629.3621,-516 2629.3621,-516 2629.3621,-528 2629.3621,-528 2629.3621,-534 2623.3621,-540 2617.3621,-540"/>
+<text text-anchor="middle" x="2592" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 38&#45;&gt;2 -->
+<g id="edge39" class="edge">
+<title>38-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2609.0114,-503.9508C2643.8343,-468.4358 2727.4545,-390.3022 2816,-360 2890.5389,-334.4912 4074.6245,-312.2843 4369.7636,-307.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9468,-310.624 4379.8843,-306.9503 4369.8248,-303.625 4369.9468,-310.624"/>
+</g>
+<!-- 38&#45;&gt;17 -->
+<g id="edge171" class="edge">
+<title>38-&gt;17</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2629.5941,-507.1018C2632.432,-506.0347 2635.2575,-504.9901 2638,-504 2675.6085,-490.423 2718.5521,-476.2498 2750.9169,-465.832"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2752.1511,-469.1118 2760.6039,-462.7242 2750.0127,-462.4464 2752.1511,-469.1118"/>
+</g>
+<!-- 39 -->
+<g id="node40" class="node">
+<title>39</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M1361.3621,-540C1361.3621,-540 1310.6379,-540 1310.6379,-540 1304.6379,-540 1298.6379,-534 1298.6379,-528 1298.6379,-528 1298.6379,-516 1298.6379,-516 1298.6379,-510 1304.6379,-504 1310.6379,-504 1310.6379,-504 1361.3621,-504 1361.3621,-504 1367.3621,-504 1373.3621,-510 1373.3621,-516 1373.3621,-516 1373.3621,-528 1373.3621,-528 1373.3621,-534 1367.3621,-540 1361.3621,-540"/>
+<text text-anchor="middle" x="1336" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 39&#45;&gt;2 -->
+<g id="edge40" class="edge">
+<title>39-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1352.2237,-503.8509C1385.4788,-468.1563 1465.5588,-389.7157 1552,-360 1689.4825,-312.738 3951.0899,-306.7855 4369.6539,-306.0878"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7804,-309.5877 4379.7747,-306.0713 4369.769,-302.5877 4369.7804,-309.5877"/>
+</g>
+<!-- 39&#45;&gt;18 -->
+<g id="edge175" class="edge">
+<title>39-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1373.6069,-507.1369C1376.4419,-506.0617 1379.2632,-505.0056 1382,-504 1417.5214,-490.9478 1457.9024,-477.0803 1488.8156,-466.6667"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1490.1369,-469.9151 1498.5015,-463.4124 1487.9074,-463.2796 1490.1369,-469.9151"/>
+</g>
+<!-- 40 -->
+<g id="node41" class="node">
+<title>40</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M3049.3621,-540C3049.3621,-540 2998.6379,-540 2998.6379,-540 2992.6379,-540 2986.6379,-534 2986.6379,-528 2986.6379,-528 2986.6379,-516 2986.6379,-516 2986.6379,-510 2992.6379,-504 2998.6379,-504 2998.6379,-504 3049.3621,-504 3049.3621,-504 3055.3621,-504 3061.3621,-510 3061.3621,-516 3061.3621,-516 3061.3621,-528 3061.3621,-528 3061.3621,-534 3055.3621,-540 3049.3621,-540"/>
+<text text-anchor="middle" x="3024" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 40&#45;&gt;2 -->
+<g id="edge41" class="edge">
+<title>40-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3040.0709,-503.7746C3072.657,-468.3068 3150.6146,-390.7893 3235,-360 3341.5629,-321.119 4133.2149,-309.332 4369.5661,-306.6611"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7743,-310.1591 4379.7347,-306.548 4369.6964,-303.1596 4369.7743,-310.1591"/>
+</g>
+<!-- 40&#45;&gt;19 -->
+<g id="edge179" class="edge">
+<title>40-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3061.6387,-507.2216C3064.4663,-506.1268 3067.2772,-505.0432 3070,-504 3101.2243,-492.037 3136.3601,-478.8556 3164.108,-468.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3165.4468,-471.7471 3173.5962,-464.9766 3163.0034,-465.1874 3165.4468,-471.7471"/>
+</g>
+<!-- 41 -->
+<g id="node42" class="node">
+<title>41</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M3850.3621,-540C3850.3621,-540 3799.6379,-540 3799.6379,-540 3793.6379,-540 3787.6379,-534 3787.6379,-528 3787.6379,-528 3787.6379,-516 3787.6379,-516 3787.6379,-510 3793.6379,-504 3799.6379,-504 3799.6379,-504 3850.3621,-504 3850.3621,-504 3856.3621,-504 3862.3621,-510 3862.3621,-516 3862.3621,-516 3862.3621,-528 3862.3621,-528 3862.3621,-534 3856.3621,-540 3850.3621,-540"/>
+<text text-anchor="middle" x="3825" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 41&#45;&gt;2 -->
+<g id="edge42" class="edge">
+<title>41-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3838.6158,-503.7922C3865.7366,-469.0619 3930.2792,-393.8073 4004,-360 4067.5809,-330.8427 4265.0401,-315.6196 4369.556,-309.4231"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8997,-312.9091 4379.6794,-308.834 4369.4929,-305.921 4369.8997,-312.9091"/>
+</g>
+<!-- 41&#45;&gt;20 -->
+<g id="edge183" class="edge">
+<title>41-&gt;20</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3862.5243,-506.9064C3889.1426,-496.1996 3925.1475,-481.7172 3954.173,-470.0422"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3955.7537,-473.1789 3963.7252,-466.1999 3953.1415,-466.6846 3955.7537,-473.1789"/>
+</g>
+<!-- 42 -->
+<g id="node43" class="node">
+<title>42</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M6949.3621,-540C6949.3621,-540 6898.6379,-540 6898.6379,-540 6892.6379,-540 6886.6379,-534 6886.6379,-528 6886.6379,-528 6886.6379,-516 6886.6379,-516 6886.6379,-510 6892.6379,-504 6898.6379,-504 6898.6379,-504 6949.3621,-504 6949.3621,-504 6955.3621,-504 6961.3621,-510 6961.3621,-516 6961.3621,-516 6961.3621,-528 6961.3621,-528 6961.3621,-534 6955.3621,-540 6949.3621,-540"/>
+<text text-anchor="middle" x="6924" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 42&#45;&gt;2 -->
+<g id="edge43" class="edge">
+<title>42-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6907.4816,-503.8846C6873.6399,-468.2506 6792.2345,-389.9135 6705,-360 6598.2548,-323.3961 4865.2072,-309.0587 4502.3103,-306.4506"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.252,-302.9502 4492.2273,-306.3787 4502.202,-309.9501 4502.252,-302.9502"/>
+</g>
+<!-- 42&#45;&gt;21 -->
+<g id="edge187" class="edge">
+<title>42-&gt;21</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6886.364,-507.2146C6883.5357,-506.1214 6880.7239,-505.0401 6878,-504 6846.4596,-491.9569 6810.9396,-478.7234 6782.9495,-468.371"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6783.9753,-465.0188 6773.382,-464.8361 6781.5492,-471.585 6783.9753,-465.0188"/>
+</g>
+<!-- 43 -->
+<g id="node44" class="node">
+<title>43</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M5252.3621,-540C5252.3621,-540 5201.6379,-540 5201.6379,-540 5195.6379,-540 5189.6379,-534 5189.6379,-528 5189.6379,-528 5189.6379,-516 5189.6379,-516 5189.6379,-510 5195.6379,-504 5201.6379,-504 5201.6379,-504 5252.3621,-504 5252.3621,-504 5258.3621,-504 5264.3621,-510 5264.3621,-516 5264.3621,-516 5264.3621,-528 5264.3621,-528 5264.3621,-534 5258.3621,-540 5252.3621,-540"/>
+<text text-anchor="middle" x="5227" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 43&#45;&gt;2 -->
+<g id="edge44" class="edge">
+<title>43-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5199.1863,-503.8965C5167.8414,-484.1108 5114.8702,-452.5027 5066,-432 4871.3069,-350.3198 4620.0956,-320.5425 4502.3875,-310.5697"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3541,-307.0551 4492.0999,-309.7199 4501.7778,-314.0313 4502.3541,-307.0551"/>
+</g>
+<!-- 43&#45;&gt;22 -->
+<g id="edge191" class="edge">
+<title>43-&gt;22</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5189.4079,-507.0962C5186.5695,-506.0303 5183.7434,-504.9876 5181,-504 5143.0433,-490.3364 5099.6716,-476.1153 5067.0677,-465.699"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5067.9034,-462.292 5057.3129,-462.5933 5065.7798,-468.9621 5067.9034,-462.292"/>
+</g>
+<!-- 44 -->
+<g id="node45" class="node">
+<title>44</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M6526.3621,-540C6526.3621,-540 6475.6379,-540 6475.6379,-540 6469.6379,-540 6463.6379,-534 6463.6379,-528 6463.6379,-528 6463.6379,-516 6463.6379,-516 6463.6379,-510 6469.6379,-504 6475.6379,-504 6475.6379,-504 6526.3621,-504 6526.3621,-504 6532.3621,-504 6538.3621,-510 6538.3621,-516 6538.3621,-516 6538.3621,-528 6538.3621,-528 6538.3621,-534 6532.3621,-540 6526.3621,-540"/>
+<text text-anchor="middle" x="6501" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 44&#45;&gt;2 -->
+<g id="edge45" class="edge">
+<title>44-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6484.5616,-503.926C6450.8826,-468.3664 6369.8629,-390.1566 6283,-360 6197.3704,-330.2716 4822.9084,-310.9407 4502.4288,-306.8239"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.4085,-303.3235 4492.3645,-306.6952 4502.3189,-310.3229 4502.4085,-303.3235"/>
+</g>
+<!-- 44&#45;&gt;23 -->
+<g id="edge195" class="edge">
+<title>44-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6463.3613,-507.2216C6460.5337,-506.1268 6457.7228,-505.0432 6455,-504 6423.7757,-492.037 6388.6399,-478.8556 6360.892,-468.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6361.9966,-465.1874 6351.4038,-464.9766 6359.5532,-471.7471 6361.9966,-465.1874"/>
+</g>
+<!-- 45 -->
+<g id="node46" class="node">
+<title>45</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M5678.3621,-540C5678.3621,-540 5627.6379,-540 5627.6379,-540 5621.6379,-540 5615.6379,-534 5615.6379,-528 5615.6379,-528 5615.6379,-516 5615.6379,-516 5615.6379,-510 5621.6379,-504 5627.6379,-504 5627.6379,-504 5678.3621,-504 5678.3621,-504 5684.3621,-504 5690.3621,-510 5690.3621,-516 5690.3621,-516 5690.3621,-528 5690.3621,-528 5690.3621,-534 5684.3621,-540 5678.3621,-540"/>
+<text text-anchor="middle" x="5653" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 45&#45;&gt;2 -->
+<g id="edge46" class="edge">
+<title>45-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5635.8544,-503.837C5601.149,-468.48 5518.4165,-391.1498 5431,-360 5344.0617,-329.0206 4710.6764,-312.1665 4502.273,-307.4149"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.163,-303.9116 4492.0864,-307.1846 4502.0047,-310.9098 4502.163,-303.9116"/>
+</g>
+<!-- 45&#45;&gt;24 -->
+<g id="edge199" class="edge">
+<title>45-&gt;24</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5615.3718,-507.1942C5612.5417,-506.1057 5609.7274,-505.031 5607,-504 5574.36,-491.6612 5537.496,-478.2094 5508.7242,-467.8183"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5509.8893,-464.5179 5499.2949,-464.4177 5507.5145,-471.1027 5509.8893,-464.5179"/>
+</g>
+<!-- 46 -->
+<g id="node47" class="node">
+<title>46</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M7794.3621,-540C7794.3621,-540 7743.6379,-540 7743.6379,-540 7737.6379,-540 7731.6379,-534 7731.6379,-528 7731.6379,-528 7731.6379,-516 7731.6379,-516 7731.6379,-510 7737.6379,-504 7743.6379,-504 7743.6379,-504 7794.3621,-504 7794.3621,-504 7800.3621,-504 7806.3621,-510 7806.3621,-516 7806.3621,-516 7806.3621,-528 7806.3621,-528 7806.3621,-534 7800.3621,-540 7794.3621,-540"/>
+<text text-anchor="middle" x="7769" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 46&#45;&gt;2 -->
+<g id="edge47" class="edge">
+<title>46-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7752.8739,-503.842C7719.8132,-468.1313 7640.1731,-389.6632 7554,-360 7479.2999,-334.2862 4947.4291,-310.5598 4502.4402,-306.5834"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3498,-303.0826 4492.319,-306.4932 4502.2874,-310.0823 4502.3498,-303.0826"/>
+</g>
+<!-- 46&#45;&gt;25 -->
+<g id="edge203" class="edge">
+<title>46-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7731.3666,-507.2078C7728.5378,-506.1161 7725.7251,-505.037 7723,-504 7691.142,-491.8766 7655.2356,-478.5911 7627.0034,-468.2316"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7627.9503,-464.8511 7617.3566,-464.6961 7625.5414,-471.4236 7627.9503,-464.8511"/>
+</g>
+<!-- 47 -->
+<g id="node48" class="node">
+<title>47</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M6104.3621,-540C6104.3621,-540 6053.6379,-540 6053.6379,-540 6047.6379,-540 6041.6379,-534 6041.6379,-528 6041.6379,-528 6041.6379,-516 6041.6379,-516 6041.6379,-510 6047.6379,-504 6053.6379,-504 6053.6379,-504 6104.3621,-504 6104.3621,-504 6110.3621,-504 6116.3621,-510 6116.3621,-516 6116.3621,-516 6116.3621,-528 6116.3621,-528 6116.3621,-534 6110.3621,-540 6104.3621,-540"/>
+<text text-anchor="middle" x="6079" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 47&#45;&gt;2 -->
+<g id="edge48" class="edge">
+<title>47-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6062.07,-503.9869C6027.4126,-468.5368 5944.1827,-390.5141 5856,-360 5727.3772,-315.4923 4765.3364,-307.5914 4502.2982,-306.2584"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1509,-302.7578 4492.1337,-306.2085 4502.1164,-309.7577 4502.1509,-302.7578"/>
+</g>
+<!-- 47&#45;&gt;26 -->
+<g id="edge207" class="edge">
+<title>47-&gt;26</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6041.3931,-507.1369C6038.5581,-506.0617 6035.7368,-505.0056 6033,-504 5997.4786,-490.9478 5957.0976,-477.0803 5926.1844,-466.6667"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5927.0926,-463.2796 5916.4985,-463.4124 5924.8631,-469.9151 5927.0926,-463.2796"/>
+</g>
+<!-- 48 -->
+<g id="node49" class="node">
+<title>48</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M7376.3621,-540C7376.3621,-540 7325.6379,-540 7325.6379,-540 7319.6379,-540 7313.6379,-534 7313.6379,-528 7313.6379,-528 7313.6379,-516 7313.6379,-516 7313.6379,-510 7319.6379,-504 7325.6379,-504 7325.6379,-504 7376.3621,-504 7376.3621,-504 7382.3621,-504 7388.3621,-510 7388.3621,-516 7388.3621,-516 7388.3621,-528 7388.3621,-528 7388.3621,-534 7382.3621,-540 7376.3621,-540"/>
+<text text-anchor="middle" x="7351" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 48&#45;&gt;2 -->
+<g id="edge49" class="edge">
+<title>48-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7334.3035,-503.8542C7300.1038,-468.1655 7217.8712,-389.735 7130,-360 7001.8357,-316.6301 4904.501,-307.5449 4502.3717,-306.1988"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.0886,-302.698 4492.0771,-306.1648 4502.0654,-309.6979 4502.0886,-302.698"/>
+</g>
+<!-- 48&#45;&gt;27 -->
+<g id="edge211" class="edge">
+<title>48-&gt;27</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7313.3613,-507.2216C7310.5337,-506.1268 7307.7228,-505.0432 7305,-504 7273.7757,-492.037 7238.6399,-478.8556 7210.892,-468.5108"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7211.9966,-465.1874 7201.4038,-464.9766 7209.5532,-471.7471 7211.9966,-465.1874"/>
+</g>
+<!-- 49 -->
+<g id="node50" class="node">
+<title>49</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M8226.3621,-540C8226.3621,-540 8175.6379,-540 8175.6379,-540 8169.6379,-540 8163.6379,-534 8163.6379,-528 8163.6379,-528 8163.6379,-516 8163.6379,-516 8163.6379,-510 8169.6379,-504 8175.6379,-504 8175.6379,-504 8226.3621,-504 8226.3621,-504 8232.3621,-504 8238.3621,-510 8238.3621,-516 8238.3621,-516 8238.3621,-528 8238.3621,-528 8238.3621,-534 8232.3621,-540 8226.3621,-540"/>
+<text text-anchor="middle" x="8201" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 49&#45;&gt;2 -->
+<g id="edge50" class="edge">
+<title>49-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8183.5671,-503.8082C8147.892,-468.0367 8062.2771,-389.4647 7972,-360 7886.3144,-332.0338 4980.9411,-309.926 4502.4074,-306.4704"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.2386,-302.9692 4492.2136,-306.397 4502.1881,-309.969 4502.2386,-302.9692"/>
+</g>
+<!-- 49&#45;&gt;28 -->
+<g id="edge215" class="edge">
+<title>49-&gt;28</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8163.4079,-507.0962C8160.5695,-506.0303 8157.7434,-504.9876 8155,-504 8117.0433,-490.3364 8073.6716,-476.1153 8041.0677,-465.699"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8041.9034,-462.292 8031.3129,-462.5933 8039.7798,-468.9621 8041.9034,-462.292"/>
+</g>
+<!-- 50 -->
+<g id="node51" class="node">
+<title>50</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M8648.3621,-540C8648.3621,-540 8597.6379,-540 8597.6379,-540 8591.6379,-540 8585.6379,-534 8585.6379,-528 8585.6379,-528 8585.6379,-516 8585.6379,-516 8585.6379,-510 8591.6379,-504 8597.6379,-504 8597.6379,-504 8648.3621,-504 8648.3621,-504 8654.3621,-504 8660.3621,-510 8660.3621,-516 8660.3621,-516 8660.3621,-528 8660.3621,-528 8660.3621,-534 8654.3621,-540 8648.3621,-540"/>
+<text text-anchor="middle" x="8623" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 50&#45;&gt;2 -->
+<g id="edge51" class="edge">
+<title>50-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8606.4135,-503.8075C8572.4304,-468.0347 8490.6759,-389.4606 8403,-360 8306.6455,-327.6232 5013.1043,-309.0321 4502.2793,-306.3405"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1471,-302.8398 4492.1288,-306.2872 4502.1102,-309.8397 4502.1471,-302.8398"/>
+</g>
+<!-- 50&#45;&gt;29 -->
+<g id="edge219" class="edge">
+<title>50-&gt;29</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8585.3886,-507.1492C8582.5547,-506.0711 8579.7348,-505.0111 8577,-504 8542.0291,-491.0714 8502.3165,-477.2526 8471.844,-466.8306"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8472.8873,-463.4885 8462.2928,-463.5717 8470.6268,-470.1135 8472.8873,-463.4885"/>
+</g>
+<!-- 51 -->
+<g id="node52" class="node">
+<title>51</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M9087.3621,-540C9087.3621,-540 9036.6379,-540 9036.6379,-540 9030.6379,-540 9024.6379,-534 9024.6379,-528 9024.6379,-528 9024.6379,-516 9024.6379,-516 9024.6379,-510 9030.6379,-504 9036.6379,-504 9036.6379,-504 9087.3621,-504 9087.3621,-504 9093.3621,-504 9099.3621,-510 9099.3621,-516 9099.3621,-516 9099.3621,-528 9099.3621,-528 9099.3621,-534 9093.3621,-540 9087.3621,-540"/>
+<text text-anchor="middle" x="9062" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 51&#45;&gt;2 -->
+<g id="edge52" class="edge">
+<title>51-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M9044.0153,-503.7778C9007.2345,-467.9517 8919.0842,-389.2864 8827,-360 8719.3598,-325.7661 5046.0148,-308.6302 4502.8356,-306.2811"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.4532,-302.7795 4492.4382,-306.2363 4502.423,-309.7794 4502.4532,-302.7795"/>
+</g>
+<!-- 51&#45;&gt;30 -->
+<g id="edge223" class="edge">
+<title>51-&gt;30</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M9024.4079,-507.0962C9021.5695,-506.0303 9018.7434,-504.9876 9016,-504 8978.0433,-490.3364 8934.6716,-476.1153 8902.0677,-465.699"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8902.9034,-462.292 8892.3129,-462.5933 8900.7798,-468.9621 8902.9034,-462.292"/>
+</g>
+<!-- 52&#45;&gt;2 -->
+<g id="edge53" class="edge">
+<title>52-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M398.6566,-363.5579C403.4139,-362.1077 408.2796,-360.8565 413,-360 615.7478,-323.2131 3863.6568,-308.3599 4369.8896,-306.2637"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9658,-309.7635 4379.9513,-306.2222 4369.9369,-302.7635 4369.9658,-309.7635"/>
+</g>
+<!-- 53&#45;&gt;2 -->
+<g id="edge54" class="edge">
+<title>53-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M820.6579,-363.565C825.4149,-362.1136 830.2803,-360.8602 835,-360 1015.5105,-327.1013 3893.3919,-309.1288 4369.5228,-306.3738"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.6879,-309.873 4379.6676,-306.3153 4369.6475,-302.8732 4369.6879,-309.873"/>
+</g>
+<!-- 54&#45;&gt;2 -->
+<g id="edge55" class="edge">
+<title>54-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2498.6688,-363.6238C2503.4241,-362.1628 2508.286,-360.891 2513,-360 2698.1616,-325.001 4051.4027,-309.7427 4369.2852,-306.6199"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7475,-310.1157 4379.7128,-306.5182 4369.6792,-303.116 4369.7475,-310.1157"/>
+</g>
+<!-- 55&#45;&gt;2 -->
+<g id="edge56" class="edge">
+<title>55-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3795.7181,-371.2594C3816.2269,-367.5586 3842.498,-363.1044 3866,-360 4047.4407,-336.0333 4262.7354,-318.6084 4369.3338,-310.7127"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9001,-314.1806 4379.6161,-309.9557 4369.3861,-307.1995 4369.9001,-314.1806"/>
+</g>
+<!-- 56&#45;&gt;2 -->
+<g id="edge57" class="edge">
+<title>56-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4483.8501,-359.8314C4476.3283,-351.3694 4467.2435,-341.1489 4459.0196,-331.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4461.627,-329.5621 4452.3673,-324.4133 4456.3951,-334.2127 4461.627,-329.5621"/>
+</g>
+<!-- 57&#45;&gt;2 -->
+<g id="edge58" class="edge">
+<title>57-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1242.6595,-363.5739C1247.4163,-362.1211 1252.2811,-360.8649 1257,-360 1415.4125,-330.9658 3927.7125,-309.9853 4369.8195,-306.5089"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9036,-310.0085 4379.8758,-306.43 4369.8486,-303.0087 4369.9036,-310.0085"/>
+</g>
+<!-- 58&#45;&gt;2 -->
+<g id="edge59" class="edge">
+<title>58-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2080.6646,-363.6013C2085.4205,-362.1439 2090.2838,-360.8792 2095,-360 2323.4801,-317.4056 4011.8032,-307.8193 4369.5232,-306.2584"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.731,-309.7576 4379.7158,-306.2145 4369.7008,-302.7577 4369.731,-309.7576"/>
+</g>
+<!-- 59&#45;&gt;2 -->
+<g id="edge60" class="edge">
+<title>59-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2930.6758,-363.6602C2935.4299,-362.1933 2940.2897,-360.9102 2945,-360 3085.8462,-332.7841 4099.4084,-312.2344 4369.8313,-307.1934"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9577,-310.6917 4379.8909,-307.0066 4369.8277,-303.6929 4369.9577,-310.6917"/>
+</g>
+<!-- 60&#45;&gt;2 -->
+<g id="edge61" class="edge">
+<title>60-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1664.6617,-363.5856C1669.4181,-362.1309 1674.2823,-360.871 1679,-360 1815.308,-334.834 3962.0051,-311.0006 4369.5026,-306.6908"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.6863,-310.1891 4379.6488,-306.5837 4369.6124,-303.1895 4369.6863,-310.1891"/>
+</g>
+<!-- 61&#45;&gt;2 -->
+<g id="edge62" class="edge">
+<title>61-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3352.6884,-363.7242C3357.4404,-362.2468 3362.2963,-360.9438 3367,-360 3560.2967,-321.2164 4167.5609,-309.6268 4369.7648,-306.7957"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.9894,-310.2931 4379.9403,-306.6559 4369.8931,-303.2937 4369.9894,-310.2931"/>
+</g>
+<!-- 62&#45;&gt;2 -->
+<g id="edge63" class="edge">
+<title>62-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4107.8121,-364.2576C4112.544,-362.693 4117.3612,-361.2237 4122,-360 4206.2754,-337.7674 4305.7656,-322.4456 4369.813,-313.9501"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4370.3192,-317.4138 4379.7802,-312.6452 4369.4104,-310.473 4370.3192,-317.4138"/>
+</g>
+<!-- 63&#45;&gt;2 -->
+<g id="edge64" class="edge">
+<title>63-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6594.3336,-363.6108C6589.578,-362.1519 6584.7153,-360.8842 6580,-360 6371.8996,-320.9768 4841.0506,-308.6685 4502.2586,-306.4089"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1384,-302.9081 4492.1155,-306.3419 4502.0921,-309.9079 4502.1384,-302.9081"/>
+</g>
+<!-- 64&#45;&gt;2 -->
+<g id="edge65" class="edge">
+<title>64-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4664.3958,-368.2898C4622.8781,-356.9668 4553.3857,-338.0143 4501.9355,-323.9824"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.7935,-320.5886 4492.2249,-321.3341 4500.9516,-327.342 4502.7935,-320.5886"/>
+</g>
+<!-- 65&#45;&gt;2 -->
+<g id="edge66" class="edge">
+<title>65-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6172.3284,-363.6385C6167.5736,-362.1751 6162.7125,-360.8988 6158,-360 5993.4891,-328.6253 4798.7886,-310.8164 4502.4018,-306.8511"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.2862,-303.3493 4492.2405,-306.7158 4502.193,-310.3487 4502.2862,-303.3493"/>
+</g>
+<!-- 66&#45;&gt;2 -->
+<g id="edge67" class="edge">
+<title>66-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5320.3011,-363.7758C5315.5508,-362.29 5310.6982,-360.9708 5306,-360 5152.5198,-328.2848 4677.886,-312.5409 4502.2447,-307.6853"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.201,-304.1829 4492.109,-307.4081 4502.0095,-311.1803 4502.201,-304.1829"/>
+</g>
+<!-- 67&#45;&gt;2 -->
+<g id="edge68" class="edge">
+<title>67-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7444.3396,-363.5787C7439.583,-362.125 7434.7184,-360.8674 7430,-360 7281.2904,-332.6635 4929.6784,-310.4109 4502.3449,-306.5825"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3464,-303.0824 4492.3155,-306.4928 4502.2838,-310.0822 4502.3464,-303.0824"/>
+</g>
+<!-- 68&#45;&gt;2 -->
+<g id="edge69" class="edge">
+<title>68-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5746.3195,-363.6847C5741.5661,-362.2137 5736.7079,-360.923 5732,-360 5611.1564,-336.308 4750.6786,-313.6797 4502.7142,-307.5937"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.495,-304.0873 4492.4124,-307.3417 4502.3238,-311.0852 4502.495,-304.0873"/>
+</g>
+<!-- 69&#45;&gt;2 -->
+<g id="edge70" class="edge">
+<title>69-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7017.3371,-363.5921C7012.5809,-362.1363 7007.7171,-360.8744 7003,-360 6751.0138,-313.288 4880.2161,-306.9238 4502.3987,-306.1125"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1874,-302.6122 4492.1801,-306.0911 4502.1727,-309.6121 4502.1874,-302.6122"/>
+</g>
+<!-- 70&#45;&gt;2 -->
+<g id="edge71" class="edge">
+<title>70-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7862.3414,-363.5687C7857.5845,-362.1167 7852.7194,-360.8621 7848,-360 7677.378,-328.8303 4962.9851,-309.4947 4502.2198,-306.4295"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.0967,-302.9287 4492.0736,-306.3622 4502.0502,-309.9285 4502.0967,-302.9287"/>
+</g>
+<!-- 71&#45;&gt;2 -->
+<g id="edge72" class="edge">
+<title>71-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8294.3429,-363.5607C8289.5857,-362.11 8284.7201,-360.858 8280,-360 8086.6868,-324.8626 4995.8166,-308.6738 4502.231,-306.3072"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.0871,-302.8066 4492.0705,-306.2587 4502.0536,-309.8065 4502.0871,-302.8066"/>
+</g>
+<!-- 72&#45;&gt;2 -->
+<g id="edge73" class="edge">
+<title>72-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8716.344,-363.5545C8711.5867,-362.1048 8706.7207,-360.8547 8702,-360 8486.4875,-320.9822 5026.7039,-307.9644 4502.3663,-306.212"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3297,-302.7119 4492.3181,-306.1786 4502.3064,-309.7119 4502.3297,-302.7119"/>
+</g>
+<!-- 73 -->
+<g id="node74" class="node">
+<title>73</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M264.6605,-684C264.6605,-684 171.3395,-684 171.3395,-684 165.3395,-684 159.3395,-678 159.3395,-672 159.3395,-672 159.3395,-660 159.3395,-660 159.3395,-654 165.3395,-648 171.3395,-648 171.3395,-648 264.6605,-648 264.6605,-648 270.6605,-648 276.6605,-654 276.6605,-660 276.6605,-660 276.6605,-672 276.6605,-672 276.6605,-678 270.6605,-684 264.6605,-684"/>
+<text text-anchor="middle" x="218" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 73&#45;&gt;2 -->
+<g id="edge74" class="edge">
+<title>73-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M159.1165,-658.4176C123.9578,-651.3486 80.2193,-637.8059 49,-612 13.896,-582.9831 0,-567.5442 0,-522 0,-522 0,-522 0,-450 0,-350.4951 107.7485,-381.0566 205,-360 417.1923,-314.0568 3846.4353,-306.9161 4369.3578,-306.093"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7461,-309.5925 4379.7406,-306.0769 4369.7351,-302.5925 4369.7461,-309.5925"/>
+</g>
+<!-- 73&#45;&gt;7 -->
+<g id="edge99" class="edge">
+<title>73-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M276.7472,-662.3339C348.1637,-658.0474 472.3687,-651.1402 579,-648 1020.2713,-635.005 4112.1827,-650.0777 4552,-612 4564.0174,-610.9596 4576.7086,-609.344 4589.0173,-607.4987"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.9031,-610.9029 4599.2435,-605.9022 4588.8233,-603.9867 4589.9031,-610.9029"/>
+</g>
+<!-- 73&#45;&gt;8 -->
+<g id="edge120" class="edge">
+<title>73-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M276.747,-662.3268C348.1633,-658.0334 472.3681,-651.1193 579,-648 806.8169,-641.3358 4414.4356,-647.9724 4730.5276,-611.6833"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.2785,-615.114 4740.7257,-610.3181 4730.3497,-608.1759 4731.2785,-615.114"/>
+</g>
+<!-- 73&#45;&gt;10 -->
+<g id="edge144" class="edge">
+<title>73-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M221.1745,-647.9555C227.7965,-610.3144 243.1246,-523.1867 251.0522,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="254.5221,-478.6003 252.8078,-468.1451 247.628,-477.3874 254.5221,-478.6003"/>
+</g>
+<!-- 73&#45;&gt;31 -->
+<g id="edge226" class="edge">
+<title>73-&gt;31</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M158.9371,-653.0633C119.8537,-643.1689 73.7199,-628.459 62,-612 49.317,-594.1884 51.388,-568.9752 55.8772,-549.7646"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="59.2686,-550.6303 58.4604,-540.0663 52.5044,-548.8286 59.2686,-550.6303"/>
+</g>
+<!-- 94 -->
+<g id="node95" class="node">
+<title>94</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M335.6488,-540C335.6488,-540 282.3512,-540 282.3512,-540 276.3512,-540 270.3512,-534 270.3512,-528 270.3512,-528 270.3512,-516 270.3512,-516 270.3512,-510 276.3512,-504 282.3512,-504 282.3512,-504 335.6488,-504 335.6488,-504 341.6488,-504 347.6488,-510 347.6488,-516 347.6488,-516 347.6488,-528 347.6488,-528 347.6488,-534 341.6488,-540 335.6488,-540"/>
+<text text-anchor="middle" x="309" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 73&#45;&gt;94 -->
+<g id="edge415" class="edge">
+<title>73-&gt;94</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M225.2882,-647.6585C233.1129,-628.9184 246.5268,-599.3382 262,-576 268.5202,-566.1656 276.6682,-556.1988 284.3401,-547.5503"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="287.0504,-549.7722 291.1913,-540.0201 281.8727,-545.0613 287.0504,-549.7722"/>
+</g>
+<!-- 95 -->
+<g id="node96" class="node">
+<title>95</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M201.6762,-540C201.6762,-540 132.3238,-540 132.3238,-540 126.3238,-540 120.3238,-534 120.3238,-528 120.3238,-528 120.3238,-516 120.3238,-516 120.3238,-510 126.3238,-504 132.3238,-504 132.3238,-504 201.6762,-504 201.6762,-504 207.6762,-504 213.6762,-510 213.6762,-516 213.6762,-516 213.6762,-528 213.6762,-528 213.6762,-534 207.6762,-540 201.6762,-540"/>
+<text text-anchor="middle" x="167" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 73&#45;&gt;95 -->
+<g id="edge417" class="edge">
+<title>73-&gt;95</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M207.8031,-647.9217C202.2925,-637.6247 195.6787,-624.3503 191,-612 183.3378,-591.774 177.1308,-568.1157 172.95,-550.1326"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="176.34,-549.2547 170.7268,-540.269 169.5113,-550.7939 176.34,-549.2547"/>
+</g>
+<!-- 136 -->
+<g id="node137" class="node">
+<title>136</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M126.5931,-612C126.5931,-612 83.4069,-612 83.4069,-612 77.4069,-612 71.4069,-606 71.4069,-600 71.4069,-600 71.4069,-588 71.4069,-588 71.4069,-582 77.4069,-576 83.4069,-576 83.4069,-576 126.5931,-576 126.5931,-576 132.5931,-576 138.5931,-582 138.5931,-588 138.5931,-588 138.5931,-600 138.5931,-600 138.5931,-606 132.5931,-612 126.5931,-612"/>
+<text text-anchor="middle" x="105" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 73&#45;&gt;136 -->
+<g id="edge498" class="edge">
+<title>73-&gt;136</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M189.4853,-647.8314C175.1658,-638.7074 157.6376,-627.539 142.2662,-617.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="143.8199,-614.5847 133.5055,-612.1628 140.0583,-620.4882 143.8199,-614.5847"/>
+</g>
+<!-- 243 -->
+<g id="node244" class="node">
+<title>243</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M348.7975,-612C348.7975,-612 283.2025,-612 283.2025,-612 277.2025,-612 271.2025,-606 271.2025,-600 271.2025,-600 271.2025,-588 271.2025,-588 271.2025,-582 277.2025,-576 283.2025,-576 283.2025,-576 348.7975,-576 348.7975,-576 354.7975,-576 360.7975,-582 360.7975,-588 360.7975,-588 360.7975,-600 360.7975,-600 360.7975,-606 354.7975,-612 348.7975,-612"/>
+<text text-anchor="middle" x="316" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 73&#45;&gt;243 -->
+<g id="edge645" class="edge">
+<title>73-&gt;243</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M242.7295,-647.8314C254.9162,-638.8779 269.7823,-627.9558 282.9312,-618.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="285.2918,-620.9042 291.2784,-612.1628 281.1473,-615.263 285.2918,-620.9042"/>
+</g>
+<!-- 74 -->
+<g id="node75" class="node">
+<title>74</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M693.6605,-684C693.6605,-684 600.3395,-684 600.3395,-684 594.3395,-684 588.3395,-678 588.3395,-672 588.3395,-672 588.3395,-660 588.3395,-660 588.3395,-654 594.3395,-648 600.3395,-648 600.3395,-648 693.6605,-648 693.6605,-648 699.6605,-648 705.6605,-654 705.6605,-660 705.6605,-660 705.6605,-672 705.6605,-672 705.6605,-678 699.6605,-684 693.6605,-684"/>
+<text text-anchor="middle" x="647" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 74&#45;&gt;2 -->
+<g id="edge75" class="edge">
+<title>74-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M588.2023,-659.7433C551.2691,-653.1568 504.6194,-639.6553 472,-612 437.8883,-583.0795 427,-566.7214 427,-522 427,-522 427,-522 427,-450 427,-351.3083 533.5963,-381.1278 630,-360 819.9285,-318.3754 3878.2715,-307.643 4369.6223,-306.1844"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7499,-309.6841 4379.7396,-306.1546 4369.7293,-302.6841 4369.7499,-309.6841"/>
+</g>
+<!-- 74&#45;&gt;7 -->
+<g id="edge100" class="edge">
+<title>74-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M705.826,-662.254C775.6967,-657.9756 895.7886,-651.1605 999,-648 1788.2262,-623.8327 3765.3831,-680.5266 4552,-612 4564.0168,-610.9531 4576.7078,-609.3343 4589.0164,-607.4877"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.9024,-610.8918 4599.2425,-605.8905 4588.8221,-603.9757 4589.9024,-610.8918"/>
+</g>
+<!-- 74&#45;&gt;8 -->
+<g id="edge121" class="edge">
+<title>74-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M705.8257,-662.2452C775.6961,-657.9585 895.7879,-651.1353 999,-648 1203.5699,-641.7858 4440.1561,-644.5095 4730.6732,-611.6509"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.2735,-615.102 4740.7252,-610.3148 4730.3512,-608.163 4731.2735,-615.102"/>
+</g>
+<!-- 74&#45;&gt;11 -->
+<g id="edge148" class="edge">
+<title>74-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M649.9239,-647.9555C656.0231,-610.3144 670.141,-523.1867 677.4428,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="680.9152,-478.5762 679.0598,-468.1451 674.0053,-477.4565 680.9152,-478.5762"/>
+</g>
+<!-- 74&#45;&gt;32 -->
+<g id="edge228" class="edge">
+<title>74-&gt;32</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M587.9174,-654.0281C546.5697,-644.3118 496.5662,-629.4009 484,-612 471.1552,-594.2133 474.7336,-568.9979 480.6239,-549.78"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="484.0178,-550.672 483.9418,-540.0775 477.3943,-548.407 484.0178,-550.672"/>
+</g>
+<!-- 96 -->
+<g id="node97" class="node">
+<title>96</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M762.6488,-540C762.6488,-540 709.3512,-540 709.3512,-540 703.3512,-540 697.3512,-534 697.3512,-528 697.3512,-528 697.3512,-516 697.3512,-516 697.3512,-510 703.3512,-504 709.3512,-504 709.3512,-504 762.6488,-504 762.6488,-504 768.6488,-504 774.6488,-510 774.6488,-516 774.6488,-516 774.6488,-528 774.6488,-528 774.6488,-534 768.6488,-540 762.6488,-540"/>
+<text text-anchor="middle" x="736" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 74&#45;&gt;96 -->
+<g id="edge419" class="edge">
+<title>74-&gt;96</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M652.2516,-647.7779C658.1976,-628.8711 669.0408,-598.918 684,-576 690.6576,-565.8003 699.397,-555.8413 707.8062,-547.3102"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="710.3583,-549.7097 715.0506,-540.2106 705.4588,-544.7103 710.3583,-549.7097"/>
+</g>
+<!-- 97 -->
+<g id="node98" class="node">
+<title>97</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M628.6762,-540C628.6762,-540 559.3238,-540 559.3238,-540 553.3238,-540 547.3238,-534 547.3238,-528 547.3238,-528 547.3238,-516 547.3238,-516 547.3238,-510 553.3238,-504 559.3238,-504 559.3238,-504 628.6762,-504 628.6762,-504 634.6762,-504 640.6762,-510 640.6762,-516 640.6762,-516 640.6762,-528 640.6762,-528 640.6762,-534 634.6762,-540 628.6762,-540"/>
+<text text-anchor="middle" x="594" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 74&#45;&gt;97 -->
+<g id="edge421" class="edge">
+<title>74-&gt;97</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M633.3183,-647.8898C626.2973,-637.7991 618.159,-624.7318 613,-612 604.9285,-592.0806 600.0924,-568.2306 597.3207,-550.0883"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="600.7799,-549.5525 595.9185,-540.1388 593.8484,-550.5294 600.7799,-549.5525"/>
+</g>
+<!-- 137 -->
+<g id="node138" class="node">
+<title>137</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M548.5931,-612C548.5931,-612 505.4069,-612 505.4069,-612 499.4069,-612 493.4069,-606 493.4069,-600 493.4069,-600 493.4069,-588 493.4069,-588 493.4069,-582 499.4069,-576 505.4069,-576 505.4069,-576 548.5931,-576 548.5931,-576 554.5931,-576 560.5931,-582 560.5931,-588 560.5931,-588 560.5931,-600 560.5931,-600 560.5931,-606 554.5931,-612 548.5931,-612"/>
+<text text-anchor="middle" x="527" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 74&#45;&gt;137 -->
+<g id="edge499" class="edge">
+<title>74-&gt;137</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M616.7189,-647.8314C601.3702,-638.6221 582.5502,-627.3301 566.1177,-617.4706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="567.6471,-614.3066 557.2714,-612.1628 564.0456,-620.3091 567.6471,-614.3066"/>
+</g>
+<!-- 244 -->
+<g id="node245" class="node">
+<title>244</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M770.7975,-612C770.7975,-612 705.2025,-612 705.2025,-612 699.2025,-612 693.2025,-606 693.2025,-600 693.2025,-600 693.2025,-588 693.2025,-588 693.2025,-582 699.2025,-576 705.2025,-576 705.2025,-576 770.7975,-576 770.7975,-576 776.7975,-576 782.7975,-582 782.7975,-588 782.7975,-588 782.7975,-600 782.7975,-600 782.7975,-606 776.7975,-612 770.7975,-612"/>
+<text text-anchor="middle" x="738" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 74&#45;&gt;244 -->
+<g id="edge648" class="edge">
+<title>74-&gt;244</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M669.9631,-647.8314C681.1715,-638.9632 694.8209,-628.1637 706.9439,-618.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="709.3737,-621.1125 715.0442,-612.1628 705.0303,-615.6229 709.3737,-621.1125"/>
+</g>
+<!-- 75 -->
+<g id="node76" class="node">
+<title>75</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M2361.6605,-684C2361.6605,-684 2268.3395,-684 2268.3395,-684 2262.3395,-684 2256.3395,-678 2256.3395,-672 2256.3395,-672 2256.3395,-660 2256.3395,-660 2256.3395,-654 2262.3395,-648 2268.3395,-648 2268.3395,-648 2361.6605,-648 2361.6605,-648 2367.6605,-648 2373.6605,-654 2373.6605,-660 2373.6605,-660 2373.6605,-672 2373.6605,-672 2373.6605,-678 2367.6605,-684 2361.6605,-684"/>
+<text text-anchor="middle" x="2315" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 75&#45;&gt;2 -->
+<g id="edge76" class="edge">
+<title>75-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2256.0175,-657.4712C2223.9611,-650.1539 2185.5585,-636.6792 2159,-612 2133.478,-588.2839 2135.0337,-574.1226 2128,-540 2104.8398,-427.643 2204.9796,-398.6274 2313,-360 2411.9992,-324.5985 4020.4796,-309.4094 4369.5169,-306.5219"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7442,-310.0203 4379.715,-306.4381 4369.6866,-303.0205 4369.7442,-310.0203"/>
+</g>
+<!-- 75&#45;&gt;7 -->
+<g id="edge101" class="edge">
+<title>75-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2373.8539,-662.4358C2444.0811,-658.3152 2565.0648,-651.635 2669,-648 3087.2652,-633.3715 4135.2256,-650.1947 4552,-612 4564.012,-610.8992 4576.7005,-609.2529 4589.0082,-607.3956"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.8962,-610.7992 4599.2338,-605.7931 4588.8125,-603.8836 4589.8962,-610.7992"/>
+</g>
+<!-- 75&#45;&gt;8 -->
+<g id="edge122" class="edge">
+<title>75-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2373.8529,-662.4058C2444.0791,-658.2563 2565.0618,-651.5484 2669,-648 2895.103,-640.281 4463.5837,-648.6742 4730.7175,-611.7908"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.3518,-615.2349 4740.7209,-610.2881 4730.3119,-608.3125 4731.3518,-615.2349"/>
+</g>
+<!-- 75&#45;&gt;12 -->
+<g id="edge152" class="edge">
+<title>75-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2319.8453,-647.9555C2329.9739,-610.235 2353.4468,-522.8188 2365.5245,-477.8399"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2368.9146,-478.7106 2368.1277,-468.1451 2362.1541,-476.8953 2368.9146,-478.7106"/>
+</g>
+<!-- 75&#45;&gt;33 -->
+<g id="edge230" class="edge">
+<title>75-&gt;33</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2256.1863,-651.088C2221.3962,-640.9459 2182.1861,-626.7347 2172,-612 2159.7021,-594.2105 2161.2833,-569.3572 2165.3325,-550.2739"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2168.7843,-550.8928 2167.7635,-540.3472 2161.9852,-549.2276 2168.7843,-550.8928"/>
+</g>
+<!-- 98 -->
+<g id="node99" class="node">
+<title>98</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M2444.6488,-540C2444.6488,-540 2391.3512,-540 2391.3512,-540 2385.3512,-540 2379.3512,-534 2379.3512,-528 2379.3512,-528 2379.3512,-516 2379.3512,-516 2379.3512,-510 2385.3512,-504 2391.3512,-504 2391.3512,-504 2444.6488,-504 2444.6488,-504 2450.6488,-504 2456.6488,-510 2456.6488,-516 2456.6488,-516 2456.6488,-528 2456.6488,-528 2456.6488,-534 2450.6488,-540 2444.6488,-540"/>
+<text text-anchor="middle" x="2418" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 75&#45;&gt;98 -->
+<g id="edge423" class="edge">
+<title>75-&gt;98</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2327.11,-647.8998C2339.4352,-629.6031 2359.2053,-600.5958 2377,-576 2383.5882,-566.8938 2390.9656,-557.0682 2397.627,-548.3267"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2400.4444,-550.4042 2403.7452,-540.3366 2394.8867,-546.1485 2400.4444,-550.4042"/>
+</g>
+<!-- 99 -->
+<g id="node100" class="node">
+<title>99</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M2310.6762,-540C2310.6762,-540 2241.3238,-540 2241.3238,-540 2235.3238,-540 2229.3238,-534 2229.3238,-528 2229.3238,-528 2229.3238,-516 2229.3238,-516 2229.3238,-510 2235.3238,-504 2241.3238,-504 2241.3238,-504 2310.6762,-504 2310.6762,-504 2316.6762,-504 2322.6762,-510 2322.6762,-516 2322.6762,-516 2322.6762,-528 2322.6762,-528 2322.6762,-534 2316.6762,-540 2310.6762,-540"/>
+<text text-anchor="middle" x="2276" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 75&#45;&gt;99 -->
+<g id="edge425" class="edge">
+<title>75-&gt;99</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2310.0606,-647.7623C2303.3793,-623.0928 2291.3995,-578.8598 2283.576,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2286.8918,-548.8269 2280.8993,-540.0896 2280.1352,-550.6569 2286.8918,-548.8269"/>
+</g>
+<!-- 138 -->
+<g id="node139" class="node">
+<title>138</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M2236.5931,-612C2236.5931,-612 2193.4069,-612 2193.4069,-612 2187.4069,-612 2181.4069,-606 2181.4069,-600 2181.4069,-600 2181.4069,-588 2181.4069,-588 2181.4069,-582 2187.4069,-576 2193.4069,-576 2193.4069,-576 2236.5931,-576 2236.5931,-576 2242.5931,-576 2248.5931,-582 2248.5931,-588 2248.5931,-588 2248.5931,-600 2248.5931,-600 2248.5931,-606 2242.5931,-612 2236.5931,-612"/>
+<text text-anchor="middle" x="2215" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 75&#45;&gt;138 -->
+<g id="edge500" class="edge">
+<title>75-&gt;138</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2289.7658,-647.8314C2277.212,-638.7927 2261.8717,-627.7476 2248.3609,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2250.3866,-615.1655 2240.2261,-612.1628 2246.2964,-620.8463 2250.3866,-615.1655"/>
+</g>
+<!-- 245 -->
+<g id="node246" class="node">
+<title>245</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M2496.7975,-612C2496.7975,-612 2431.2025,-612 2431.2025,-612 2425.2025,-612 2419.2025,-606 2419.2025,-600 2419.2025,-600 2419.2025,-588 2419.2025,-588 2419.2025,-582 2425.2025,-576 2431.2025,-576 2431.2025,-576 2496.7975,-576 2496.7975,-576 2502.7975,-576 2508.7975,-582 2508.7975,-588 2508.7975,-588 2508.7975,-600 2508.7975,-600 2508.7975,-606 2502.7975,-612 2496.7975,-612"/>
+<text text-anchor="middle" x="2464" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 75&#45;&gt;245 -->
+<g id="edge651" class="edge">
+<title>75-&gt;245</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2352.599,-647.8314C2372.3497,-638.2874 2396.7297,-626.5065 2417.6417,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2419.1903,-619.5403 2426.6714,-612.038 2416.1447,-613.2376 2419.1903,-619.5403"/>
+</g>
+<!-- 76 -->
+<g id="node77" class="node">
+<title>76</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M3650.6605,-684C3650.6605,-684 3557.3395,-684 3557.3395,-684 3551.3395,-684 3545.3395,-678 3545.3395,-672 3545.3395,-672 3545.3395,-660 3545.3395,-660 3545.3395,-654 3551.3395,-648 3557.3395,-648 3557.3395,-648 3650.6605,-648 3650.6605,-648 3656.6605,-648 3662.6605,-654 3662.6605,-660 3662.6605,-660 3662.6605,-672 3662.6605,-672 3662.6605,-678 3656.6605,-684 3650.6605,-684"/>
+<text text-anchor="middle" x="3604" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 76&#45;&gt;2 -->
+<g id="edge77" class="edge">
+<title>76-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3545.0429,-660.1263C3507.3519,-653.6929 3459.4439,-640.2179 3426,-612 3391.8196,-583.1607 3381,-566.7214 3381,-522 3381,-522 3381,-522 3381,-450 3381,-345.1789 3496.8911,-383.6905 3599,-360 3745.2182,-326.0757 4198.7658,-311.7699 4369.8125,-307.4857"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4370.026,-310.9816 4379.9365,-307.2356 4369.8531,-303.9837 4370.026,-310.9816"/>
+</g>
+<!-- 76&#45;&gt;7 -->
+<g id="edge102" class="edge">
+<title>76-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3662.7196,-663.0216C3855.8383,-653.1753 4463.9825,-621.7462 4552,-612 4563.9891,-610.6725 4576.6659,-608.9108 4588.969,-607.0085"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.8656,-610.4101 4599.1924,-605.384 4588.767,-603.4968 4589.8656,-610.4101"/>
+</g>
+<!-- 76&#45;&gt;8 -->
+<g id="edge123" class="edge">
+<title>76-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3662.7287,-662.9479C3733.1276,-659.3066 3854.6773,-653.074 3959,-648 4299.251,-631.4509 4391.6442,-671.5144 4731.1574,-611.863"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.7821,-615.3069 4741.0175,-610.115 4730.5601,-608.4144 4731.7821,-615.3069"/>
+</g>
+<!-- 76&#45;&gt;13 -->
+<g id="edge156" class="edge">
+<title>76-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3605.7689,-647.9187C3607.7541,-629.6367 3611.443,-600.6406 3617,-576 3624.7484,-541.6424 3637.2643,-503.0866 3646.0218,-477.7797"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3649.4029,-478.7144 3649.4053,-468.1196 3642.7964,-476.4005 3649.4029,-478.7144"/>
+</g>
+<!-- 76&#45;&gt;34 -->
+<g id="edge232" class="edge">
+<title>76-&gt;34</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3545.1572,-654.4736C3502.8082,-644.8439 3450.9562,-629.8391 3438,-612 3425.1072,-594.2481 3428.69,-569.0294 3434.5942,-549.8015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3437.9903,-550.6876 3437.9204,-540.093 3431.3681,-548.4188 3437.9903,-550.6876"/>
+</g>
+<!-- 100 -->
+<g id="node101" class="node">
+<title>100</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M3716.6488,-540C3716.6488,-540 3663.3512,-540 3663.3512,-540 3657.3512,-540 3651.3512,-534 3651.3512,-528 3651.3512,-528 3651.3512,-516 3651.3512,-516 3651.3512,-510 3657.3512,-504 3663.3512,-504 3663.3512,-504 3716.6488,-504 3716.6488,-504 3722.6488,-504 3728.6488,-510 3728.6488,-516 3728.6488,-516 3728.6488,-528 3728.6488,-528 3728.6488,-534 3722.6488,-540 3716.6488,-540"/>
+<text text-anchor="middle" x="3690" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 76&#45;&gt;100 -->
+<g id="edge427" class="edge">
+<title>76-&gt;100</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3608.5364,-647.7583C3613.7643,-628.8356 3623.5383,-598.8697 3638,-576 3644.5099,-565.7053 3653.2094,-555.7209 3661.6278,-547.1956"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3664.1783,-549.5971 3668.8912,-540.1082 3659.2896,-544.587 3664.1783,-549.5971"/>
+</g>
+<!-- 101 -->
+<g id="node102" class="node">
+<title>101</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M3582.6762,-540C3582.6762,-540 3513.3238,-540 3513.3238,-540 3507.3238,-540 3501.3238,-534 3501.3238,-528 3501.3238,-528 3501.3238,-516 3501.3238,-516 3501.3238,-510 3507.3238,-504 3513.3238,-504 3513.3238,-504 3582.6762,-504 3582.6762,-504 3588.6762,-504 3594.6762,-510 3594.6762,-516 3594.6762,-516 3594.6762,-528 3594.6762,-528 3594.6762,-534 3588.6762,-540 3582.6762,-540"/>
+<text text-anchor="middle" x="3548" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 76&#45;&gt;101 -->
+<g id="edge429" class="edge">
+<title>76-&gt;101</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3588.6841,-647.5801C3581.114,-637.608 3572.4551,-624.7465 3567,-612 3558.5437,-592.2409 3553.7274,-568.3827 3551.0611,-550.1965"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3554.5215,-549.6666 3549.7283,-540.218 3547.5831,-550.5934 3554.5215,-549.6666"/>
+</g>
+<!-- 139 -->
+<g id="node140" class="node">
+<title>139</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M3502.5931,-612C3502.5931,-612 3459.4069,-612 3459.4069,-612 3453.4069,-612 3447.4069,-606 3447.4069,-600 3447.4069,-600 3447.4069,-588 3447.4069,-588 3447.4069,-582 3453.4069,-576 3459.4069,-576 3459.4069,-576 3502.5931,-576 3502.5931,-576 3508.5931,-576 3514.5931,-582 3514.5931,-588 3514.5931,-588 3514.5931,-600 3514.5931,-600 3514.5931,-606 3508.5931,-612 3502.5931,-612"/>
+<text text-anchor="middle" x="3481" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 76&#45;&gt;139 -->
+<g id="edge501" class="edge">
+<title>76-&gt;139</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3572.9619,-647.8314C3557.2295,-638.6221 3537.9389,-627.3301 3521.0956,-617.4706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3522.4265,-614.1941 3512.0282,-612.1628 3518.8902,-620.2352 3522.4265,-614.1941"/>
+</g>
+<!-- 246 -->
+<g id="node247" class="node">
+<title>246</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M3724.7975,-612C3724.7975,-612 3659.2025,-612 3659.2025,-612 3653.2025,-612 3647.2025,-606 3647.2025,-600 3647.2025,-600 3647.2025,-588 3647.2025,-588 3647.2025,-582 3653.2025,-576 3659.2025,-576 3659.2025,-576 3724.7975,-576 3724.7975,-576 3730.7975,-576 3736.7975,-582 3736.7975,-588 3736.7975,-588 3736.7975,-600 3736.7975,-600 3736.7975,-606 3730.7975,-612 3724.7975,-612"/>
+<text text-anchor="middle" x="3692" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 76&#45;&gt;246 -->
+<g id="edge654" class="edge">
+<title>76-&gt;246</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3626.2061,-647.8314C3637.045,-638.9632 3650.2444,-628.1637 3661.9678,-618.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3664.2777,-621.2041 3669.801,-612.1628 3659.845,-615.7864 3664.2777,-621.2041"/>
+</g>
+<!-- 77 -->
+<g id="node78" class="node">
+<title>77</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M4500.6605,-684C4500.6605,-684 4407.3395,-684 4407.3395,-684 4401.3395,-684 4395.3395,-678 4395.3395,-672 4395.3395,-672 4395.3395,-660 4395.3395,-660 4395.3395,-654 4401.3395,-648 4407.3395,-648 4407.3395,-648 4500.6605,-648 4500.6605,-648 4506.6605,-648 4512.6605,-654 4512.6605,-660 4512.6605,-660 4512.6605,-672 4512.6605,-672 4512.6605,-678 4506.6605,-684 4500.6605,-684"/>
+<text text-anchor="middle" x="4454" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 77&#45;&gt;2 -->
+<g id="edge78" class="edge">
+<title>77-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4395.3382,-654.1294C4349.0353,-643.8016 4289.1565,-628.0147 4270,-612 4235.689,-583.3163 4225,-566.7214 4225,-522 4225,-522 4225,-522 4225,-450 4225,-378.7498 4308.0984,-340.2154 4369.9967,-321.3952"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4371.1209,-324.713 4379.733,-318.5419 4369.1523,-317.9955 4371.1209,-324.713"/>
+</g>
+<!-- 77&#45;&gt;7 -->
+<g id="edge103" class="edge">
+<title>77-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4505.9677,-647.9243C4534.3888,-638.0387 4569.7702,-625.7321 4599.5536,-615.3726"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4600.7158,-618.6742 4609.011,-612.0831 4598.4161,-612.0627 4600.7158,-618.6742"/>
+</g>
+<!-- 77&#45;&gt;8 -->
+<g id="edge124" class="edge">
+<title>77-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4512.8913,-654.4594C4523.8939,-652.3085 4535.2965,-650.0829 4546,-648 4625.5833,-632.5131 4648.6892,-632.676 4731.1091,-612.0881"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4732.0707,-615.4552 4740.9093,-609.6132 4730.3567,-608.6683 4732.0707,-615.4552"/>
+</g>
+<!-- 77&#45;&gt;14 -->
+<g id="edge160" class="edge">
+<title>77-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4509.8767,-647.902C4526.3622,-639.6643 4542.5148,-628.0564 4552,-612 4562.4656,-594.284 4552.6265,-517.8287 4544,-504 4535.4985,-490.3717 4522.1512,-479.5702 4508.5312,-471.3219"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4510.0174,-468.1415 4499.5898,-466.2662 4506.572,-474.2349 4510.0174,-468.1415"/>
+</g>
+<!-- 77&#45;&gt;35 -->
+<g id="edge234" class="edge">
+<title>77-&gt;35</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4395.3106,-655.2449C4351.0522,-645.8006 4295.7066,-630.6694 4282,-612 4268.9425,-594.2147 4272.9297,-568.8405 4279.1848,-549.5656"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4282.493,-550.709 4282.5843,-540.1146 4275.9061,-548.3397 4282.493,-550.709"/>
+</g>
+<!-- 102 -->
+<g id="node103" class="node">
+<title>102</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M4522.6488,-540C4522.6488,-540 4469.3512,-540 4469.3512,-540 4463.3512,-540 4457.3512,-534 4457.3512,-528 4457.3512,-528 4457.3512,-516 4457.3512,-516 4457.3512,-510 4463.3512,-504 4469.3512,-504 4469.3512,-504 4522.6488,-504 4522.6488,-504 4528.6488,-504 4534.6488,-510 4534.6488,-516 4534.6488,-516 4534.6488,-528 4534.6488,-528 4534.6488,-534 4528.6488,-540 4522.6488,-540"/>
+<text text-anchor="middle" x="4496" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 77&#45;&gt;102 -->
+<g id="edge431" class="edge">
+<title>77-&gt;102</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4446.9804,-647.7149C4440.9303,-629.0197 4434.5349,-599.4747 4444,-576 4448.3225,-565.2796 4455.9044,-555.4983 4463.9639,-547.2948"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4466.573,-549.644 4471.4199,-540.2228 4461.7558,-544.5652 4466.573,-549.644"/>
+</g>
+<!-- 103 -->
+<g id="node104" class="node">
+<title>103</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M4427.6762,-540C4427.6762,-540 4358.3238,-540 4358.3238,-540 4352.3238,-540 4346.3238,-534 4346.3238,-528 4346.3238,-528 4346.3238,-516 4346.3238,-516 4346.3238,-510 4352.3238,-504 4358.3238,-504 4358.3238,-504 4427.6762,-504 4427.6762,-504 4433.6762,-504 4439.6762,-510 4439.6762,-516 4439.6762,-516 4439.6762,-528 4439.6762,-528 4439.6762,-534 4433.6762,-540 4427.6762,-540"/>
+<text text-anchor="middle" x="4393" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 77&#45;&gt;103 -->
+<g id="edge433" class="edge">
+<title>77-&gt;103</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4446.2743,-647.7623C4435.7782,-622.9846 4416.9219,-578.4714 4404.6891,-549.5939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4407.7864,-547.9323 4400.663,-540.0896 4401.3408,-550.6628 4407.7864,-547.9323"/>
+</g>
+<!-- 140 -->
+<g id="node141" class="node">
+<title>140</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M4346.5931,-612C4346.5931,-612 4303.4069,-612 4303.4069,-612 4297.4069,-612 4291.4069,-606 4291.4069,-600 4291.4069,-600 4291.4069,-588 4291.4069,-588 4291.4069,-582 4297.4069,-576 4303.4069,-576 4303.4069,-576 4346.5931,-576 4346.5931,-576 4352.5931,-576 4358.5931,-582 4358.5931,-588 4358.5931,-588 4358.5931,-600 4358.5931,-600 4358.5931,-606 4352.5931,-612 4346.5931,-612"/>
+<text text-anchor="middle" x="4325" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 77&#45;&gt;140 -->
+<g id="edge502" class="edge">
+<title>77-&gt;140</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4421.4479,-647.8314C4404.7952,-638.5368 4384.3415,-627.1208 4366.5615,-617.1971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4367.9795,-613.9803 4357.5417,-612.1628 4364.5679,-620.0927 4367.9795,-613.9803"/>
+</g>
+<!-- 247 -->
+<g id="node248" class="node">
+<title>247</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M4530.7975,-612C4530.7975,-612 4465.2025,-612 4465.2025,-612 4459.2025,-612 4453.2025,-606 4453.2025,-600 4453.2025,-600 4453.2025,-588 4453.2025,-588 4453.2025,-582 4459.2025,-576 4465.2025,-576 4465.2025,-576 4530.7975,-576 4530.7975,-576 4536.7975,-576 4542.7975,-582 4542.7975,-588 4542.7975,-588 4542.7975,-600 4542.7975,-600 4542.7975,-606 4536.7975,-612 4530.7975,-612"/>
+<text text-anchor="middle" x="4498" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 77&#45;&gt;247 -->
+<g id="edge657" class="edge">
+<title>77-&gt;247</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4465.1031,-647.8314C4470.0674,-639.7079 4476.0222,-629.9637 4481.4928,-621.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4484.5194,-622.7712 4486.7474,-612.4133 4478.5464,-619.121 4484.5194,-622.7712"/>
+</g>
+<!-- 78 -->
+<g id="node79" class="node">
+<title>78</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M1113.6605,-684C1113.6605,-684 1020.3395,-684 1020.3395,-684 1014.3395,-684 1008.3395,-678 1008.3395,-672 1008.3395,-672 1008.3395,-660 1008.3395,-660 1008.3395,-654 1014.3395,-648 1020.3395,-648 1020.3395,-648 1113.6605,-648 1113.6605,-648 1119.6605,-648 1125.6605,-654 1125.6605,-660 1125.6605,-660 1125.6605,-672 1125.6605,-672 1125.6605,-678 1119.6605,-684 1113.6605,-684"/>
+<text text-anchor="middle" x="1067" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 78&#45;&gt;2 -->
+<g id="edge79" class="edge">
+<title>78-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1008.0501,-659.4343C971.6668,-652.7311 925.995,-639.2155 894,-612 859.9354,-583.0241 849,-566.7214 849,-522 849,-522 849,-522 849,-450 849,-351.3083 955.6151,-381.213 1052,-360 1219.913,-323.0446 3910.2797,-308.522 4369.5688,-306.3069"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7021,-309.8063 4379.6851,-306.2583 4369.6684,-302.8064 4369.7021,-309.8063"/>
+</g>
+<!-- 78&#45;&gt;7 -->
+<g id="edge104" class="edge">
+<title>78-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1125.8494,-662.2986C1196.0722,-658.0461 1317.0517,-651.2391 1421,-648 2116.4862,-626.3282 3858.843,-672.8617 4552,-612 4564.0161,-610.9449 4576.7067,-609.3219 4589.0152,-607.4737"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.9015,-610.8778 4599.2412,-605.8757 4588.8207,-603.9617 4589.9015,-610.8778"/>
+</g>
+<!-- 78&#45;&gt;8 -->
+<g id="edge125" class="edge">
+<title>78-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1125.849,-662.2874C1196.0715,-658.024 1317.0507,-651.2066 1421,-648 1785.5934,-636.7531 4324.7643,-669.4578 4730.7067,-611.821"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.3581,-615.2625 4740.7245,-610.3106 4730.3144,-608.3407 4731.3581,-615.2625"/>
+</g>
+<!-- 78&#45;&gt;15 -->
+<g id="edge164" class="edge">
+<title>78-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1070.091,-647.9555C1076.5387,-610.3144 1091.4634,-523.1867 1099.1824,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1102.6531,-478.5925 1100.8918,-468.1451 1095.7536,-477.4105 1102.6531,-478.5925"/>
+</g>
+<!-- 78&#45;&gt;36 -->
+<g id="edge236" class="edge">
+<title>78-&gt;36</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1008.2071,-653.8289C967.4449,-644.0599 918.3525,-629.1718 906,-612 893.1881,-594.1896 896.7635,-568.9763 902.6442,-549.7654"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="906.0366,-550.6614 905.9566,-540.0669 899.4123,-548.3989 906.0366,-550.6614"/>
+</g>
+<!-- 104 -->
+<g id="node105" class="node">
+<title>104</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M1184.6488,-540C1184.6488,-540 1131.3512,-540 1131.3512,-540 1125.3512,-540 1119.3512,-534 1119.3512,-528 1119.3512,-528 1119.3512,-516 1119.3512,-516 1119.3512,-510 1125.3512,-504 1131.3512,-504 1131.3512,-504 1184.6488,-504 1184.6488,-504 1190.6488,-504 1196.6488,-510 1196.6488,-516 1196.6488,-516 1196.6488,-528 1196.6488,-528 1196.6488,-534 1190.6488,-540 1184.6488,-540"/>
+<text text-anchor="middle" x="1158" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 78&#45;&gt;104 -->
+<g id="edge435" class="edge">
+<title>78-&gt;104</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1072.7263,-647.7941C1079.1494,-628.9004 1090.704,-598.958 1106,-576 1112.8093,-565.7797 1121.6636,-555.7573 1130.1303,-547.1753"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1132.7212,-549.5366 1137.4097,-540.0356 1127.8197,-544.5391 1132.7212,-549.5366"/>
+</g>
+<!-- 105 -->
+<g id="node106" class="node">
+<title>105</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M1050.6762,-540C1050.6762,-540 981.3238,-540 981.3238,-540 975.3238,-540 969.3238,-534 969.3238,-528 969.3238,-528 969.3238,-516 969.3238,-516 969.3238,-510 975.3238,-504 981.3238,-504 981.3238,-504 1050.6762,-504 1050.6762,-504 1056.6762,-504 1062.6762,-510 1062.6762,-516 1062.6762,-516 1062.6762,-528 1062.6762,-528 1062.6762,-534 1056.6762,-540 1050.6762,-540"/>
+<text text-anchor="middle" x="1016" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 78&#45;&gt;105 -->
+<g id="edge437" class="edge">
+<title>78-&gt;105</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1054.1628,-647.7775C1047.5665,-637.6539 1039.9054,-624.591 1035,-612 1027.1978,-591.9736 1022.3479,-568.1291 1019.5025,-550.0161"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1022.9606,-549.4748 1018.0516,-540.0859 1016.0342,-550.4869 1022.9606,-549.4748"/>
+</g>
+<!-- 141 -->
+<g id="node142" class="node">
+<title>141</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M970.5931,-612C970.5931,-612 927.4069,-612 927.4069,-612 921.4069,-612 915.4069,-606 915.4069,-600 915.4069,-600 915.4069,-588 915.4069,-588 915.4069,-582 921.4069,-576 927.4069,-576 927.4069,-576 970.5931,-576 970.5931,-576 976.5931,-576 982.5931,-582 982.5931,-588 982.5931,-588 982.5931,-600 982.5931,-600 982.5931,-606 976.5931,-612 970.5931,-612"/>
+<text text-anchor="middle" x="949" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 78&#45;&gt;141 -->
+<g id="edge503" class="edge">
+<title>78-&gt;141</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1037.2236,-647.8314C1022.1307,-638.6221 1003.6243,-627.3301 987.4657,-617.4706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="989.1263,-614.3838 978.7669,-612.1628 985.4802,-620.3593 989.1263,-614.3838"/>
+</g>
+<!-- 248 -->
+<g id="node249" class="node">
+<title>248</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M1192.7975,-612C1192.7975,-612 1127.2025,-612 1127.2025,-612 1121.2025,-612 1115.2025,-606 1115.2025,-600 1115.2025,-600 1115.2025,-588 1115.2025,-588 1115.2025,-582 1121.2025,-576 1127.2025,-576 1127.2025,-576 1192.7975,-576 1192.7975,-576 1198.7975,-576 1204.7975,-582 1204.7975,-588 1204.7975,-588 1204.7975,-600 1204.7975,-600 1204.7975,-606 1198.7975,-612 1192.7975,-612"/>
+<text text-anchor="middle" x="1160" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 78&#45;&gt;248 -->
+<g id="edge660" class="edge">
+<title>78-&gt;248</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1090.4678,-647.8314C1102.0327,-638.8779 1116.1404,-627.9558 1128.6183,-618.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1130.775,-621.0521 1136.5397,-612.1628 1126.4898,-615.5171 1130.775,-621.0521"/>
+</g>
+<!-- 79 -->
+<g id="node80" class="node">
+<title>79</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M1939.6605,-684C1939.6605,-684 1846.3395,-684 1846.3395,-684 1840.3395,-684 1834.3395,-678 1834.3395,-672 1834.3395,-672 1834.3395,-660 1834.3395,-660 1834.3395,-654 1840.3395,-648 1846.3395,-648 1846.3395,-648 1939.6605,-648 1939.6605,-648 1945.6605,-648 1951.6605,-654 1951.6605,-660 1951.6605,-660 1951.6605,-672 1951.6605,-672 1951.6605,-678 1945.6605,-684 1939.6605,-684"/>
+<text text-anchor="middle" x="1893" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 79&#45;&gt;2 -->
+<g id="edge80" class="edge">
+<title>79-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1834.1681,-656.6176C1802.634,-649.0523 1764.8583,-635.6133 1738,-612 1704.4134,-582.4713 1693,-566.7214 1693,-522 1693,-522 1693,-522 1693,-450 1693,-351.3083 1799.6716,-381.4684 1896,-360 2020.0867,-332.3452 3981.3532,-310.6986 4369.54,-306.6733"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7976,-310.1709 4379.7608,-306.5676 4369.7252,-303.1713 4369.7976,-310.1709"/>
+</g>
+<!-- 79&#45;&gt;7 -->
+<g id="edge105" class="edge">
+<title>79-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1951.8517,-662.3728C2022.0769,-658.1916 2143.0586,-651.4532 2247,-648 2759.0022,-630.99 4041.7721,-657.8591 4552,-612 4564.0139,-610.9202 4576.7034,-609.2846 4589.0114,-607.4314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.8987,-610.8353 4599.2372,-605.8311 4588.8163,-603.9195 4589.8987,-610.8353"/>
+</g>
+<!-- 79&#45;&gt;8 -->
+<g id="edge126" class="edge">
+<title>79-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1951.8511,-662.3524C2022.0756,-658.1517 2143.0566,-651.3944 2247,-648 2519.8934,-639.0883 4416.111,-655.664 4730.6227,-611.8158"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.3536,-615.2454 4740.7225,-610.2983 4730.3134,-608.3231 4731.3536,-615.2454"/>
+</g>
+<!-- 79&#45;&gt;16 -->
+<g id="edge168" class="edge">
+<title>79-&gt;16</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1898.4301,-647.9555C1909.7811,-610.235 1936.0869,-522.8188 1949.6222,-477.8399"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1953.0095,-478.7295 1952.5397,-468.1451 1946.3065,-476.7123 1953.0095,-478.7295"/>
+</g>
+<!-- 79&#45;&gt;37 -->
+<g id="edge238" class="edge">
+<title>79-&gt;37</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1834.1863,-651.088C1799.3962,-640.9459 1760.1861,-626.7347 1750,-612 1737.5995,-594.0621 1741.0258,-569.0666 1746.7466,-549.9679"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1750.1217,-550.9109 1749.9749,-540.3171 1743.4833,-548.6902 1750.1217,-550.9109"/>
+</g>
+<!-- 106 -->
+<g id="node107" class="node">
+<title>106</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M2028.6488,-540C2028.6488,-540 1975.3512,-540 1975.3512,-540 1969.3512,-540 1963.3512,-534 1963.3512,-528 1963.3512,-528 1963.3512,-516 1963.3512,-516 1963.3512,-510 1969.3512,-504 1975.3512,-504 1975.3512,-504 2028.6488,-504 2028.6488,-504 2034.6488,-504 2040.6488,-510 2040.6488,-516 2040.6488,-516 2040.6488,-528 2040.6488,-528 2040.6488,-534 2034.6488,-540 2028.6488,-540"/>
+<text text-anchor="middle" x="2002" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 79&#45;&gt;106 -->
+<g id="edge439" class="edge">
+<title>79-&gt;106</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1904.5425,-647.9889C1916.582,-629.5118 1936.2776,-600.1378 1955,-576 1962.3484,-566.5261 1970.8327,-556.5242 1978.5533,-547.7376"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1981.3492,-549.8603 1985.3744,-540.0599 1976.1161,-545.2111 1981.3492,-549.8603"/>
+</g>
+<!-- 107 -->
+<g id="node108" class="node">
+<title>107</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M1894.6762,-540C1894.6762,-540 1825.3238,-540 1825.3238,-540 1819.3238,-540 1813.3238,-534 1813.3238,-528 1813.3238,-528 1813.3238,-516 1813.3238,-516 1813.3238,-510 1819.3238,-504 1825.3238,-504 1825.3238,-504 1894.6762,-504 1894.6762,-504 1900.6762,-504 1906.6762,-510 1906.6762,-516 1906.6762,-516 1906.6762,-528 1906.6762,-528 1906.6762,-534 1900.6762,-540 1894.6762,-540"/>
+<text text-anchor="middle" x="1860" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 79&#45;&gt;107 -->
+<g id="edge441" class="edge">
+<title>79-&gt;107</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1887.9961,-647.5573C1885.2274,-637.1463 1881.7923,-623.8793 1879,-612 1874.1659,-591.4341 1869.254,-568.0893 1865.6358,-550.3299"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1869.0256,-549.4342 1863.6139,-540.3258 1862.1643,-550.821 1869.0256,-549.4342"/>
+</g>
+<!-- 142 -->
+<g id="node143" class="node">
+<title>142</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M1814.5931,-612C1814.5931,-612 1771.4069,-612 1771.4069,-612 1765.4069,-612 1759.4069,-606 1759.4069,-600 1759.4069,-600 1759.4069,-588 1759.4069,-588 1759.4069,-582 1765.4069,-576 1771.4069,-576 1771.4069,-576 1814.5931,-576 1814.5931,-576 1820.5931,-576 1826.5931,-582 1826.5931,-588 1826.5931,-588 1826.5931,-600 1826.5931,-600 1826.5931,-606 1820.5931,-612 1814.5931,-612"/>
+<text text-anchor="middle" x="1793" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 79&#45;&gt;142 -->
+<g id="edge504" class="edge">
+<title>79-&gt;142</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1867.7658,-647.8314C1855.212,-638.7927 1839.8717,-627.7476 1826.3609,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1828.3866,-615.1655 1818.2261,-612.1628 1824.2964,-620.8463 1828.3866,-615.1655"/>
+</g>
+<!-- 249 -->
+<g id="node250" class="node">
+<title>249</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M2074.7975,-612C2074.7975,-612 2009.2025,-612 2009.2025,-612 2003.2025,-612 1997.2025,-606 1997.2025,-600 1997.2025,-600 1997.2025,-588 1997.2025,-588 1997.2025,-582 2003.2025,-576 2009.2025,-576 2009.2025,-576 2074.7975,-576 2074.7975,-576 2080.7975,-576 2086.7975,-582 2086.7975,-588 2086.7975,-588 2086.7975,-600 2086.7975,-600 2086.7975,-606 2080.7975,-612 2074.7975,-612"/>
+<text text-anchor="middle" x="2042" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 79&#45;&gt;249 -->
+<g id="edge663" class="edge">
+<title>79-&gt;249</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1930.599,-647.8314C1950.3497,-638.2874 1974.7297,-626.5065 1995.6417,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1997.1903,-619.5403 2004.6714,-612.038 1994.1447,-613.2376 1997.1903,-619.5403"/>
+</g>
+<!-- 80 -->
+<g id="node81" class="node">
+<title>80</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M2783.6605,-684C2783.6605,-684 2690.3395,-684 2690.3395,-684 2684.3395,-684 2678.3395,-678 2678.3395,-672 2678.3395,-672 2678.3395,-660 2678.3395,-660 2678.3395,-654 2684.3395,-648 2690.3395,-648 2690.3395,-648 2783.6605,-648 2783.6605,-648 2789.6605,-648 2795.6605,-654 2795.6605,-660 2795.6605,-660 2795.6605,-672 2795.6605,-672 2795.6605,-678 2789.6605,-684 2783.6605,-684"/>
+<text text-anchor="middle" x="2737" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 80&#45;&gt;2 -->
+<g id="edge81" class="edge">
+<title>80-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2677.9705,-657.2015C2645.8139,-649.7984 2607.1601,-636.3279 2580,-612 2553.6399,-588.3887 2553.7432,-574.531 2546,-540 2520.2643,-425.2309 2628.9263,-398.6897 2740,-360 2818.1,-332.7958 4064.4803,-311.763 4369.1845,-307.0109"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.6786,-310.5037 4379.623,-306.8487 4369.5698,-303.5045 4369.6786,-310.5037"/>
+</g>
+<!-- 80&#45;&gt;7 -->
+<g id="edge106" class="edge">
+<title>80-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2795.9287,-662.7423C2869.6023,-658.7665 2999.5896,-652.0721 3111,-648 3751.2168,-624.5997 3914.2032,-672.3354 4552,-612 4564.0087,-610.864 4576.6956,-609.1998 4589.0026,-607.3355"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.892,-610.7388 4599.2279,-605.7296 4588.8059,-603.8235 4589.892,-610.7388"/>
+</g>
+<!-- 80&#45;&gt;8 -->
+<g id="edge127" class="edge">
+<title>80-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2795.9269,-662.6918C2869.5986,-658.6646 2999.5841,-651.9177 3111,-648 3467.8358,-635.4528 4360.2125,-670.2039 4730.717,-611.8899"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.4055,-615.3241 4740.7182,-610.2719 4730.2876,-608.414 4731.4055,-615.3241"/>
+</g>
+<!-- 80&#45;&gt;17 -->
+<g id="edge172" class="edge">
+<title>80-&gt;17</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2742.3465,-647.9555C2753.523,-610.235 2779.424,-522.8188 2792.7511,-477.8399"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2796.1385,-478.7274 2795.6237,-468.1451 2789.4269,-476.7387 2796.1385,-478.7274"/>
+</g>
+<!-- 80&#45;&gt;38 -->
+<g id="edge240" class="edge">
+<title>80-&gt;38</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2678.2955,-651.0116C2643.5503,-640.838 2604.3492,-626.6207 2594,-612 2581.4291,-594.2406 2581.9394,-569.1802 2585.0209,-550.012"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2588.4847,-550.5332 2586.9307,-540.0529 2581.61,-549.2148 2588.4847,-550.5332"/>
+</g>
+<!-- 108 -->
+<g id="node109" class="node">
+<title>108</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M2862.6488,-540C2862.6488,-540 2809.3512,-540 2809.3512,-540 2803.3512,-540 2797.3512,-534 2797.3512,-528 2797.3512,-528 2797.3512,-516 2797.3512,-516 2797.3512,-510 2803.3512,-504 2809.3512,-504 2809.3512,-504 2862.6488,-504 2862.6488,-504 2868.6488,-504 2874.6488,-510 2874.6488,-516 2874.6488,-516 2874.6488,-528 2874.6488,-528 2874.6488,-534 2868.6488,-540 2862.6488,-540"/>
+<text text-anchor="middle" x="2836" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 80&#45;&gt;108 -->
+<g id="edge443" class="edge">
+<title>80-&gt;108</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2749.5384,-647.7623C2766.7962,-622.66 2797.9801,-577.3017 2817.8039,-548.4671"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2820.7822,-550.3129 2823.5634,-540.0896 2815.0139,-546.3472 2820.7822,-550.3129"/>
+</g>
+<!-- 109 -->
+<g id="node110" class="node">
+<title>109</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M2728.6762,-540C2728.6762,-540 2659.3238,-540 2659.3238,-540 2653.3238,-540 2647.3238,-534 2647.3238,-528 2647.3238,-528 2647.3238,-516 2647.3238,-516 2647.3238,-510 2653.3238,-504 2659.3238,-504 2659.3238,-504 2728.6762,-504 2728.6762,-504 2734.6762,-504 2740.6762,-510 2740.6762,-516 2740.6762,-516 2740.6762,-528 2740.6762,-528 2740.6762,-534 2734.6762,-540 2728.6762,-540"/>
+<text text-anchor="middle" x="2694" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 80&#45;&gt;109 -->
+<g id="edge445" class="edge">
+<title>80-&gt;109</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2731.554,-647.7623C2724.1874,-623.0928 2710.979,-578.8598 2702.3531,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2705.6168,-548.6701 2699.4018,-540.0896 2698.9094,-550.673 2705.6168,-548.6701"/>
+</g>
+<!-- 143 -->
+<g id="node144" class="node">
+<title>143</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M2658.5931,-612C2658.5931,-612 2615.4069,-612 2615.4069,-612 2609.4069,-612 2603.4069,-606 2603.4069,-600 2603.4069,-600 2603.4069,-588 2603.4069,-588 2603.4069,-582 2609.4069,-576 2615.4069,-576 2615.4069,-576 2658.5931,-576 2658.5931,-576 2664.5931,-576 2670.5931,-582 2670.5931,-588 2670.5931,-588 2670.5931,-600 2670.5931,-600 2670.5931,-606 2664.5931,-612 2658.5931,-612"/>
+<text text-anchor="middle" x="2637" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 80&#45;&gt;143 -->
+<g id="edge505" class="edge">
+<title>80-&gt;143</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2711.7658,-647.8314C2699.212,-638.7927 2683.8717,-627.7476 2670.3609,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2672.3866,-615.1655 2662.2261,-612.1628 2668.2964,-620.8463 2672.3866,-615.1655"/>
+</g>
+<!-- 250 -->
+<g id="node251" class="node">
+<title>250</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M2918.7975,-612C2918.7975,-612 2853.2025,-612 2853.2025,-612 2847.2025,-612 2841.2025,-606 2841.2025,-600 2841.2025,-600 2841.2025,-588 2841.2025,-588 2841.2025,-582 2847.2025,-576 2853.2025,-576 2853.2025,-576 2918.7975,-576 2918.7975,-576 2924.7975,-576 2930.7975,-582 2930.7975,-588 2930.7975,-588 2930.7975,-600 2930.7975,-600 2930.7975,-606 2924.7975,-612 2918.7975,-612"/>
+<text text-anchor="middle" x="2886" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 80&#45;&gt;250 -->
+<g id="edge666" class="edge">
+<title>80-&gt;250</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2774.599,-647.8314C2794.3497,-638.2874 2818.7297,-626.5065 2839.6417,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2841.1903,-619.5403 2848.6714,-612.038 2838.1447,-613.2376 2841.1903,-619.5403"/>
+</g>
+<!-- 81 -->
+<g id="node82" class="node">
+<title>81</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M1535.6605,-684C1535.6605,-684 1442.3395,-684 1442.3395,-684 1436.3395,-684 1430.3395,-678 1430.3395,-672 1430.3395,-672 1430.3395,-660 1430.3395,-660 1430.3395,-654 1436.3395,-648 1442.3395,-648 1442.3395,-648 1535.6605,-648 1535.6605,-648 1541.6605,-648 1547.6605,-654 1547.6605,-660 1547.6605,-660 1547.6605,-672 1547.6605,-672 1547.6605,-678 1541.6605,-684 1535.6605,-684"/>
+<text text-anchor="middle" x="1489" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 81&#45;&gt;2 -->
+<g id="edge82" class="edge">
+<title>81-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1430.0501,-659.4343C1393.6668,-652.7311 1347.995,-639.2155 1316,-612 1281.9354,-583.0241 1271,-566.7214 1271,-522 1271,-522 1271,-522 1271,-450 1271,-349.6805 1379.9729,-381.3236 1478,-360 1623.8565,-328.2722 3944.4651,-309.6352 4369.4387,-306.4798"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.7355,-309.9778 4379.7093,-306.4038 4369.6837,-302.978 4369.7355,-309.9778"/>
+</g>
+<!-- 81&#45;&gt;7 -->
+<g id="edge107" class="edge">
+<title>81-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1547.8439,-662.1277C1614.8982,-657.8825 1727.7898,-651.2442 1825,-648 2430.7156,-627.7856 3948.3153,-665.5238 4552,-612 4564.0152,-610.9347 4576.7053,-609.3065 4589.0136,-607.4562"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.9003,-610.8602 4599.2396,-605.8573 4588.8189,-603.9442 4589.9003,-610.8602"/>
+</g>
+<!-- 81&#45;&gt;8 -->
+<g id="edge128" class="edge">
+<title>81-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1547.8434,-662.1131C1614.8972,-657.8548 1727.7885,-651.2044 1825,-648 2144.6966,-637.4616 4368.9994,-662.6856 4730.5733,-611.8323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.3556,-615.2541 4740.7237,-610.3054 4730.3143,-608.3319 4731.3556,-615.2541"/>
+</g>
+<!-- 81&#45;&gt;18 -->
+<g id="edge176" class="edge">
+<title>81-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1491.7274,-647.9781C1494.5987,-629.7423 1499.4649,-600.7814 1505,-576 1512.5967,-541.989 1523.3382,-503.3634 1530.7034,-477.9454"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1534.0947,-478.8183 1533.5384,-468.238 1527.3753,-476.8559 1534.0947,-478.8183"/>
+</g>
+<!-- 81&#45;&gt;39 -->
+<g id="edge242" class="edge">
+<title>81-&gt;39</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1430.2071,-653.8289C1389.4449,-644.0599 1340.3525,-629.1718 1328,-612 1315.1881,-594.1896 1318.7635,-568.9763 1324.6442,-549.7654"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1328.0366,-550.6614 1327.9566,-540.0669 1321.4123,-548.3989 1328.0366,-550.6614"/>
+</g>
+<!-- 110 -->
+<g id="node111" class="node">
+<title>110</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M1606.6488,-540C1606.6488,-540 1553.3512,-540 1553.3512,-540 1547.3512,-540 1541.3512,-534 1541.3512,-528 1541.3512,-528 1541.3512,-516 1541.3512,-516 1541.3512,-510 1547.3512,-504 1553.3512,-504 1553.3512,-504 1606.6488,-504 1606.6488,-504 1612.6488,-504 1618.6488,-510 1618.6488,-516 1618.6488,-516 1618.6488,-528 1618.6488,-528 1618.6488,-534 1612.6488,-540 1606.6488,-540"/>
+<text text-anchor="middle" x="1580" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 81&#45;&gt;110 -->
+<g id="edge447" class="edge">
+<title>81-&gt;110</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1494.7263,-647.7941C1501.1494,-628.9004 1512.704,-598.958 1528,-576 1534.8093,-565.7797 1543.6636,-555.7573 1552.1303,-547.1753"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1554.7212,-549.5366 1559.4097,-540.0356 1549.8197,-544.5391 1554.7212,-549.5366"/>
+</g>
+<!-- 111 -->
+<g id="node112" class="node">
+<title>111</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M1472.6762,-540C1472.6762,-540 1403.3238,-540 1403.3238,-540 1397.3238,-540 1391.3238,-534 1391.3238,-528 1391.3238,-528 1391.3238,-516 1391.3238,-516 1391.3238,-510 1397.3238,-504 1403.3238,-504 1403.3238,-504 1472.6762,-504 1472.6762,-504 1478.6762,-504 1484.6762,-510 1484.6762,-516 1484.6762,-516 1484.6762,-528 1484.6762,-528 1484.6762,-534 1478.6762,-540 1472.6762,-540"/>
+<text text-anchor="middle" x="1438" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 81&#45;&gt;111 -->
+<g id="edge449" class="edge">
+<title>81-&gt;111</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1476.1628,-647.7775C1469.5665,-637.6539 1461.9054,-624.591 1457,-612 1449.1978,-591.9736 1444.3479,-568.1291 1441.5025,-550.0161"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1444.9606,-549.4748 1440.0516,-540.0859 1438.0342,-550.4869 1444.9606,-549.4748"/>
+</g>
+<!-- 144 -->
+<g id="node145" class="node">
+<title>144</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M1392.5931,-612C1392.5931,-612 1349.4069,-612 1349.4069,-612 1343.4069,-612 1337.4069,-606 1337.4069,-600 1337.4069,-600 1337.4069,-588 1337.4069,-588 1337.4069,-582 1343.4069,-576 1349.4069,-576 1349.4069,-576 1392.5931,-576 1392.5931,-576 1398.5931,-576 1404.5931,-582 1404.5931,-588 1404.5931,-588 1404.5931,-600 1404.5931,-600 1404.5931,-606 1398.5931,-612 1392.5931,-612"/>
+<text text-anchor="middle" x="1371" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 81&#45;&gt;144 -->
+<g id="edge506" class="edge">
+<title>81-&gt;144</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1459.2236,-647.8314C1444.1307,-638.6221 1425.6243,-627.3301 1409.4657,-617.4706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1411.1263,-614.3838 1400.7669,-612.1628 1407.4802,-620.3593 1411.1263,-614.3838"/>
+</g>
+<!-- 251 -->
+<g id="node252" class="node">
+<title>251</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M1614.7975,-612C1614.7975,-612 1549.2025,-612 1549.2025,-612 1543.2025,-612 1537.2025,-606 1537.2025,-600 1537.2025,-600 1537.2025,-588 1537.2025,-588 1537.2025,-582 1543.2025,-576 1549.2025,-576 1549.2025,-576 1614.7975,-576 1614.7975,-576 1620.7975,-576 1626.7975,-582 1626.7975,-588 1626.7975,-588 1626.7975,-600 1626.7975,-600 1626.7975,-606 1620.7975,-612 1614.7975,-612"/>
+<text text-anchor="middle" x="1582" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 81&#45;&gt;251 -->
+<g id="edge669" class="edge">
+<title>81-&gt;251</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1512.4678,-647.8314C1524.0327,-638.8779 1538.1404,-627.9558 1550.6183,-618.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1552.775,-621.0521 1558.5397,-612.1628 1548.4898,-615.5171 1552.775,-621.0521"/>
+</g>
+<!-- 82 -->
+<g id="node83" class="node">
+<title>82</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M3225.6605,-684C3225.6605,-684 3132.3395,-684 3132.3395,-684 3126.3395,-684 3120.3395,-678 3120.3395,-672 3120.3395,-672 3120.3395,-660 3120.3395,-660 3120.3395,-654 3126.3395,-648 3132.3395,-648 3132.3395,-648 3225.6605,-648 3225.6605,-648 3231.6605,-648 3237.6605,-654 3237.6605,-660 3237.6605,-660 3237.6605,-672 3237.6605,-672 3237.6605,-678 3231.6605,-684 3225.6605,-684"/>
+<text text-anchor="middle" x="3179" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 82&#45;&gt;2 -->
+<g id="edge83" class="edge">
+<title>82-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3120.2023,-659.7433C3083.2691,-653.1568 3036.6194,-639.6553 3004,-612 2969.8883,-583.0795 2959,-566.7214 2959,-522 2959,-522 2959,-522 2959,-450 2959,-350.9018 3066.4876,-382.4902 3163,-360 3280.6735,-332.5787 4124.7408,-312.6299 4369.5867,-307.3723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4369.8396,-310.8678 4379.7625,-307.1549 4369.6899,-303.8694 4369.8396,-310.8678"/>
+</g>
+<!-- 82&#45;&gt;7 -->
+<g id="edge108" class="edge">
+<title>82-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3237.7373,-662.7686C3308.4764,-658.9394 3430.9086,-652.511 3536,-648 3987.4233,-628.623 4102.3977,-656.9016 4552,-612 4564.0027,-610.8013 4576.6864,-609.1052 4588.9922,-607.2285"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.884,-610.6312 4599.2169,-605.6165 4588.7938,-603.7166 4589.884,-610.6312"/>
+</g>
+<!-- 82&#45;&gt;8 -->
+<g id="edge129" class="edge">
+<title>82-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3237.7333,-662.6728C3308.4685,-658.7503 3430.897,-652.231 3536,-648 3798.4398,-637.4352 4453.5922,-655.994 4730.618,-611.9083"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.4157,-615.3242 4740.7137,-610.245 4730.2777,-608.4173 4731.4157,-615.3242"/>
+</g>
+<!-- 82&#45;&gt;19 -->
+<g id="edge180" class="edge">
+<title>82-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3181.9239,-647.9555C3188.0231,-610.3144 3202.141,-523.1867 3209.4428,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3212.9152,-478.5762 3211.0598,-468.1451 3206.0053,-477.4565 3212.9152,-478.5762"/>
+</g>
+<!-- 82&#45;&gt;40 -->
+<g id="edge244" class="edge">
+<title>82-&gt;40</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3119.9174,-654.0281C3078.5697,-644.3118 3028.5662,-629.4009 3016,-612 3003.1552,-594.2133 3006.7336,-568.9979 3012.6239,-549.78"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3016.0178,-550.672 3015.9418,-540.0775 3009.3943,-548.407 3016.0178,-550.672"/>
+</g>
+<!-- 112 -->
+<g id="node113" class="node">
+<title>112</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M3294.6488,-540C3294.6488,-540 3241.3512,-540 3241.3512,-540 3235.3512,-540 3229.3512,-534 3229.3512,-528 3229.3512,-528 3229.3512,-516 3229.3512,-516 3229.3512,-510 3235.3512,-504 3241.3512,-504 3241.3512,-504 3294.6488,-504 3294.6488,-504 3300.6488,-504 3306.6488,-510 3306.6488,-516 3306.6488,-516 3306.6488,-528 3306.6488,-528 3306.6488,-534 3300.6488,-540 3294.6488,-540"/>
+<text text-anchor="middle" x="3268" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 82&#45;&gt;112 -->
+<g id="edge451" class="edge">
+<title>82-&gt;112</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3184.2516,-647.7779C3190.1976,-628.8711 3201.0408,-598.918 3216,-576 3222.6576,-565.8003 3231.397,-555.8413 3239.8062,-547.3102"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3242.3583,-549.7097 3247.0506,-540.2106 3237.4588,-544.7103 3242.3583,-549.7097"/>
+</g>
+<!-- 113 -->
+<g id="node114" class="node">
+<title>113</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M3160.6762,-540C3160.6762,-540 3091.3238,-540 3091.3238,-540 3085.3238,-540 3079.3238,-534 3079.3238,-528 3079.3238,-528 3079.3238,-516 3079.3238,-516 3079.3238,-510 3085.3238,-504 3091.3238,-504 3091.3238,-504 3160.6762,-504 3160.6762,-504 3166.6762,-504 3172.6762,-510 3172.6762,-516 3172.6762,-516 3172.6762,-528 3172.6762,-528 3172.6762,-534 3166.6762,-540 3160.6762,-540"/>
+<text text-anchor="middle" x="3126" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 82&#45;&gt;113 -->
+<g id="edge453" class="edge">
+<title>82-&gt;113</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3165.3183,-647.8898C3158.2973,-637.7991 3150.159,-624.7318 3145,-612 3136.9285,-592.0806 3132.0924,-568.2306 3129.3207,-550.0883"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3132.7799,-549.5525 3127.9185,-540.1388 3125.8484,-550.5294 3132.7799,-549.5525"/>
+</g>
+<!-- 145 -->
+<g id="node146" class="node">
+<title>145</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M3080.5931,-612C3080.5931,-612 3037.4069,-612 3037.4069,-612 3031.4069,-612 3025.4069,-606 3025.4069,-600 3025.4069,-600 3025.4069,-588 3025.4069,-588 3025.4069,-582 3031.4069,-576 3037.4069,-576 3037.4069,-576 3080.5931,-576 3080.5931,-576 3086.5931,-576 3092.5931,-582 3092.5931,-588 3092.5931,-588 3092.5931,-600 3092.5931,-600 3092.5931,-606 3086.5931,-612 3080.5931,-612"/>
+<text text-anchor="middle" x="3059" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 82&#45;&gt;145 -->
+<g id="edge507" class="edge">
+<title>82-&gt;145</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3148.7189,-647.8314C3133.3702,-638.6221 3114.5502,-627.3301 3098.1177,-617.4706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3099.6471,-614.3066 3089.2714,-612.1628 3096.0456,-620.3091 3099.6471,-614.3066"/>
+</g>
+<!-- 252 -->
+<g id="node253" class="node">
+<title>252</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M3302.7975,-612C3302.7975,-612 3237.2025,-612 3237.2025,-612 3231.2025,-612 3225.2025,-606 3225.2025,-600 3225.2025,-600 3225.2025,-588 3225.2025,-588 3225.2025,-582 3231.2025,-576 3237.2025,-576 3237.2025,-576 3302.7975,-576 3302.7975,-576 3308.7975,-576 3314.7975,-582 3314.7975,-588 3314.7975,-588 3314.7975,-600 3314.7975,-600 3314.7975,-606 3308.7975,-612 3302.7975,-612"/>
+<text text-anchor="middle" x="3270" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 82&#45;&gt;252 -->
+<g id="edge672" class="edge">
+<title>82-&gt;252</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3201.9631,-647.8314C3213.1715,-638.9632 3226.8209,-628.1637 3238.9439,-618.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3241.3737,-621.1125 3247.0442,-612.1628 3237.0303,-615.6229 3241.3737,-621.1125"/>
+</g>
+<!-- 83 -->
+<g id="node84" class="node">
+<title>83</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M4073.6605,-684C4073.6605,-684 3980.3395,-684 3980.3395,-684 3974.3395,-684 3968.3395,-678 3968.3395,-672 3968.3395,-672 3968.3395,-660 3968.3395,-660 3968.3395,-654 3974.3395,-648 3980.3395,-648 3980.3395,-648 4073.6605,-648 4073.6605,-648 4079.6605,-648 4085.6605,-654 4085.6605,-660 4085.6605,-660 4085.6605,-672 4085.6605,-672 4085.6605,-678 4079.6605,-684 4073.6605,-684"/>
+<text text-anchor="middle" x="4027" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 83&#45;&gt;2 -->
+<g id="edge84" class="edge">
+<title>83-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4030.0777,-647.7101C4034.1299,-628.1963 4042.8496,-597.2317 4060,-576 4078.828,-552.6915 4095.3168,-560.6789 4117,-540 4187.668,-472.6054 4163.3215,-416.4565 4243,-360 4280.2156,-333.6307 4329.9244,-320.1077 4369.5733,-313.1889"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4370.3834,-316.6028 4379.6839,-311.5281 4369.2488,-309.6954 4370.3834,-316.6028"/>
+</g>
+<!-- 83&#45;&gt;7 -->
+<g id="edge109" class="edge">
+<title>83-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4085.7959,-661.1343C4183.0179,-652.8237 4383.3083,-634.5827 4552,-612 4563.9557,-610.3995 4576.6156,-608.499 4588.912,-606.5426"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4589.8184,-609.9416 4599.1321,-604.8914 4588.7019,-603.0312 4589.8184,-609.9416"/>
+</g>
+<!-- 83&#45;&gt;8 -->
+<g id="edge130" class="edge">
+<title>83-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4085.8853,-663.2317C4228.5109,-656.2533 4590.4427,-636.8421 4730.878,-611.8939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4731.8073,-615.2811 4740.9982,-610.0106 4730.5266,-608.3993 4731.8073,-615.2811"/>
+</g>
+<!-- 83&#45;&gt;20 -->
+<g id="edge184" class="edge">
+<title>83-&gt;20</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4023.5558,-647.5586C4021.7048,-637.1481 4019.5011,-623.881 4018,-612 4012.0868,-565.1974 4007.928,-510.4677 4005.7528,-478.1032"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4009.2391,-477.7778 4005.0915,-468.0285 4002.2541,-478.2363 4009.2391,-477.7778"/>
+</g>
+<!-- 83&#45;&gt;41 -->
+<g id="edge246" class="edge">
+<title>83-&gt;41</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3968.1168,-652.3419C3909.1901,-638.3945 3826.5987,-617.9669 3822,-612 3808.6523,-594.6809 3810.7848,-569.4221 3815.4668,-550.0688"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3818.8799,-550.8572 3818.1631,-540.2866 3812.1316,-548.997 3818.8799,-550.8572"/>
+</g>
+<!-- 114 -->
+<g id="node115" class="node">
+<title>114</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M4095.6488,-540C4095.6488,-540 4042.3512,-540 4042.3512,-540 4036.3512,-540 4030.3512,-534 4030.3512,-528 4030.3512,-528 4030.3512,-516 4030.3512,-516 4030.3512,-510 4036.3512,-504 4042.3512,-504 4042.3512,-504 4095.6488,-504 4095.6488,-504 4101.6488,-504 4107.6488,-510 4107.6488,-516 4107.6488,-516 4107.6488,-528 4107.6488,-528 4107.6488,-534 4101.6488,-540 4095.6488,-540"/>
+<text text-anchor="middle" x="4069" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 83&#45;&gt;114 -->
+<g id="edge455" class="edge">
+<title>83-&gt;114</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4023.6271,-647.8471C4020.9407,-629.2571 4018.8359,-599.7946 4027,-576 4030.469,-565.8894 4036.6899,-556.2137 4043.299,-547.9166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4046.1265,-549.9949 4049.95,-540.1141 4040.7992,-545.4539 4046.1265,-549.9949"/>
+</g>
+<!-- 115 -->
+<g id="node116" class="node">
+<title>115</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M3961.6762,-540C3961.6762,-540 3892.3238,-540 3892.3238,-540 3886.3238,-540 3880.3238,-534 3880.3238,-528 3880.3238,-528 3880.3238,-516 3880.3238,-516 3880.3238,-510 3886.3238,-504 3892.3238,-504 3892.3238,-504 3961.6762,-504 3961.6762,-504 3967.6762,-504 3973.6762,-510 3973.6762,-516 3973.6762,-516 3973.6762,-528 3973.6762,-528 3973.6762,-534 3967.6762,-540 3961.6762,-540"/>
+<text text-anchor="middle" x="3927" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 83&#45;&gt;115 -->
+<g id="edge457" class="edge">
+<title>83-&gt;115</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3991.335,-647.8572C3976.8945,-638.8711 3961.2455,-626.7587 3951,-612 3938.2986,-593.7035 3932.3172,-569.0426 3929.5015,-550.1619"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3932.9519,-549.5504 3928.2113,-540.0753 3926.0085,-550.4386 3932.9519,-549.5504"/>
+</g>
+<!-- 146 -->
+<g id="node147" class="node">
+<title>146</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M3886.5931,-612C3886.5931,-612 3843.4069,-612 3843.4069,-612 3837.4069,-612 3831.4069,-606 3831.4069,-600 3831.4069,-600 3831.4069,-588 3831.4069,-588 3831.4069,-582 3837.4069,-576 3843.4069,-576 3843.4069,-576 3886.5931,-576 3886.5931,-576 3892.5931,-576 3898.5931,-582 3898.5931,-588 3898.5931,-588 3898.5931,-600 3898.5931,-600 3898.5931,-606 3892.5931,-612 3886.5931,-612"/>
+<text text-anchor="middle" x="3865" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 83&#45;&gt;146 -->
+<g id="edge508" class="edge">
+<title>83-&gt;146</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3986.1206,-647.8314C3962.289,-637.2396 3932.2585,-623.8927 3908.0624,-613.1388"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3909.3229,-609.869 3898.7633,-609.0059 3906.4799,-616.2657 3909.3229,-609.869"/>
+</g>
+<!-- 253 -->
+<g id="node254" class="node">
+<title>253</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M4146.7975,-612C4146.7975,-612 4081.2025,-612 4081.2025,-612 4075.2025,-612 4069.2025,-606 4069.2025,-600 4069.2025,-600 4069.2025,-588 4069.2025,-588 4069.2025,-582 4075.2025,-576 4081.2025,-576 4081.2025,-576 4146.7975,-576 4146.7975,-576 4152.7975,-576 4158.7975,-582 4158.7975,-588 4158.7975,-588 4158.7975,-600 4158.7975,-600 4158.7975,-606 4152.7975,-612 4146.7975,-612"/>
+<text text-anchor="middle" x="4114" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 83&#45;&gt;253 -->
+<g id="edge675" class="edge">
+<title>83-&gt;253</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4048.9538,-647.8314C4059.6695,-638.9632 4072.7189,-628.1637 4084.309,-618.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4086.5808,-621.2349 4092.0533,-612.1628 4082.1178,-615.8422 4086.5808,-621.2349"/>
+</g>
+<!-- 84 -->
+<g id="node85" class="node">
+<title>84</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M6821.6605,-684C6821.6605,-684 6728.3395,-684 6728.3395,-684 6722.3395,-684 6716.3395,-678 6716.3395,-672 6716.3395,-672 6716.3395,-660 6716.3395,-660 6716.3395,-654 6722.3395,-648 6728.3395,-648 6728.3395,-648 6821.6605,-648 6821.6605,-648 6827.6605,-648 6833.6605,-654 6833.6605,-660 6833.6605,-660 6833.6605,-672 6833.6605,-672 6833.6605,-678 6827.6605,-684 6821.6605,-684"/>
+<text text-anchor="middle" x="6775" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 84&#45;&gt;2 -->
+<g id="edge85" class="edge">
+<title>84-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6833.6873,-648.9252C6876.6792,-636.002 6928.8914,-619.2769 6937,-612 6974.3542,-578.4773 6993.3932,-548.4057 6970,-504 6916.2241,-401.9208 6864.2463,-394.0257 6754,-360 6643.7256,-325.9657 4870.4169,-309.5708 4502.5093,-306.527"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.32,-303.0254 4492.2915,-306.4429 4502.2623,-310.0252 4502.32,-303.0254"/>
+</g>
+<!-- 84&#45;&gt;7 -->
+<g id="edge110" class="edge">
+<title>84-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6716.1447,-662.4753C6645.9161,-658.3927 6524.9312,-651.7491 6421,-648 6049.1229,-634.5853 5120.5244,-661.9647 4732.9744,-611.8947"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.167,-608.3897 4722.7936,-610.5445 4732.2466,-615.329 4733.167,-608.3897"/>
+</g>
+<!-- 84&#45;&gt;8 -->
+<g id="edge131" class="edge">
+<title>84-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6716.1437,-662.5031C6645.9142,-658.4472 6524.9282,-651.8292 6421,-648 6074.3917,-635.2292 5207.6513,-668.6543 4847.2721,-611.8883"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.7132,-608.4142 4837.2822,-610.2697 4846.5937,-615.3241 4847.7132,-608.4142"/>
+</g>
+<!-- 84&#45;&gt;21 -->
+<g id="edge188" class="edge">
+<title>84-&gt;21</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6771.4913,-647.9555C6764.1722,-610.3144 6747.2307,-523.1867 6738.4687,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6741.8726,-477.2932 6736.5282,-468.1451 6735.0013,-478.6293 6741.8726,-477.2932"/>
+</g>
+<!-- 84&#45;&gt;42 -->
+<g id="edge248" class="edge">
+<title>84-&gt;42</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6833.8742,-650.7415C6868.4355,-640.5123 6907.3687,-626.3343 6918,-612 6930.9872,-594.4893 6931.6234,-569.4071 6929.5012,-550.1672"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6932.9535,-549.582 6928.0993,-540.1646 6926.0212,-550.5536 6932.9535,-549.582"/>
+</g>
+<!-- 116 -->
+<g id="node117" class="node">
+<title>116</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M6706.6488,-540C6706.6488,-540 6653.3512,-540 6653.3512,-540 6647.3512,-540 6641.3512,-534 6641.3512,-528 6641.3512,-528 6641.3512,-516 6641.3512,-516 6641.3512,-510 6647.3512,-504 6653.3512,-504 6653.3512,-504 6706.6488,-504 6706.6488,-504 6712.6488,-504 6718.6488,-510 6718.6488,-516 6718.6488,-516 6718.6488,-528 6718.6488,-528 6718.6488,-534 6712.6488,-540 6706.6488,-540"/>
+<text text-anchor="middle" x="6680" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 84&#45;&gt;116 -->
+<g id="edge459" class="edge">
+<title>84-&gt;116</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6762.9682,-647.7623C6746.4077,-622.66 6716.4838,-577.3017 6697.4609,-548.4671"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6700.3625,-546.5094 6691.9341,-540.0896 6694.5195,-550.3642 6700.3625,-546.5094"/>
+</g>
+<!-- 117 -->
+<g id="node118" class="node">
+<title>117</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M6856.6762,-540C6856.6762,-540 6787.3238,-540 6787.3238,-540 6781.3238,-540 6775.3238,-534 6775.3238,-528 6775.3238,-528 6775.3238,-516 6775.3238,-516 6775.3238,-510 6781.3238,-504 6787.3238,-504 6787.3238,-504 6856.6762,-504 6856.6762,-504 6862.6762,-504 6868.6762,-510 6868.6762,-516 6868.6762,-516 6868.6762,-528 6868.6762,-528 6868.6762,-534 6862.6762,-540 6856.6762,-540"/>
+<text text-anchor="middle" x="6822" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 84&#45;&gt;117 -->
+<g id="edge461" class="edge">
+<title>84-&gt;117</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6780.9526,-647.7623C6789.0044,-623.0928 6803.4416,-578.8598 6812.8699,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6816.3201,-550.6821 6816.0957,-540.0896 6809.6656,-548.5101 6816.3201,-550.6821"/>
+</g>
+<!-- 147 -->
+<g id="node148" class="node">
+<title>147</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M6896.5931,-612C6896.5931,-612 6853.4069,-612 6853.4069,-612 6847.4069,-612 6841.4069,-606 6841.4069,-600 6841.4069,-600 6841.4069,-588 6841.4069,-588 6841.4069,-582 6847.4069,-576 6853.4069,-576 6853.4069,-576 6896.5931,-576 6896.5931,-576 6902.5931,-576 6908.5931,-582 6908.5931,-588 6908.5931,-588 6908.5931,-600 6908.5931,-600 6908.5931,-606 6902.5931,-612 6896.5931,-612"/>
+<text text-anchor="middle" x="6875" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 84&#45;&gt;147 -->
+<g id="edge509" class="edge">
+<title>84-&gt;147</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6800.2342,-647.8314C6812.788,-638.7927 6828.1283,-627.7476 6841.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6843.7036,-620.8463 6849.7739,-612.1628 6839.6134,-615.1655 6843.7036,-620.8463"/>
+</g>
+<!-- 254 -->
+<g id="node255" class="node">
+<title>254</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M6658.7975,-612C6658.7975,-612 6593.2025,-612 6593.2025,-612 6587.2025,-612 6581.2025,-606 6581.2025,-600 6581.2025,-600 6581.2025,-588 6581.2025,-588 6581.2025,-582 6587.2025,-576 6593.2025,-576 6593.2025,-576 6658.7975,-576 6658.7975,-576 6664.7975,-576 6670.7975,-582 6670.7975,-588 6670.7975,-588 6670.7975,-600 6670.7975,-600 6670.7975,-606 6664.7975,-612 6658.7975,-612"/>
+<text text-anchor="middle" x="6626" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 84&#45;&gt;254 -->
+<g id="edge678" class="edge">
+<title>84-&gt;254</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6737.401,-647.8314C6717.6503,-638.2874 6693.2703,-626.5065 6672.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6673.8553,-613.2376 6663.3286,-612.038 6670.8097,-619.5403 6673.8553,-613.2376"/>
+</g>
+<!-- 85 -->
+<g id="node86" class="node">
+<title>85</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M5144.6605,-684C5144.6605,-684 5051.3395,-684 5051.3395,-684 5045.3395,-684 5039.3395,-678 5039.3395,-672 5039.3395,-672 5039.3395,-660 5039.3395,-660 5039.3395,-654 5045.3395,-648 5051.3395,-648 5051.3395,-648 5144.6605,-648 5144.6605,-648 5150.6605,-648 5156.6605,-654 5156.6605,-660 5156.6605,-660 5156.6605,-672 5156.6605,-672 5156.6605,-678 5150.6605,-684 5144.6605,-684"/>
+<text text-anchor="middle" x="5098" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 85&#45;&gt;2 -->
+<g id="edge86" class="edge">
+<title>85-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5155.399,-647.9711C5194.7323,-635.1734 5241.0188,-619.0609 5248,-612 5282.6402,-576.9641 5299.6539,-545.437 5273,-504 5231.2524,-439.0978 5186.5211,-460.981 5115,-432 5026.6662,-396.2064 5005.8531,-381.5023 4913,-360 4768.8075,-326.6089 4595.1181,-313.5586 4502.2495,-308.6968"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3165,-305.1958 4492.1518,-308.1839 4501.9614,-312.1868 4502.3165,-305.1958"/>
+</g>
+<!-- 85&#45;&gt;7 -->
+<g id="edge111" class="edge">
+<title>85-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5039.0474,-659.1786C4968.5064,-650.5979 4846.687,-634.4549 4732.8071,-612.0549"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.3619,-608.5968 4722.8714,-610.0804 4731.9974,-615.4625 4733.3619,-608.5968"/>
+</g>
+<!-- 85&#45;&gt;8 -->
+<g id="edge132" class="edge">
+<title>85-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5039.3229,-655.063C4990.3153,-645.5572 4918.4527,-630.7596 4847.1616,-612.1899"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6698,-608.7046 4837.1084,-609.5448 4845.8886,-615.4742 4847.6698,-608.7046"/>
+</g>
+<!-- 85&#45;&gt;22 -->
+<g id="edge192" class="edge">
+<title>85-&gt;22</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5091.2333,-647.9555C5077.0583,-610.1556 5044.169,-522.4506 5027.3337,-477.5564"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5030.5929,-476.2794 5023.8044,-468.1451 5024.0385,-478.7373 5030.5929,-476.2794"/>
+</g>
+<!-- 85&#45;&gt;43 -->
+<g id="edge250" class="edge">
+<title>85-&gt;43</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5156.839,-657.1751C5183.8995,-649.8513 5213.5768,-636.463 5230,-612 5242.0581,-594.0391 5240.2042,-569.1996 5235.955,-550.1653"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5239.2921,-549.0879 5233.421,-540.2685 5232.5108,-550.8242 5239.2921,-549.0879"/>
+</g>
+<!-- 118 -->
+<g id="node119" class="node">
+<title>118</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M5009.6488,-540C5009.6488,-540 4956.3512,-540 4956.3512,-540 4950.3512,-540 4944.3512,-534 4944.3512,-528 4944.3512,-528 4944.3512,-516 4944.3512,-516 4944.3512,-510 4950.3512,-504 4956.3512,-504 4956.3512,-504 5009.6488,-504 5009.6488,-504 5015.6488,-504 5021.6488,-510 5021.6488,-516 5021.6488,-516 5021.6488,-528 5021.6488,-528 5021.6488,-534 5015.6488,-540 5009.6488,-540"/>
+<text text-anchor="middle" x="4983" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 85&#45;&gt;118 -->
+<g id="edge463" class="edge">
+<title>85-&gt;118</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5083.4352,-647.7623C5063.3018,-622.5518 5026.852,-576.9103 5003.8399,-548.0952"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5006.4218,-545.7195 4997.4466,-540.0896 5000.952,-550.0877 5006.4218,-545.7195"/>
+</g>
+<!-- 119 -->
+<g id="node120" class="node">
+<title>119</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M5159.6762,-540C5159.6762,-540 5090.3238,-540 5090.3238,-540 5084.3238,-540 5078.3238,-534 5078.3238,-528 5078.3238,-528 5078.3238,-516 5078.3238,-516 5078.3238,-510 5084.3238,-504 5090.3238,-504 5090.3238,-504 5159.6762,-504 5159.6762,-504 5165.6762,-504 5171.6762,-510 5171.6762,-516 5171.6762,-516 5171.6762,-528 5171.6762,-528 5171.6762,-534 5165.6762,-540 5159.6762,-540"/>
+<text text-anchor="middle" x="5125" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 85&#45;&gt;119 -->
+<g id="edge465" class="edge">
+<title>85-&gt;119</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5101.4196,-647.7623C5106.0451,-623.0928 5114.3388,-578.8598 5119.755,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5123.2053,-550.5634 5121.6082,-540.0896 5116.3252,-549.2733 5123.2053,-550.5634"/>
+</g>
+<!-- 148 -->
+<g id="node149" class="node">
+<title>148</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M5208.5931,-612C5208.5931,-612 5165.4069,-612 5165.4069,-612 5159.4069,-612 5153.4069,-606 5153.4069,-600 5153.4069,-600 5153.4069,-588 5153.4069,-588 5153.4069,-582 5159.4069,-576 5165.4069,-576 5165.4069,-576 5208.5931,-576 5208.5931,-576 5214.5931,-576 5220.5931,-582 5220.5931,-588 5220.5931,-588 5220.5931,-600 5220.5931,-600 5220.5931,-606 5214.5931,-612 5208.5931,-612"/>
+<text text-anchor="middle" x="5187" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 85&#45;&gt;148 -->
+<g id="edge510" class="edge">
+<title>85-&gt;148</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5120.4585,-647.8314C5131.4205,-638.9632 5144.7699,-628.1637 5156.6265,-618.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5158.9755,-621.1734 5164.5487,-612.1628 5154.5729,-615.7313 5158.9755,-621.1734"/>
+</g>
+<!-- 255 -->
+<g id="node256" class="node">
+<title>255</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M4932.7975,-612C4932.7975,-612 4867.2025,-612 4867.2025,-612 4861.2025,-612 4855.2025,-606 4855.2025,-600 4855.2025,-600 4855.2025,-588 4855.2025,-588 4855.2025,-582 4861.2025,-576 4867.2025,-576 4867.2025,-576 4932.7975,-576 4932.7975,-576 4938.7975,-576 4944.7975,-582 4944.7975,-588 4944.7975,-588 4944.7975,-600 4944.7975,-600 4944.7975,-606 4938.7975,-612 4932.7975,-612"/>
+<text text-anchor="middle" x="4900" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 85&#45;&gt;255 -->
+<g id="edge681" class="edge">
+<title>85-&gt;255</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5048.2918,-647.9243C5019.6803,-637.5201 4983.6942,-624.4343 4954.3373,-613.759"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4955.25,-610.3667 4944.6559,-610.2385 4952.8577,-616.9453 4955.25,-610.3667"/>
+</g>
+<!-- 86 -->
+<g id="node87" class="node">
+<title>86</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M6399.6605,-684C6399.6605,-684 6306.3395,-684 6306.3395,-684 6300.3395,-684 6294.3395,-678 6294.3395,-672 6294.3395,-672 6294.3395,-660 6294.3395,-660 6294.3395,-654 6300.3395,-648 6306.3395,-648 6306.3395,-648 6399.6605,-648 6399.6605,-648 6405.6605,-648 6411.6605,-654 6411.6605,-660 6411.6605,-660 6411.6605,-672 6411.6605,-672 6411.6605,-678 6405.6605,-684 6399.6605,-684"/>
+<text text-anchor="middle" x="6353" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 86&#45;&gt;2 -->
+<g id="edge87" class="edge">
+<title>86-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6411.7102,-648.9506C6454.7151,-636.0417 6506.9335,-619.3235 6515,-612 6552.0654,-578.3484 6570.3335,-548.2924 6547,-504 6493.3964,-402.2478 6441.734,-394.4285 6332,-360 6243.051,-332.0927 4827.5623,-311.2999 4502.2783,-306.8754"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.117,-303.3729 4492.0704,-306.737 4502.0221,-310.3723 4502.117,-303.3729"/>
+</g>
+<!-- 86&#45;&gt;7 -->
+<g id="edge112" class="edge">
+<title>86-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6294.1399,-662.6031C6223.9067,-658.6433 6102.9172,-652.1178 5999,-648 5720.8499,-636.9782 5027.4798,-650.5196 4733.0996,-611.9135"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1766,-608.3921 4722.7972,-610.5181 4732.2369,-615.3287 4733.1766,-608.3921"/>
+</g>
+<!-- 86&#45;&gt;8 -->
+<g id="edge133" class="edge">
+<title>86-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6294.1378,-662.6536C6223.9027,-658.7424 6102.9113,-652.2636 5999,-648 5746.1201,-637.624 5115.0075,-654.5618 4847.4271,-611.916"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.7237,-608.4177 4837.287,-610.2412 4846.5829,-615.3241 4847.7237,-608.4177"/>
+</g>
+<!-- 86&#45;&gt;23 -->
+<g id="edge196" class="edge">
+<title>86-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6349.4913,-647.9555C6342.1722,-610.3144 6325.2307,-523.1867 6316.4687,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6319.8726,-477.2932 6314.5282,-468.1451 6313.0013,-478.6293 6319.8726,-477.2932"/>
+</g>
+<!-- 86&#45;&gt;44 -->
+<g id="edge252" class="edge">
+<title>86-&gt;44</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6411.9279,-650.7811C6446.511,-640.5679 6485.4482,-626.3929 6496,-612 6508.8814,-594.4295 6509.2311,-569.3526 6506.8696,-550.1299"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6510.313,-549.4935 6505.341,-540.1378 6503.3935,-550.5521 6510.313,-549.4935"/>
+</g>
+<!-- 120 -->
+<g id="node121" class="node">
+<title>120</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M6283.6488,-540C6283.6488,-540 6230.3512,-540 6230.3512,-540 6224.3512,-540 6218.3512,-534 6218.3512,-528 6218.3512,-528 6218.3512,-516 6218.3512,-516 6218.3512,-510 6224.3512,-504 6230.3512,-504 6230.3512,-504 6283.6488,-504 6283.6488,-504 6289.6488,-504 6295.6488,-510 6295.6488,-516 6295.6488,-516 6295.6488,-528 6295.6488,-528 6295.6488,-534 6289.6488,-540 6283.6488,-540"/>
+<text text-anchor="middle" x="6257" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 86&#45;&gt;120 -->
+<g id="edge467" class="edge">
+<title>86-&gt;120</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6340.8415,-647.7623C6324.1067,-622.66 6293.8678,-577.3017 6274.6447,-548.4671"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6277.519,-546.4687 6269.0597,-540.0896 6271.6946,-550.3516 6277.519,-546.4687"/>
+</g>
+<!-- 121 -->
+<g id="node122" class="node">
+<title>121</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M6433.6762,-540C6433.6762,-540 6364.3238,-540 6364.3238,-540 6358.3238,-540 6352.3238,-534 6352.3238,-528 6352.3238,-528 6352.3238,-516 6352.3238,-516 6352.3238,-510 6358.3238,-504 6364.3238,-504 6364.3238,-504 6433.6762,-504 6433.6762,-504 6439.6762,-504 6445.6762,-510 6445.6762,-516 6445.6762,-516 6445.6762,-528 6445.6762,-528 6445.6762,-534 6439.6762,-540 6433.6762,-540"/>
+<text text-anchor="middle" x="6399" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 86&#45;&gt;121 -->
+<g id="edge469" class="edge">
+<title>86-&gt;121</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6358.8259,-647.7623C6366.7065,-623.0928 6380.8365,-578.8598 6390.0642,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6393.5124,-550.6805 6393.2214,-540.0896 6386.8443,-548.5503 6393.5124,-550.6805"/>
+</g>
+<!-- 149 -->
+<g id="node150" class="node">
+<title>149</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M6474.5931,-612C6474.5931,-612 6431.4069,-612 6431.4069,-612 6425.4069,-612 6419.4069,-606 6419.4069,-600 6419.4069,-600 6419.4069,-588 6419.4069,-588 6419.4069,-582 6425.4069,-576 6431.4069,-576 6431.4069,-576 6474.5931,-576 6474.5931,-576 6480.5931,-576 6486.5931,-582 6486.5931,-588 6486.5931,-588 6486.5931,-600 6486.5931,-600 6486.5931,-606 6480.5931,-612 6474.5931,-612"/>
+<text text-anchor="middle" x="6453" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 86&#45;&gt;149 -->
+<g id="edge511" class="edge">
+<title>86-&gt;149</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6378.2342,-647.8314C6390.788,-638.7927 6406.1283,-627.7476 6419.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6421.7036,-620.8463 6427.7739,-612.1628 6417.6134,-615.1655 6421.7036,-620.8463"/>
+</g>
+<!-- 256 -->
+<g id="node257" class="node">
+<title>256</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M6236.7975,-612C6236.7975,-612 6171.2025,-612 6171.2025,-612 6165.2025,-612 6159.2025,-606 6159.2025,-600 6159.2025,-600 6159.2025,-588 6159.2025,-588 6159.2025,-582 6165.2025,-576 6171.2025,-576 6171.2025,-576 6236.7975,-576 6236.7975,-576 6242.7975,-576 6248.7975,-582 6248.7975,-588 6248.7975,-588 6248.7975,-600 6248.7975,-600 6248.7975,-606 6242.7975,-612 6236.7975,-612"/>
+<text text-anchor="middle" x="6204" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 86&#45;&gt;256 -->
+<g id="edge684" class="edge">
+<title>86-&gt;256</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6315.401,-647.8314C6295.6503,-638.2874 6271.2703,-626.5065 6250.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6251.8553,-613.2376 6241.3286,-612.038 6248.8097,-619.5403 6251.8553,-613.2376"/>
+</g>
+<!-- 87 -->
+<g id="node88" class="node">
+<title>87</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M5555.6605,-684C5555.6605,-684 5462.3395,-684 5462.3395,-684 5456.3395,-684 5450.3395,-678 5450.3395,-672 5450.3395,-672 5450.3395,-660 5450.3395,-660 5450.3395,-654 5456.3395,-648 5462.3395,-648 5462.3395,-648 5555.6605,-648 5555.6605,-648 5561.6605,-648 5567.6605,-654 5567.6605,-660 5567.6605,-660 5567.6605,-672 5567.6605,-672 5567.6605,-678 5561.6605,-684 5555.6605,-684"/>
+<text text-anchor="middle" x="5509" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 87&#45;&gt;2 -->
+<g id="edge88" class="edge">
+<title>87-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5567.8057,-649.0533C5610.8646,-636.2025 5663.1091,-619.5124 5671,-612 5706.9141,-577.8088 5722.398,-547.7195 5699,-504 5644.0336,-401.2943 5590.8099,-395.9298 5480,-360 5387.4785,-330.0001 4717.8803,-312.3783 4502.5216,-307.4399"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3878,-303.936 4492.3107,-307.2075 4502.2284,-310.9342 4502.3878,-303.936"/>
+</g>
+<!-- 87&#45;&gt;7 -->
+<g id="edge113" class="edge">
+<title>87-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5450.1473,-662.5197C5287.2881,-652.8062 4836.3915,-625.3273 4732.9545,-611.8237"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.2166,-608.3255 4722.8201,-610.3657 4732.2197,-615.2541 4733.2166,-608.3255"/>
+</g>
+<!-- 87&#45;&gt;8 -->
+<g id="edge134" class="edge">
+<title>87-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5450.3052,-662.9142C5314.0721,-655.4853 4978.6409,-635.5937 4846.8812,-611.8567"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.4806,-608.4081 4837.0051,-609.9938 4846.1831,-615.2868 4847.4806,-608.4081"/>
+</g>
+<!-- 87&#45;&gt;24 -->
+<g id="edge200" class="edge">
+<title>87-&gt;24</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5504.823,-647.9555C5496.1098,-610.3144 5475.9414,-523.1867 5465.5103,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5468.8653,-477.0981 5463.2002,-468.1451 5462.0457,-478.6768 5468.8653,-477.0981"/>
+</g>
+<!-- 87&#45;&gt;45 -->
+<g id="edge254" class="edge">
+<title>87-&gt;45</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5567.759,-651.0499C5602.5266,-640.8921 5641.7322,-626.6779 5652,-612 5664.4698,-594.1744 5663.6726,-569.1198 5660.3504,-549.9706"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5663.7484,-549.1176 5658.3131,-540.0232 5656.8907,-550.5221 5663.7484,-549.1176"/>
+</g>
+<!-- 122 -->
+<g id="node123" class="node">
+<title>122</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M5435.6488,-540C5435.6488,-540 5382.3512,-540 5382.3512,-540 5376.3512,-540 5370.3512,-534 5370.3512,-528 5370.3512,-528 5370.3512,-516 5370.3512,-516 5370.3512,-510 5376.3512,-504 5382.3512,-504 5382.3512,-504 5435.6488,-504 5435.6488,-504 5441.6488,-504 5447.6488,-510 5447.6488,-516 5447.6488,-516 5447.6488,-528 5447.6488,-528 5447.6488,-534 5441.6488,-540 5435.6488,-540"/>
+<text text-anchor="middle" x="5409" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 87&#45;&gt;122 -->
+<g id="edge471" class="edge">
+<title>87-&gt;122</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5496.4662,-647.6916C5483.9804,-629.4801 5464.2383,-600.7581 5447,-576 5440.8099,-567.1096 5434.0118,-557.4246 5427.898,-548.7429"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5430.6829,-546.6188 5422.0602,-540.4624 5424.9617,-550.6522 5430.6829,-546.6188"/>
+</g>
+<!-- 123 -->
+<g id="node124" class="node">
+<title>123</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M5585.6762,-540C5585.6762,-540 5516.3238,-540 5516.3238,-540 5510.3238,-540 5504.3238,-534 5504.3238,-528 5504.3238,-528 5504.3238,-516 5504.3238,-516 5504.3238,-510 5510.3238,-504 5516.3238,-504 5516.3238,-504 5585.6762,-504 5585.6762,-504 5591.6762,-504 5597.6762,-510 5597.6762,-516 5597.6762,-516 5597.6762,-528 5597.6762,-528 5597.6762,-534 5591.6762,-540 5585.6762,-540"/>
+<text text-anchor="middle" x="5551" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 87&#45;&gt;123 -->
+<g id="edge473" class="edge">
+<title>87-&gt;123</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5514.3193,-647.7623C5521.5146,-623.0928 5534.4159,-578.8598 5542.8412,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5546.2838,-550.6696 5545.7239,-540.0896 5539.5638,-548.7096 5546.2838,-550.6696"/>
+</g>
+<!-- 150 -->
+<g id="node151" class="node">
+<title>150</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M5630.5931,-612C5630.5931,-612 5587.4069,-612 5587.4069,-612 5581.4069,-612 5575.4069,-606 5575.4069,-600 5575.4069,-600 5575.4069,-588 5575.4069,-588 5575.4069,-582 5581.4069,-576 5587.4069,-576 5587.4069,-576 5630.5931,-576 5630.5931,-576 5636.5931,-576 5642.5931,-582 5642.5931,-588 5642.5931,-588 5642.5931,-600 5642.5931,-600 5642.5931,-606 5636.5931,-612 5630.5931,-612"/>
+<text text-anchor="middle" x="5609" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 87&#45;&gt;150 -->
+<g id="edge512" class="edge">
+<title>87-&gt;150</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5534.2342,-647.8314C5546.788,-638.7927 5562.1283,-627.7476 5575.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5577.7036,-620.8463 5583.7739,-612.1628 5573.6134,-615.1655 5577.7036,-620.8463"/>
+</g>
+<!-- 257 -->
+<g id="node258" class="node">
+<title>257</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M5392.7975,-612C5392.7975,-612 5327.2025,-612 5327.2025,-612 5321.2025,-612 5315.2025,-606 5315.2025,-600 5315.2025,-600 5315.2025,-588 5315.2025,-588 5315.2025,-582 5321.2025,-576 5327.2025,-576 5327.2025,-576 5392.7975,-576 5392.7975,-576 5398.7975,-576 5404.7975,-582 5404.7975,-588 5404.7975,-588 5404.7975,-600 5404.7975,-600 5404.7975,-606 5398.7975,-612 5392.7975,-612"/>
+<text text-anchor="middle" x="5360" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 87&#45;&gt;257 -->
+<g id="edge687" class="edge">
+<title>87-&gt;257</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5471.401,-647.8314C5451.6503,-638.2874 5427.2703,-626.5065 5406.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5407.8553,-613.2376 5397.3286,-612.038 5404.8097,-619.5403 5407.8553,-613.2376"/>
+</g>
+<!-- 88 -->
+<g id="node89" class="node">
+<title>88</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M7665.6605,-684C7665.6605,-684 7572.3395,-684 7572.3395,-684 7566.3395,-684 7560.3395,-678 7560.3395,-672 7560.3395,-672 7560.3395,-660 7560.3395,-660 7560.3395,-654 7566.3395,-648 7572.3395,-648 7572.3395,-648 7665.6605,-648 7665.6605,-648 7671.6605,-648 7677.6605,-654 7677.6605,-660 7677.6605,-660 7677.6605,-672 7677.6605,-672 7677.6605,-678 7671.6605,-684 7665.6605,-684"/>
+<text text-anchor="middle" x="7619" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 88&#45;&gt;2 -->
+<g id="edge89" class="edge">
+<title>88-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7678.0486,-648.9431C7721.3054,-636.03 7773.8396,-619.3098 7782,-612 7808.2198,-588.5132 7807.494,-574.3914 7815,-540 7841.3561,-419.2392 7720.9903,-396.8255 7603,-360 7449.8834,-312.2114 4944.5224,-306.6764 4502.3915,-306.0711"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.338,-302.5711 4492.3333,-306.0577 4502.3286,-309.5711 4502.338,-302.5711"/>
+</g>
+<!-- 88&#45;&gt;7 -->
+<g id="edge114" class="edge">
+<title>88-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7560.1491,-662.3475C7489.9247,-658.142 7368.9438,-651.3802 7265,-648 6986.8352,-638.9544 5055.1456,-648.6156 4733.1346,-611.842"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1423,-608.3167 4722.7901,-610.5709 4732.2885,-615.2645 4733.1423,-608.3167"/>
+</g>
+<!-- 88&#45;&gt;8 -->
+<g id="edge135" class="edge">
+<title>88-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7560.1487,-662.3595C7489.924,-658.1656 7368.9427,-651.415 7265,-648 6999.4858,-639.2767 5155.3151,-654.5609 4847.5718,-611.8412"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6863,-608.3193 4837.2777,-610.2969 4846.6478,-615.2418 4847.6863,-608.3193"/>
+</g>
+<!-- 88&#45;&gt;25 -->
+<g id="edge204" class="edge">
+<title>88-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7615.4913,-647.9555C7608.1722,-610.3144 7591.2307,-523.1867 7582.4687,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7585.8726,-477.2932 7580.5282,-468.1451 7579.0013,-478.6293 7585.8726,-477.2932"/>
+</g>
+<!-- 88&#45;&gt;46 -->
+<g id="edge256" class="edge">
+<title>88-&gt;46</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7677.8207,-650.7016C7712.3605,-640.4563 7751.2896,-626.2753 7762,-612 7775.0942,-594.5474 7776.0168,-569.4601 7774.1336,-550.2035"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7777.5938,-549.6683 7772.8582,-540.1907 7770.6499,-550.5529 7777.5938,-549.6683"/>
+</g>
+<!-- 124 -->
+<g id="node125" class="node">
+<title>124</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M7551.6488,-540C7551.6488,-540 7498.3512,-540 7498.3512,-540 7492.3512,-540 7486.3512,-534 7486.3512,-528 7486.3512,-528 7486.3512,-516 7486.3512,-516 7486.3512,-510 7492.3512,-504 7498.3512,-504 7498.3512,-504 7551.6488,-504 7551.6488,-504 7557.6488,-504 7563.6488,-510 7563.6488,-516 7563.6488,-516 7563.6488,-528 7563.6488,-528 7563.6488,-534 7557.6488,-540 7551.6488,-540"/>
+<text text-anchor="middle" x="7525" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 88&#45;&gt;124 -->
+<g id="edge475" class="edge">
+<title>88-&gt;124</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7607.0948,-647.7623C7590.7086,-622.66 7561.0997,-577.3017 7542.2771,-548.4671"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7545.2056,-546.5502 7536.8085,-540.0896 7539.3439,-550.3766 7545.2056,-546.5502"/>
+</g>
+<!-- 125 -->
+<g id="node126" class="node">
+<title>125</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M7701.6762,-540C7701.6762,-540 7632.3238,-540 7632.3238,-540 7626.3238,-540 7620.3238,-534 7620.3238,-528 7620.3238,-528 7620.3238,-516 7620.3238,-516 7620.3238,-510 7626.3238,-504 7632.3238,-504 7632.3238,-504 7701.6762,-504 7701.6762,-504 7707.6762,-504 7713.6762,-510 7713.6762,-516 7713.6762,-516 7713.6762,-528 7713.6762,-528 7713.6762,-534 7707.6762,-540 7701.6762,-540"/>
+<text text-anchor="middle" x="7667" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 88&#45;&gt;125 -->
+<g id="edge477" class="edge">
+<title>88-&gt;125</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7625.0792,-647.7623C7633.3385,-622.9846 7648.1762,-578.4714 7657.802,-549.5939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7661.1282,-550.6833 7660.9701,-540.0896 7654.4874,-548.4696 7661.1282,-550.6833"/>
+</g>
+<!-- 151 -->
+<g id="node152" class="node">
+<title>151</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M7740.5931,-612C7740.5931,-612 7697.4069,-612 7697.4069,-612 7691.4069,-612 7685.4069,-606 7685.4069,-600 7685.4069,-600 7685.4069,-588 7685.4069,-588 7685.4069,-582 7691.4069,-576 7697.4069,-576 7697.4069,-576 7740.5931,-576 7740.5931,-576 7746.5931,-576 7752.5931,-582 7752.5931,-588 7752.5931,-588 7752.5931,-600 7752.5931,-600 7752.5931,-606 7746.5931,-612 7740.5931,-612"/>
+<text text-anchor="middle" x="7719" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 88&#45;&gt;151 -->
+<g id="edge513" class="edge">
+<title>88-&gt;151</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7644.2342,-647.8314C7656.788,-638.7927 7672.1283,-627.7476 7685.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7687.7036,-620.8463 7693.7739,-612.1628 7683.6134,-615.1655 7687.7036,-620.8463"/>
+</g>
+<!-- 258 -->
+<g id="node259" class="node">
+<title>258</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M7502.7975,-612C7502.7975,-612 7437.2025,-612 7437.2025,-612 7431.2025,-612 7425.2025,-606 7425.2025,-600 7425.2025,-600 7425.2025,-588 7425.2025,-588 7425.2025,-582 7431.2025,-576 7437.2025,-576 7437.2025,-576 7502.7975,-576 7502.7975,-576 7508.7975,-576 7514.7975,-582 7514.7975,-588 7514.7975,-588 7514.7975,-600 7514.7975,-600 7514.7975,-606 7508.7975,-612 7502.7975,-612"/>
+<text text-anchor="middle" x="7470" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 88&#45;&gt;258 -->
+<g id="edge690" class="edge">
+<title>88-&gt;258</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7581.401,-647.8314C7561.6503,-638.2874 7537.2703,-626.5065 7516.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7517.8553,-613.2376 7507.3286,-612.038 7514.8097,-619.5403 7517.8553,-613.2376"/>
+</g>
+<!-- 89 -->
+<g id="node90" class="node">
+<title>89</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M5977.6605,-684C5977.6605,-684 5884.3395,-684 5884.3395,-684 5878.3395,-684 5872.3395,-678 5872.3395,-672 5872.3395,-672 5872.3395,-660 5872.3395,-660 5872.3395,-654 5878.3395,-648 5884.3395,-648 5884.3395,-648 5977.6605,-648 5977.6605,-648 5983.6605,-648 5989.6605,-654 5989.6605,-660 5989.6605,-660 5989.6605,-672 5989.6605,-672 5989.6605,-678 5983.6605,-684 5977.6605,-684"/>
+<text text-anchor="middle" x="5931" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 89&#45;&gt;2 -->
+<g id="edge90" class="edge">
+<title>89-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5989.7102,-648.9506C6032.7151,-636.0417 6084.9335,-619.3235 6093,-612 6130.0654,-578.3484 6148.5275,-548.1897 6125,-504 6070.2546,-401.1763 6017.147,-394.8729 5906,-360 5771.2029,-317.7067 4771.1374,-308.1822 4502.3465,-306.3766"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3667,-302.8767 4492.3439,-306.3107 4502.3205,-309.8766 4502.3667,-302.8767"/>
+</g>
+<!-- 89&#45;&gt;7 -->
+<g id="edge115" class="edge">
+<title>89-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5872.1289,-662.8582C5801.885,-659.1437 5680.8854,-652.854 5577,-648 5204.8136,-630.6097 5105.6648,-665.8465 4732.7886,-611.9209"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.2051,-608.4447 4722.8048,-610.4653 4732.1952,-615.3715 4733.2051,-608.4447"/>
+</g>
+<!-- 89&#45;&gt;8 -->
+<g id="edge136" class="edge">
+<title>89-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5872.1231,-662.9775C5801.8737,-659.3778 5680.8688,-653.1984 5577,-648 5255.4552,-631.9075 5167.9572,-668.6812 4847.0342,-611.9007"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.4438,-608.4185 4836.9841,-610.1056 4846.2129,-615.3095 4847.4438,-608.4185"/>
+</g>
+<!-- 89&#45;&gt;26 -->
+<g id="edge208" class="edge">
+<title>89-&gt;26</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5926.4053,-647.9555C5916.8006,-610.235 5894.5418,-522.8188 5883.0889,-477.8399"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5886.4797,-476.9722 5880.6203,-468.1451 5879.6961,-478.6995 5886.4797,-476.9722"/>
+</g>
+<!-- 89&#45;&gt;47 -->
+<g id="edge258" class="edge">
+<title>89-&gt;47</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5989.9279,-650.7811C6024.511,-640.5679 6063.4482,-626.3929 6074,-612 6086.8814,-594.4295 6087.2311,-569.3526 6084.8696,-550.1299"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6088.313,-549.4935 6083.341,-540.1378 6081.3935,-550.5521 6088.313,-549.4935"/>
+</g>
+<!-- 126 -->
+<g id="node127" class="node">
+<title>126</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M5861.6488,-540C5861.6488,-540 5808.3512,-540 5808.3512,-540 5802.3512,-540 5796.3512,-534 5796.3512,-528 5796.3512,-528 5796.3512,-516 5796.3512,-516 5796.3512,-510 5802.3512,-504 5808.3512,-504 5808.3512,-504 5861.6488,-504 5861.6488,-504 5867.6488,-504 5873.6488,-510 5873.6488,-516 5873.6488,-516 5873.6488,-528 5873.6488,-528 5873.6488,-534 5867.6488,-540 5861.6488,-540"/>
+<text text-anchor="middle" x="5835" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 89&#45;&gt;126 -->
+<g id="edge479" class="edge">
+<title>89-&gt;126</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5918.8415,-647.7623C5902.1067,-622.66 5871.8678,-577.3017 5852.6447,-548.4671"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5855.519,-546.4687 5847.0597,-540.0896 5849.6946,-550.3516 5855.519,-546.4687"/>
+</g>
+<!-- 127 -->
+<g id="node128" class="node">
+<title>127</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M6011.6762,-540C6011.6762,-540 5942.3238,-540 5942.3238,-540 5936.3238,-540 5930.3238,-534 5930.3238,-528 5930.3238,-528 5930.3238,-516 5930.3238,-516 5930.3238,-510 5936.3238,-504 5942.3238,-504 5942.3238,-504 6011.6762,-504 6011.6762,-504 6017.6762,-504 6023.6762,-510 6023.6762,-516 6023.6762,-516 6023.6762,-528 6023.6762,-528 6023.6762,-534 6017.6762,-540 6011.6762,-540"/>
+<text text-anchor="middle" x="5977" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 89&#45;&gt;127 -->
+<g id="edge481" class="edge">
+<title>89-&gt;127</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5936.8259,-647.7623C5944.7065,-623.0928 5958.8365,-578.8598 5968.0642,-549.9731"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5971.5124,-550.6805 5971.2214,-540.0896 5964.8443,-548.5503 5971.5124,-550.6805"/>
+</g>
+<!-- 152 -->
+<g id="node153" class="node">
+<title>152</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M6052.5931,-612C6052.5931,-612 6009.4069,-612 6009.4069,-612 6003.4069,-612 5997.4069,-606 5997.4069,-600 5997.4069,-600 5997.4069,-588 5997.4069,-588 5997.4069,-582 6003.4069,-576 6009.4069,-576 6009.4069,-576 6052.5931,-576 6052.5931,-576 6058.5931,-576 6064.5931,-582 6064.5931,-588 6064.5931,-588 6064.5931,-600 6064.5931,-600 6064.5931,-606 6058.5931,-612 6052.5931,-612"/>
+<text text-anchor="middle" x="6031" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 89&#45;&gt;152 -->
+<g id="edge514" class="edge">
+<title>89-&gt;152</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5956.2342,-647.8314C5968.788,-638.7927 5984.1283,-627.7476 5997.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5999.7036,-620.8463 6005.7739,-612.1628 5995.6134,-615.1655 5999.7036,-620.8463"/>
+</g>
+<!-- 259 -->
+<g id="node260" class="node">
+<title>259</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M5814.7975,-612C5814.7975,-612 5749.2025,-612 5749.2025,-612 5743.2025,-612 5737.2025,-606 5737.2025,-600 5737.2025,-600 5737.2025,-588 5737.2025,-588 5737.2025,-582 5743.2025,-576 5749.2025,-576 5749.2025,-576 5814.7975,-576 5814.7975,-576 5820.7975,-576 5826.7975,-582 5826.7975,-588 5826.7975,-588 5826.7975,-600 5826.7975,-600 5826.7975,-606 5820.7975,-612 5814.7975,-612"/>
+<text text-anchor="middle" x="5782" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 89&#45;&gt;259 -->
+<g id="edge693" class="edge">
+<title>89-&gt;259</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5893.401,-647.8314C5873.6503,-638.2874 5849.2703,-626.5065 5828.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5829.8553,-613.2376 5819.3286,-612.038 5826.8097,-619.5403 5829.8553,-613.2376"/>
+</g>
+<!-- 90 -->
+<g id="node91" class="node">
+<title>90</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M7243.6605,-684C7243.6605,-684 7150.3395,-684 7150.3395,-684 7144.3395,-684 7138.3395,-678 7138.3395,-672 7138.3395,-672 7138.3395,-660 7138.3395,-660 7138.3395,-654 7144.3395,-648 7150.3395,-648 7150.3395,-648 7243.6605,-648 7243.6605,-648 7249.6605,-648 7255.6605,-654 7255.6605,-660 7255.6605,-660 7255.6605,-672 7255.6605,-672 7255.6605,-678 7249.6605,-684 7243.6605,-684"/>
+<text text-anchor="middle" x="7197" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 90&#45;&gt;2 -->
+<g id="edge91" class="edge">
+<title>90-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7255.9604,-648.8424C7299.1673,-635.8723 7351.6775,-619.1246 7360,-612 7398.5443,-579.0036 7420.7476,-548.8383 7397,-504 7342.6524,-401.3852 7290.085,-393.8169 7179,-360 7047.0697,-319.8372 4908.2897,-308.1452 4502.2599,-306.283"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.1661,-302.7827 4492.1503,-306.2371 4502.1342,-309.7826 4502.1661,-302.7827"/>
+</g>
+<!-- 90&#45;&gt;7 -->
+<g id="edge116" class="edge">
+<title>90-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7138.1474,-662.3986C7067.9214,-658.2423 6946.9389,-651.5278 6843,-648 6377.4106,-632.1975 5213.6877,-673.4725 4732.9702,-611.8934"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1613,-608.3886 4722.7915,-610.5604 4732.2523,-615.3293 4733.1613,-608.3886"/>
+</g>
+<!-- 90&#45;&gt;8 -->
+<g id="edge137" class="edge">
+<title>90-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7138.1468,-662.4162C7067.9202,-658.2767 6946.9372,-651.5783 6843,-648 6624.2388,-640.4685 5107.3234,-647.5842 4847.3585,-611.7991"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6883,-608.3095 4837.2795,-610.2862 4846.6491,-615.2319 4847.6883,-608.3095"/>
+</g>
+<!-- 90&#45;&gt;27 -->
+<g id="edge212" class="edge">
+<title>90-&gt;27</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7193.9926,-647.9555C7187.7191,-610.3144 7173.1978,-523.1867 7165.6874,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7169.1206,-477.4336 7164.0242,-468.1451 7162.2159,-478.5844 7169.1206,-477.4336"/>
+</g>
+<!-- 90&#45;&gt;48 -->
+<g id="edge260" class="edge">
+<title>90-&gt;48</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7256.0022,-658.2925C7285.7671,-651.2503 7319.7592,-637.7767 7340,-612 7353.5343,-594.764 7355.6013,-569.6577 7354.6706,-550.3387"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7358.1543,-549.9908 7353.899,-540.2881 7351.1748,-550.5267 7358.1543,-549.9908"/>
+</g>
+<!-- 128 -->
+<g id="node129" class="node">
+<title>128</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M7133.6488,-540C7133.6488,-540 7080.3512,-540 7080.3512,-540 7074.3512,-540 7068.3512,-534 7068.3512,-528 7068.3512,-528 7068.3512,-516 7068.3512,-516 7068.3512,-510 7074.3512,-504 7080.3512,-504 7080.3512,-504 7133.6488,-504 7133.6488,-504 7139.6488,-504 7145.6488,-510 7145.6488,-516 7145.6488,-516 7145.6488,-528 7145.6488,-528 7145.6488,-534 7139.6488,-540 7133.6488,-540"/>
+<text text-anchor="middle" x="7107" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 90&#45;&gt;128 -->
+<g id="edge483" class="edge">
+<title>90-&gt;128</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7185.6014,-647.7623C7169.9802,-622.7682 7141.8077,-577.6924 7123.7755,-548.8409"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7126.574,-546.7146 7118.306,-540.0896 7120.638,-550.4246 7126.574,-546.7146"/>
+</g>
+<!-- 129 -->
+<g id="node130" class="node">
+<title>129</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M7283.6762,-540C7283.6762,-540 7214.3238,-540 7214.3238,-540 7208.3238,-540 7202.3238,-534 7202.3238,-528 7202.3238,-528 7202.3238,-516 7202.3238,-516 7202.3238,-510 7208.3238,-504 7214.3238,-504 7214.3238,-504 7283.6762,-504 7283.6762,-504 7289.6762,-504 7295.6762,-510 7295.6762,-516 7295.6762,-516 7295.6762,-528 7295.6762,-528 7295.6762,-534 7289.6762,-540 7283.6762,-540"/>
+<text text-anchor="middle" x="7249" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 90&#45;&gt;129 -->
+<g id="edge485" class="edge">
+<title>90-&gt;129</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7203.5858,-647.7623C7212.5333,-622.9846 7228.6076,-578.4714 7239.0355,-549.5939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7242.3631,-550.6839 7242.4676,-540.0896 7235.7792,-548.3064 7242.3631,-550.6839"/>
+</g>
+<!-- 153 -->
+<g id="node154" class="node">
+<title>153</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M7318.5931,-612C7318.5931,-612 7275.4069,-612 7275.4069,-612 7269.4069,-612 7263.4069,-606 7263.4069,-600 7263.4069,-600 7263.4069,-588 7263.4069,-588 7263.4069,-582 7269.4069,-576 7275.4069,-576 7275.4069,-576 7318.5931,-576 7318.5931,-576 7324.5931,-576 7330.5931,-582 7330.5931,-588 7330.5931,-588 7330.5931,-600 7330.5931,-600 7330.5931,-606 7324.5931,-612 7318.5931,-612"/>
+<text text-anchor="middle" x="7297" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 90&#45;&gt;153 -->
+<g id="edge515" class="edge">
+<title>90-&gt;153</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7222.2342,-647.8314C7234.788,-638.7927 7250.1283,-627.7476 7263.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7265.7036,-620.8463 7271.7739,-612.1628 7261.6134,-615.1655 7265.7036,-620.8463"/>
+</g>
+<!-- 260 -->
+<g id="node261" class="node">
+<title>260</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M7080.7975,-612C7080.7975,-612 7015.2025,-612 7015.2025,-612 7009.2025,-612 7003.2025,-606 7003.2025,-600 7003.2025,-600 7003.2025,-588 7003.2025,-588 7003.2025,-582 7009.2025,-576 7015.2025,-576 7015.2025,-576 7080.7975,-576 7080.7975,-576 7086.7975,-576 7092.7975,-582 7092.7975,-588 7092.7975,-588 7092.7975,-600 7092.7975,-600 7092.7975,-606 7086.7975,-612 7080.7975,-612"/>
+<text text-anchor="middle" x="7048" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 90&#45;&gt;260 -->
+<g id="edge696" class="edge">
+<title>90-&gt;260</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7159.401,-647.8314C7139.6503,-638.2874 7115.2703,-626.5065 7094.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7095.8553,-613.2376 7085.3286,-612.038 7092.8097,-619.5403 7095.8553,-613.2376"/>
+</g>
+<!-- 91 -->
+<g id="node92" class="node">
+<title>91</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M8087.6605,-684C8087.6605,-684 7994.3395,-684 7994.3395,-684 7988.3395,-684 7982.3395,-678 7982.3395,-672 7982.3395,-672 7982.3395,-660 7982.3395,-660 7982.3395,-654 7988.3395,-648 7994.3395,-648 7994.3395,-648 8087.6605,-648 8087.6605,-648 8093.6605,-648 8099.6605,-654 8099.6605,-660 8099.6605,-660 8099.6605,-672 8099.6605,-672 8099.6605,-678 8093.6605,-684 8087.6605,-684"/>
+<text text-anchor="middle" x="8041" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 91&#45;&gt;2 -->
+<g id="edge92" class="edge">
+<title>91-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8099.7764,-648.8696C8143.273,-635.8211 8196.4078,-618.9539 8205,-612 8245.0334,-579.5998 8271.3979,-549.3562 8247,-504 8190.933,-399.7704 8136.5043,-393.5274 8023,-360 7935.2655,-334.0846 4985.5604,-310.2413 4502.5825,-306.5066"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.3236,-303.0046 4492.2968,-306.4272 4502.2695,-310.0044 4502.3236,-303.0046"/>
+</g>
+<!-- 91&#45;&gt;7 -->
+<g id="edge117" class="edge">
+<title>91-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7982.1503,-662.3109C7911.927,-658.0703 7790.9472,-651.2747 7687,-648 7361.93,-637.7592 5101.2203,-654.3223 4732.8835,-611.8207"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1417,-608.3261 4722.7891,-610.5785 4732.2867,-615.2737 4733.1417,-608.3261"/>
+</g>
+<!-- 91&#45;&gt;8 -->
+<g id="edge138" class="edge">
+<title>91-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7982.15,-662.3197C7911.9265,-658.0875 7790.9464,-651.3001 7687,-648 7374.5483,-638.0803 5200.7528,-661.6023 4847.2019,-611.7994"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6863,-608.333 4837.2765,-610.3044 4846.6436,-615.2549 4847.6863,-608.333"/>
+</g>
+<!-- 91&#45;&gt;28 -->
+<g id="edge216" class="edge">
+<title>91-&gt;28</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8037.2095,-647.9732C8030.8613,-618.0114 8017.5388,-556.101 8005,-504 8002.9924,-495.6579 8000.6976,-486.6225 7998.5549,-478.3726"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8001.8763,-477.2401 7995.9551,-468.4543 7995.1051,-479.015 8001.8763,-477.2401"/>
+</g>
+<!-- 91&#45;&gt;49 -->
+<g id="edge262" class="edge">
+<title>91-&gt;49</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8099.6964,-657.6646C8129.1855,-650.4455 8163.0167,-637.003 8184,-612 8198.3173,-594.9399 8202.0569,-569.6071 8202.5075,-550.1606"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8206.0071,-550.038 8202.4657,-540.0526 8199.0072,-550.067 8206.0071,-550.038"/>
+</g>
+<!-- 130 -->
+<g id="node131" class="node">
+<title>130</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M7983.6488,-540C7983.6488,-540 7930.3512,-540 7930.3512,-540 7924.3512,-540 7918.3512,-534 7918.3512,-528 7918.3512,-528 7918.3512,-516 7918.3512,-516 7918.3512,-510 7924.3512,-504 7930.3512,-504 7930.3512,-504 7983.6488,-504 7983.6488,-504 7989.6488,-504 7995.6488,-510 7995.6488,-516 7995.6488,-516 7995.6488,-528 7995.6488,-528 7995.6488,-534 7989.6488,-540 7983.6488,-540"/>
+<text text-anchor="middle" x="7957" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 91&#45;&gt;130 -->
+<g id="edge487" class="edge">
+<title>91-&gt;130</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8030.3613,-647.7623C8015.7815,-622.7682 7989.4872,-577.6924 7972.6572,-548.8409"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7975.6143,-546.9639 7967.5523,-540.0896 7969.5678,-550.491 7975.6143,-546.9639"/>
+</g>
+<!-- 131 -->
+<g id="node132" class="node">
+<title>131</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M8133.6762,-540C8133.6762,-540 8064.3238,-540 8064.3238,-540 8058.3238,-540 8052.3238,-534 8052.3238,-528 8052.3238,-528 8052.3238,-516 8052.3238,-516 8052.3238,-510 8058.3238,-504 8064.3238,-504 8064.3238,-504 8133.6762,-504 8133.6762,-504 8139.6762,-504 8145.6762,-510 8145.6762,-516 8145.6762,-516 8145.6762,-528 8145.6762,-528 8145.6762,-534 8139.6762,-540 8133.6762,-540"/>
+<text text-anchor="middle" x="8099" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 91&#45;&gt;131 -->
+<g id="edge489" class="edge">
+<title>91-&gt;131</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8048.3457,-647.7623C8058.3256,-622.9846 8076.2546,-578.4714 8087.8858,-549.5939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8091.2243,-550.6731 8091.7139,-540.0896 8084.7312,-548.0578 8091.2243,-550.6731"/>
+</g>
+<!-- 154 -->
+<g id="node155" class="node">
+<title>154</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M8162.5931,-612C8162.5931,-612 8119.4069,-612 8119.4069,-612 8113.4069,-612 8107.4069,-606 8107.4069,-600 8107.4069,-600 8107.4069,-588 8107.4069,-588 8107.4069,-582 8113.4069,-576 8119.4069,-576 8119.4069,-576 8162.5931,-576 8162.5931,-576 8168.5931,-576 8174.5931,-582 8174.5931,-588 8174.5931,-588 8174.5931,-600 8174.5931,-600 8174.5931,-606 8168.5931,-612 8162.5931,-612"/>
+<text text-anchor="middle" x="8141" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 91&#45;&gt;154 -->
+<g id="edge516" class="edge">
+<title>91-&gt;154</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8066.2342,-647.8314C8078.788,-638.7927 8094.1283,-627.7476 8107.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8109.7036,-620.8463 8115.7739,-612.1628 8105.6134,-615.1655 8109.7036,-620.8463"/>
+</g>
+<!-- 261 -->
+<g id="node262" class="node">
+<title>261</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M7924.7975,-612C7924.7975,-612 7859.2025,-612 7859.2025,-612 7853.2025,-612 7847.2025,-606 7847.2025,-600 7847.2025,-600 7847.2025,-588 7847.2025,-588 7847.2025,-582 7853.2025,-576 7859.2025,-576 7859.2025,-576 7924.7975,-576 7924.7975,-576 7930.7975,-576 7936.7975,-582 7936.7975,-588 7936.7975,-588 7936.7975,-600 7936.7975,-600 7936.7975,-606 7930.7975,-612 7924.7975,-612"/>
+<text text-anchor="middle" x="7892" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 91&#45;&gt;261 -->
+<g id="edge699" class="edge">
+<title>91-&gt;261</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8003.401,-647.8314C7983.6503,-638.2874 7959.2703,-626.5065 7938.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7939.8553,-613.2376 7929.3286,-612.038 7936.8097,-619.5403 7939.8553,-613.2376"/>
+</g>
+<!-- 92 -->
+<g id="node93" class="node">
+<title>92</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M8509.6605,-684C8509.6605,-684 8416.3395,-684 8416.3395,-684 8410.3395,-684 8404.3395,-678 8404.3395,-672 8404.3395,-672 8404.3395,-660 8404.3395,-660 8404.3395,-654 8410.3395,-648 8416.3395,-648 8416.3395,-648 8509.6605,-648 8509.6605,-648 8515.6605,-648 8521.6605,-654 8521.6605,-660 8521.6605,-660 8521.6605,-672 8521.6605,-672 8521.6605,-678 8515.6605,-684 8509.6605,-684"/>
+<text text-anchor="middle" x="8463" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 92&#45;&gt;2 -->
+<g id="edge93" class="edge">
+<title>92-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8521.7764,-648.8696C8565.273,-635.8211 8618.4078,-618.9539 8627,-612 8655.7969,-588.6938 8659.3316,-575.7626 8669,-540 8701.7023,-419.0368 8571.9134,-396.3636 8452,-360 8353.4726,-330.1217 5016.582,-309.4007 4502.268,-306.3812"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.0715,-302.88 4492.0511,-306.3213 4502.0304,-309.8799 4502.0715,-302.88"/>
+</g>
+<!-- 92&#45;&gt;7 -->
+<g id="edge118" class="edge">
+<title>92-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8404.1511,-662.2835C8333.9287,-658.0165 8212.9497,-651.1956 8109,-648 7737.047,-636.5656 5147.6066,-660.0534 4732.7462,-611.8107"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1412,-608.333 4722.7883,-610.5842 4732.2854,-615.2805 4733.1412,-608.333"/>
+</g>
+<!-- 92&#45;&gt;8 -->
+<g id="edge139" class="edge">
+<title>92-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8404.1509,-662.2902C8333.9283,-658.0297 8212.9491,-651.2149 8109,-648 7749.7809,-636.8901 5248.5603,-668.6458 4847.4473,-611.8421"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6854,-608.3385 4837.2756,-610.31 4846.6428,-615.2604 4847.6854,-608.3385"/>
+</g>
+<!-- 92&#45;&gt;29 -->
+<g id="edge220" class="edge">
+<title>92-&gt;29</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8459.5749,-647.9555C8452.43,-610.3144 8435.8919,-523.1867 8427.3385,-478.1246"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8430.7477,-477.3169 8425.4442,-468.1451 8423.8705,-478.6224 8430.7477,-477.3169"/>
+</g>
+<!-- 92&#45;&gt;50 -->
+<g id="edge264" class="edge">
+<title>92-&gt;50</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8521.6964,-657.6646C8551.1855,-650.4455 8585.0167,-637.003 8606,-612 8620.3173,-594.9399 8624.0569,-569.6071 8624.5075,-550.1606"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8628.0071,-550.038 8624.4657,-540.0526 8621.0072,-550.067 8628.0071,-550.038"/>
+</g>
+<!-- 132 -->
+<g id="node133" class="node">
+<title>132</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M8405.6488,-540C8405.6488,-540 8352.3512,-540 8352.3512,-540 8346.3512,-540 8340.3512,-534 8340.3512,-528 8340.3512,-528 8340.3512,-516 8340.3512,-516 8340.3512,-510 8346.3512,-504 8352.3512,-504 8352.3512,-504 8405.6488,-504 8405.6488,-504 8411.6488,-504 8417.6488,-510 8417.6488,-516 8417.6488,-516 8417.6488,-528 8417.6488,-528 8417.6488,-534 8411.6488,-540 8405.6488,-540"/>
+<text text-anchor="middle" x="8379" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 92&#45;&gt;132 -->
+<g id="edge491" class="edge">
+<title>92-&gt;132</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8452.3613,-647.7623C8437.7815,-622.7682 8411.4872,-577.6924 8394.6572,-548.8409"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8397.6143,-546.9639 8389.5523,-540.0896 8391.5678,-550.491 8397.6143,-546.9639"/>
+</g>
+<!-- 133 -->
+<g id="node134" class="node">
+<title>133</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M8555.6762,-540C8555.6762,-540 8486.3238,-540 8486.3238,-540 8480.3238,-540 8474.3238,-534 8474.3238,-528 8474.3238,-528 8474.3238,-516 8474.3238,-516 8474.3238,-510 8480.3238,-504 8486.3238,-504 8486.3238,-504 8555.6762,-504 8555.6762,-504 8561.6762,-504 8567.6762,-510 8567.6762,-516 8567.6762,-516 8567.6762,-528 8567.6762,-528 8567.6762,-534 8561.6762,-540 8555.6762,-540"/>
+<text text-anchor="middle" x="8521" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 92&#45;&gt;133 -->
+<g id="edge493" class="edge">
+<title>92-&gt;133</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8470.3457,-647.7623C8480.3256,-622.9846 8498.2546,-578.4714 8509.8858,-549.5939"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8513.2243,-550.6731 8513.7139,-540.0896 8506.7312,-548.0578 8513.2243,-550.6731"/>
+</g>
+<!-- 155 -->
+<g id="node156" class="node">
+<title>155</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M8584.5931,-612C8584.5931,-612 8541.4069,-612 8541.4069,-612 8535.4069,-612 8529.4069,-606 8529.4069,-600 8529.4069,-600 8529.4069,-588 8529.4069,-588 8529.4069,-582 8535.4069,-576 8541.4069,-576 8541.4069,-576 8584.5931,-576 8584.5931,-576 8590.5931,-576 8596.5931,-582 8596.5931,-588 8596.5931,-588 8596.5931,-600 8596.5931,-600 8596.5931,-606 8590.5931,-612 8584.5931,-612"/>
+<text text-anchor="middle" x="8563" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 92&#45;&gt;155 -->
+<g id="edge517" class="edge">
+<title>92-&gt;155</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8488.2342,-647.8314C8500.788,-638.7927 8516.1283,-627.7476 8529.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8531.7036,-620.8463 8537.7739,-612.1628 8527.6134,-615.1655 8531.7036,-620.8463"/>
+</g>
+<!-- 262 -->
+<g id="node263" class="node">
+<title>262</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M8346.7975,-612C8346.7975,-612 8281.2025,-612 8281.2025,-612 8275.2025,-612 8269.2025,-606 8269.2025,-600 8269.2025,-600 8269.2025,-588 8269.2025,-588 8269.2025,-582 8275.2025,-576 8281.2025,-576 8281.2025,-576 8346.7975,-576 8346.7975,-576 8352.7975,-576 8358.7975,-582 8358.7975,-588 8358.7975,-588 8358.7975,-600 8358.7975,-600 8358.7975,-606 8352.7975,-612 8346.7975,-612"/>
+<text text-anchor="middle" x="8314" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 92&#45;&gt;262 -->
+<g id="edge702" class="edge">
+<title>92-&gt;262</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8425.401,-647.8314C8405.6503,-638.2874 8381.2703,-626.5065 8360.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8361.8553,-613.2376 8351.3286,-612.038 8358.8097,-619.5403 8361.8553,-613.2376"/>
+</g>
+<!-- 93 -->
+<g id="node94" class="node">
+<title>93</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M8931.6605,-684C8931.6605,-684 8838.3395,-684 8838.3395,-684 8832.3395,-684 8826.3395,-678 8826.3395,-672 8826.3395,-672 8826.3395,-660 8826.3395,-660 8826.3395,-654 8832.3395,-648 8838.3395,-648 8838.3395,-648 8931.6605,-648 8931.6605,-648 8937.6605,-648 8943.6605,-654 8943.6605,-660 8943.6605,-660 8943.6605,-672 8943.6605,-672 8943.6605,-678 8937.6605,-684 8931.6605,-684"/>
+<text text-anchor="middle" x="8885" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 93&#45;&gt;2 -->
+<g id="edge94" class="edge">
+<title>93-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8943.8904,-657.2636C9015.5231,-642.9173 9127,-606.9452 9127,-522 9127,-522 9127,-522 9127,-450 9127,-332.3263 8993.7832,-381.0087 8878,-360 8653.2601,-319.2213 5039.7219,-307.6703 4502.548,-306.1755"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4502.2726,-302.6748 4492.263,-306.1471 4502.2532,-309.6748 4502.2726,-302.6748"/>
+</g>
+<!-- 93&#45;&gt;7 -->
+<g id="edge119" class="edge">
+<title>93-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8826.1518,-662.2622C8755.93,-657.9747 8634.9515,-651.134 8531,-648 8112.255,-635.3753 5195.2646,-665.7885 4732.9346,-611.8377"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4733.1405,-608.3367 4722.7878,-610.5886 4732.2852,-615.2842 4733.1405,-608.3367"/>
+</g>
+<!-- 93&#45;&gt;8 -->
+<g id="edge140" class="edge">
+<title>93-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8826.1516,-662.2675C8755.9297,-657.985 8634.9511,-651.1493 8531,-648 8329.0598,-641.8821 5134.0895,-644.1164 4847.2019,-611.6349"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4847.6491,-608.1636 4837.2749,-610.3144 4846.726,-615.1025 4847.6491,-608.1636"/>
+</g>
+<!-- 93&#45;&gt;30 -->
+<g id="edge224" class="edge">
+<title>93-&gt;30</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8883.6908,-647.899C8881.3345,-617.8305 8875.6997,-555.7702 8866,-504 8864.4199,-495.5665 8862.2568,-486.5029 8860.1033,-478.2553"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8863.4149,-477.0932 8857.4255,-468.3537 8856.6576,-478.9207 8863.4149,-477.0932"/>
+</g>
+<!-- 93&#45;&gt;51 -->
+<g id="edge266" class="edge">
+<title>93-&gt;51</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8943.7714,-655.6327C8972.3785,-647.8993 9005.3868,-634.6101 9028,-612 9044.62,-595.3822 9053.2416,-569.8419 9057.6362,-550.2081"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="9061.0926,-550.7723 9059.618,-540.2806 9054.228,-549.4019 9061.0926,-550.7723"/>
+</g>
+<!-- 134 -->
+<g id="node135" class="node">
+<title>134</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M8844.6488,-540C8844.6488,-540 8791.3512,-540 8791.3512,-540 8785.3512,-540 8779.3512,-534 8779.3512,-528 8779.3512,-528 8779.3512,-516 8779.3512,-516 8779.3512,-510 8785.3512,-504 8791.3512,-504 8791.3512,-504 8844.6488,-504 8844.6488,-504 8850.6488,-504 8856.6488,-510 8856.6488,-516 8856.6488,-516 8856.6488,-528 8856.6488,-528 8856.6488,-534 8850.6488,-540 8844.6488,-540"/>
+<text text-anchor="middle" x="8818" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 93&#45;&gt;134 -->
+<g id="edge495" class="edge">
+<title>93-&gt;134</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8876.5144,-647.7623C8864.9356,-622.8764 8844.0938,-578.0822 8830.6632,-549.2165"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8833.8086,-547.6798 8826.4167,-540.0896 8827.4619,-550.6328 8833.8086,-547.6798"/>
+</g>
+<!-- 135 -->
+<g id="node136" class="node">
+<title>135</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M8994.6762,-540C8994.6762,-540 8925.3238,-540 8925.3238,-540 8919.3238,-540 8913.3238,-534 8913.3238,-528 8913.3238,-528 8913.3238,-516 8913.3238,-516 8913.3238,-510 8919.3238,-504 8925.3238,-504 8925.3238,-504 8994.6762,-504 8994.6762,-504 9000.6762,-504 9006.6762,-510 9006.6762,-516 9006.6762,-516 9006.6762,-528 9006.6762,-528 9006.6762,-534 9000.6762,-540 8994.6762,-540"/>
+<text text-anchor="middle" x="8960" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 93&#45;&gt;135 -->
+<g id="edge497" class="edge">
+<title>93-&gt;135</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8894.4988,-647.7623C8907.4602,-622.8764 8930.7905,-578.0822 8945.8248,-549.2165"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8949.0631,-550.5756 8950.5783,-540.0896 8942.8547,-547.342 8949.0631,-550.5756"/>
+</g>
+<!-- 156 -->
+<g id="node157" class="node">
+<title>156</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M9006.5931,-612C9006.5931,-612 8963.4069,-612 8963.4069,-612 8957.4069,-612 8951.4069,-606 8951.4069,-600 8951.4069,-600 8951.4069,-588 8951.4069,-588 8951.4069,-582 8957.4069,-576 8963.4069,-576 8963.4069,-576 9006.5931,-576 9006.5931,-576 9012.5931,-576 9018.5931,-582 9018.5931,-588 9018.5931,-588 9018.5931,-600 9018.5931,-600 9018.5931,-606 9012.5931,-612 9006.5931,-612"/>
+<text text-anchor="middle" x="8985" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 93&#45;&gt;156 -->
+<g id="edge518" class="edge">
+<title>93-&gt;156</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8910.2342,-647.8314C8922.788,-638.7927 8938.1283,-627.7476 8951.6391,-618.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8953.7036,-620.8463 8959.7739,-612.1628 8949.6134,-615.1655 8953.7036,-620.8463"/>
+</g>
+<!-- 263 -->
+<g id="node264" class="node">
+<title>263</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M8768.7975,-612C8768.7975,-612 8703.2025,-612 8703.2025,-612 8697.2025,-612 8691.2025,-606 8691.2025,-600 8691.2025,-600 8691.2025,-588 8691.2025,-588 8691.2025,-582 8697.2025,-576 8703.2025,-576 8703.2025,-576 8768.7975,-576 8768.7975,-576 8774.7975,-576 8780.7975,-582 8780.7975,-588 8780.7975,-588 8780.7975,-600 8780.7975,-600 8780.7975,-606 8774.7975,-612 8768.7975,-612"/>
+<text text-anchor="middle" x="8736" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 93&#45;&gt;263 -->
+<g id="edge705" class="edge">
+<title>93-&gt;263</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8847.401,-647.8314C8827.6503,-638.2874 8803.2703,-626.5065 8782.3583,-616.4013"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8783.8553,-613.2376 8773.3286,-612.038 8780.8097,-619.5403 8783.8553,-613.2376"/>
+</g>
+<!-- 94&#45;&gt;10 -->
+<g id="edge141" class="edge">
+<title>94-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M295.6259,-503.8314C289.5838,-495.6232 282.3237,-485.7606 275.6779,-476.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="278.3011,-474.3918 269.5542,-468.4133 272.6637,-478.5415 278.3011,-474.3918"/>
+</g>
+<!-- 95&#45;&gt;10 -->
+<g id="edge142" class="edge">
+<title>95-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M189.4585,-503.8314C200.4205,-494.9632 213.7699,-484.1637 225.6265,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="227.9755,-477.1734 233.5487,-468.1628 223.5729,-471.7313 227.9755,-477.1734"/>
+</g>
+<!-- 96&#45;&gt;11 -->
+<g id="edge145" class="edge">
+<title>96-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M722.3735,-503.8314C716.154,-495.5386 708.6678,-485.557 701.84,-476.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="704.61,-474.3133 695.81,-468.4133 699.01,-478.5133 704.61,-474.3133"/>
+</g>
+<!-- 97&#45;&gt;11 -->
+<g id="edge146" class="edge">
+<title>97-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M616.2061,-503.8314C627.045,-494.9632 640.2444,-484.1637 651.9678,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="654.2777,-477.2041 659.801,-468.1628 649.845,-471.7864 654.2777,-477.2041"/>
+</g>
+<!-- 98&#45;&gt;12 -->
+<g id="edge149" class="edge">
+<title>98-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2406.6446,-503.8314C2401.5674,-495.7079 2395.4773,-485.9637 2389.8824,-477.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2392.7763,-475.0383 2384.5083,-468.4133 2386.8403,-478.7483 2392.7763,-475.0383"/>
+</g>
+<!-- 99&#45;&gt;12 -->
+<g id="edge150" class="edge">
+<title>99-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2300.4772,-503.8314C2312.5395,-494.8779 2327.254,-483.9558 2340.2686,-474.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2342.587,-476.9335 2348.5306,-468.1628 2338.4148,-471.3127 2342.587,-476.9335"/>
+</g>
+<!-- 100&#45;&gt;13 -->
+<g id="edge153" class="edge">
+<title>100-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3681.4204,-503.8314C3677.6642,-495.8771 3673.1743,-486.369 3669.0202,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3672.1301,-475.9612 3664.6952,-468.4133 3665.8004,-478.9503 3672.1301,-475.9612"/>
+</g>
+<!-- 101&#45;&gt;13 -->
+<g id="edge154" class="edge">
+<title>101-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3575.253,-503.8314C3588.9389,-494.7074 3605.6915,-483.539 3620.3827,-473.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3622.3767,-476.6221 3628.7558,-468.1628 3618.4938,-470.7977 3622.3767,-476.6221"/>
+</g>
+<!-- 102&#45;&gt;14 -->
+<g id="edge157" class="edge">
+<title>102-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4486.6633,-503.8314C4482.5757,-495.8771 4477.6896,-486.369 4473.1691,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4476.1461,-475.7078 4468.4624,-468.4133 4469.9201,-478.9074 4476.1461,-475.7078"/>
+</g>
+<!-- 103&#45;&gt;14 -->
+<g id="edge158" class="edge">
+<title>103-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4409.6546,-503.8314C4417.4114,-495.3694 4426.7802,-485.1489 4435.261,-475.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4437.9439,-478.1499 4442.1212,-468.4133 4432.7838,-473.4198 4437.9439,-478.1499"/>
+</g>
+<!-- 104&#45;&gt;15 -->
+<g id="edge161" class="edge">
+<title>104-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1144.3735,-503.8314C1138.154,-495.5386 1130.6678,-485.557 1123.84,-476.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1126.61,-474.3133 1117.81,-468.4133 1121.01,-478.5133 1126.61,-474.3133"/>
+</g>
+<!-- 105&#45;&gt;15 -->
+<g id="edge162" class="edge">
+<title>105-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1038.2061,-503.8314C1049.045,-494.9632 1062.2444,-484.1637 1073.9678,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1076.2777,-477.2041 1081.801,-468.1628 1071.845,-471.7864 1076.2777,-477.2041"/>
+</g>
+<!-- 106&#45;&gt;16 -->
+<g id="edge165" class="edge">
+<title>106-&gt;16</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1990.8969,-503.8314C1985.9326,-495.7079 1979.9778,-485.9637 1974.5072,-477.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1977.4536,-475.121 1969.2526,-468.4133 1971.4806,-478.7712 1977.4536,-475.121"/>
+</g>
+<!-- 107&#45;&gt;16 -->
+<g id="edge166" class="edge">
+<title>107-&gt;16</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1884.7295,-503.8314C1896.9162,-494.8779 1911.7823,-483.9558 1924.9312,-474.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1927.2918,-476.9042 1933.2784,-468.1628 1923.1473,-471.263 1927.2918,-476.9042"/>
+</g>
+<!-- 108&#45;&gt;17 -->
+<g id="edge169" class="edge">
+<title>108-&gt;17</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2827.168,-503.8314C2823.3014,-495.8771 2818.6794,-486.369 2814.4032,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2817.4707,-475.8768 2809.9509,-468.4133 2811.1751,-478.9371 2817.4707,-475.8768"/>
+</g>
+<!-- 109&#45;&gt;17 -->
+<g id="edge170" class="edge">
+<title>109-&gt;17</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2721.0006,-503.8314C2734.4331,-494.7927 2750.8473,-483.7476 2765.3039,-474.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2767.6654,-476.6494 2774.008,-468.1628 2763.7575,-470.8418 2767.6654,-476.6494"/>
+</g>
+<!-- 110&#45;&gt;18 -->
+<g id="edge173" class="edge">
+<title>110-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1569.654,-503.8314C1565.0763,-495.7925 1559.5948,-486.1666 1554.5412,-477.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1557.4752,-475.3712 1549.4853,-468.4133 1551.3923,-478.8351 1557.4752,-475.3712"/>
+</g>
+<!-- 111&#45;&gt;18 -->
+<g id="edge174" class="edge">
+<title>111-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1463.4866,-503.8314C1476.1659,-494.7927 1491.6596,-483.7476 1505.3055,-474.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1507.4105,-476.8176 1513.5216,-468.1628 1503.3471,-471.1176 1507.4105,-476.8176"/>
+</g>
+<!-- 112&#45;&gt;19 -->
+<g id="edge177" class="edge">
+<title>112-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3254.3735,-503.8314C3248.154,-495.5386 3240.6678,-485.557 3233.84,-476.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3236.61,-474.3133 3227.81,-468.4133 3231.01,-478.5133 3236.61,-474.3133"/>
+</g>
+<!-- 113&#45;&gt;19 -->
+<g id="edge178" class="edge">
+<title>113-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3148.2061,-503.8314C3159.045,-494.9632 3172.2444,-484.1637 3183.9678,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3186.2777,-477.2041 3191.801,-468.1628 3181.845,-471.7864 3186.2777,-477.2041"/>
+</g>
+<!-- 114&#45;&gt;20 -->
+<g id="edge181" class="edge">
+<title>114-&gt;20</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4052.5978,-503.8314C4044.9585,-495.3694 4035.7317,-485.1489 4027.3793,-475.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4029.9221,-473.4906 4020.6231,-468.4133 4024.7262,-478.1813 4029.9221,-473.4906"/>
+</g>
+<!-- 115&#45;&gt;20 -->
+<g id="edge182" class="edge">
+<title>115-&gt;20</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3946.4304,-503.8314C3955.732,-495.1337 3967.0204,-484.5783 3977.1286,-475.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3979.6621,-477.5493 3984.5759,-468.1628 3974.8811,-472.4363 3979.6621,-477.5493"/>
+</g>
+<!-- 116&#45;&gt;21 -->
+<g id="edge185" class="edge">
+<title>116-&gt;21</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6693.3741,-503.8314C6699.4162,-495.6232 6706.6763,-485.7606 6713.3221,-476.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6716.3363,-478.5415 6719.4458,-468.4133 6710.6989,-474.3918 6716.3363,-478.5415"/>
+</g>
+<!-- 117&#45;&gt;21 -->
+<g id="edge186" class="edge">
+<title>117-&gt;21</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6799.5415,-503.8314C6788.5795,-494.9632 6775.2301,-484.1637 6763.3735,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6765.4271,-471.7313 6755.4513,-468.1628 6761.0245,-477.1734 6765.4271,-471.7313"/>
+</g>
+<!-- 118&#45;&gt;22 -->
+<g id="edge189" class="edge">
+<title>118-&gt;22</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4991.5796,-503.8314C4995.3358,-495.8771 4999.8257,-486.369 5003.9798,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5007.1996,-478.9503 5008.3048,-468.4133 5000.8699,-475.9612 5007.1996,-478.9503"/>
+</g>
+<!-- 119&#45;&gt;22 -->
+<g id="edge190" class="edge">
+<title>119-&gt;22</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5097.747,-503.8314C5084.0611,-494.7074 5067.3085,-483.539 5052.6173,-473.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5054.5062,-470.7977 5044.2442,-468.1628 5050.6233,-476.6221 5054.5062,-470.7977"/>
+</g>
+<!-- 120&#45;&gt;23 -->
+<g id="edge193" class="edge">
+<title>120-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6270.6265,-503.8314C6276.846,-495.5386 6284.3322,-485.557 6291.16,-476.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6293.99,-478.5133 6297.19,-468.4133 6288.39,-474.3133 6293.99,-478.5133"/>
+</g>
+<!-- 121&#45;&gt;23 -->
+<g id="edge194" class="edge">
+<title>121-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6376.7939,-503.8314C6365.955,-494.9632 6352.7556,-484.1637 6341.0322,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6343.155,-471.7864 6333.199,-468.1628 6338.7223,-477.2041 6343.155,-471.7864"/>
+</g>
+<!-- 122&#45;&gt;24 -->
+<g id="edge197" class="edge">
+<title>122-&gt;24</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5421.6171,-503.8314C5427.3172,-495.6232 5434.1663,-485.7606 5440.4359,-476.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5443.3838,-478.6234 5446.213,-468.4133 5437.6342,-474.6306 5443.3838,-478.6234"/>
+</g>
+<!-- 123&#45;&gt;24 -->
+<g id="edge198" class="edge">
+<title>123-&gt;24</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5527.7845,-503.8314C5516.453,-494.9632 5502.6536,-484.1637 5490.3973,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5492.2402,-471.5697 5482.2081,-468.1628 5487.926,-477.0822 5492.2402,-471.5697"/>
+</g>
+<!-- 124&#45;&gt;25 -->
+<g id="edge201" class="edge">
+<title>124-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7538.1218,-503.8314C7544.0499,-495.6232 7551.1729,-485.7606 7557.6933,-476.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7560.684,-478.5693 7563.7015,-468.4133 7555.0092,-474.4708 7560.684,-478.5693"/>
+</g>
+<!-- 125&#45;&gt;25 -->
+<g id="edge202" class="edge">
+<title>125-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7644.2892,-503.8314C7633.204,-494.9632 7619.7046,-484.1637 7607.7148,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7609.6987,-471.6768 7599.7035,-468.1628 7605.3258,-477.1429 7609.6987,-471.6768"/>
+</g>
+<!-- 126&#45;&gt;26 -->
+<g id="edge205" class="edge">
+<title>126-&gt;26</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5845.346,-503.8314C5849.9237,-495.7925 5855.4052,-486.1666 5860.4588,-477.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5863.6077,-478.8351 5865.5147,-468.4133 5857.5248,-475.3712 5863.6077,-478.8351"/>
+</g>
+<!-- 127&#45;&gt;26 -->
+<g id="edge206" class="edge">
+<title>127-&gt;26</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5951.5134,-503.8314C5938.8341,-494.7927 5923.3404,-483.7476 5909.6945,-474.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5911.6529,-471.1176 5901.4784,-468.1628 5907.5895,-476.8176 5911.6529,-471.1176"/>
+</g>
+<!-- 128&#45;&gt;27 -->
+<g id="edge209" class="edge">
+<title>128-&gt;27</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7120.6265,-503.8314C7126.846,-495.5386 7134.3322,-485.557 7141.16,-476.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7143.99,-478.5133 7147.19,-468.4133 7138.39,-474.3133 7143.99,-478.5133"/>
+</g>
+<!-- 129&#45;&gt;27 -->
+<g id="edge210" class="edge">
+<title>129-&gt;27</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7226.7939,-503.8314C7215.955,-494.9632 7202.7556,-484.1637 7191.0322,-474.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7193.155,-471.7864 7183.199,-468.1628 7188.7223,-477.2041 7193.155,-471.7864"/>
+</g>
+<!-- 130&#45;&gt;28 -->
+<g id="edge213" class="edge">
+<title>130-&gt;28</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7965.5796,-503.8314C7969.3358,-495.8771 7973.8257,-486.369 7977.9798,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7981.1996,-478.9503 7982.3048,-468.4133 7974.8699,-475.9612 7981.1996,-478.9503"/>
+</g>
+<!-- 131&#45;&gt;28 -->
+<g id="edge214" class="edge">
+<title>131-&gt;28</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8071.747,-503.8314C8058.0611,-494.7074 8041.3085,-483.539 8026.6173,-473.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8028.5062,-470.7977 8018.2442,-468.1628 8024.6233,-476.6221 8028.5062,-470.7977"/>
+</g>
+<!-- 132&#45;&gt;29 -->
+<g id="edge217" class="edge">
+<title>132-&gt;29</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8389.8507,-503.8314C8394.7023,-495.7079 8400.5217,-485.9637 8405.868,-477.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8408.8806,-478.7933 8411.0032,-468.4133 8402.8708,-475.2041 8408.8806,-478.7933"/>
+</g>
+<!-- 133&#45;&gt;29 -->
+<g id="edge218" class="edge">
+<title>133-&gt;29</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8496.0181,-503.8314C8483.7072,-494.8779 8468.6893,-483.9558 8455.4063,-474.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8457.1199,-471.214 8446.9739,-468.1628 8453.0027,-476.8752 8457.1199,-471.214"/>
+</g>
+<!-- 134&#45;&gt;30 -->
+<g id="edge221" class="edge">
+<title>134-&gt;30</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8826.5796,-503.8314C8830.3358,-495.8771 8834.8257,-486.369 8838.9798,-477.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8842.1996,-478.9503 8843.3048,-468.4133 8835.8699,-475.9612 8842.1996,-478.9503"/>
+</g>
+<!-- 135&#45;&gt;30 -->
+<g id="edge222" class="edge">
+<title>135-&gt;30</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8932.747,-503.8314C8919.0611,-494.7074 8902.3085,-483.539 8887.6173,-473.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8889.5062,-470.7977 8879.2442,-468.1628 8885.6233,-476.6221 8889.5062,-470.7977"/>
+</g>
+<!-- 136&#45;&gt;31 -->
+<g id="edge225" class="edge">
+<title>136-&gt;31</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M94.9063,-575.8314C90.4403,-567.7925 85.0925,-558.1666 80.1621,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="83.1456,-547.4551 75.2296,-540.4133 77.0265,-550.8546 83.1456,-547.4551"/>
+</g>
+<!-- 136&#45;&gt;95 -->
+<g id="edge416" class="edge">
+<title>136-&gt;95</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M120.6452,-575.8314C127.8591,-567.454 136.557,-557.3531 144.4605,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="147.2711,-550.2748 151.1441,-540.4133 141.9667,-545.7071 147.2711,-550.2748"/>
+</g>
+<!-- 137&#45;&gt;32 -->
+<g id="edge227" class="edge">
+<title>137-&gt;32</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M518.168,-575.8314C514.3014,-567.8771 509.6794,-558.369 505.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="508.4707,-547.8768 500.9509,-540.4133 502.1751,-550.9371 508.4707,-547.8768"/>
+</g>
+<!-- 137&#45;&gt;97 -->
+<g id="edge420" class="edge">
+<title>137-&gt;97</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M543.9069,-575.8314C551.7813,-567.3694 561.292,-557.1489 569.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="572.6153,-550.1183 576.8654,-540.4133 567.4908,-545.3497 572.6153,-550.1183"/>
+</g>
+<!-- 138&#45;&gt;33 -->
+<g id="edge229" class="edge">
+<title>138-&gt;33</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2204.654,-575.8314C2200.0763,-567.7925 2194.5948,-558.1666 2189.5412,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2192.4752,-547.3712 2184.4853,-540.4133 2186.3923,-550.8351 2192.4752,-547.3712"/>
+</g>
+<!-- 138&#45;&gt;99 -->
+<g id="edge424" class="edge">
+<title>138-&gt;99</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2230.3929,-575.8314C2237.4904,-567.454 2246.048,-557.3531 2253.824,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2256.6061,-550.3056 2260.3999,-540.4133 2251.2652,-545.7807 2256.6061,-550.3056"/>
+</g>
+<!-- 139&#45;&gt;34 -->
+<g id="edge231" class="edge">
+<title>139-&gt;34</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3472.168,-575.8314C3468.3014,-567.8771 3463.6794,-558.369 3459.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3462.4707,-547.8768 3454.9509,-540.4133 3456.1751,-550.9371 3462.4707,-547.8768"/>
+</g>
+<!-- 139&#45;&gt;101 -->
+<g id="edge428" class="edge">
+<title>139-&gt;101</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3497.9069,-575.8314C3505.7813,-567.3694 3515.292,-557.1489 3523.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3526.6153,-550.1183 3530.8654,-540.4133 3521.4908,-545.3497 3526.6153,-550.1183"/>
+</g>
+<!-- 140&#45;&gt;35 -->
+<g id="edge233" class="edge">
+<title>140-&gt;35</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4316.4204,-575.8314C4312.6642,-567.8771 4308.1743,-558.369 4304.0202,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4307.1301,-547.9612 4299.6952,-540.4133 4300.8004,-550.9503 4307.1301,-547.9612"/>
+</g>
+<!-- 140&#45;&gt;103 -->
+<g id="edge432" class="edge">
+<title>140-&gt;103</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4342.1593,-575.8314C4350.1511,-567.3694 4359.8038,-557.1489 4368.5416,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4371.288,-550.0866 4375.6097,-540.4133 4366.1989,-545.2802 4371.288,-550.0866"/>
+</g>
+<!-- 141&#45;&gt;36 -->
+<g id="edge235" class="edge">
+<title>141-&gt;36</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M940.168,-575.8314C936.3014,-567.8771 931.6794,-558.369 927.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="930.4707,-547.8768 922.9509,-540.4133 924.1751,-550.9371 930.4707,-547.8768"/>
+</g>
+<!-- 141&#45;&gt;105 -->
+<g id="edge436" class="edge">
+<title>141-&gt;105</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M965.9069,-575.8314C973.7813,-567.3694 983.292,-557.1489 991.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="994.6153,-550.1183 998.8654,-540.4133 989.4908,-545.3497 994.6153,-550.1183"/>
+</g>
+<!-- 142&#45;&gt;37 -->
+<g id="edge237" class="edge">
+<title>142-&gt;37</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1784.168,-575.8314C1780.3014,-567.8771 1775.6794,-558.369 1771.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1774.4707,-547.8768 1766.9509,-540.4133 1768.1751,-550.9371 1774.4707,-547.8768"/>
+</g>
+<!-- 142&#45;&gt;107 -->
+<g id="edge440" class="edge">
+<title>142-&gt;107</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1809.9069,-575.8314C1817.7813,-567.3694 1827.292,-557.1489 1835.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1838.6153,-550.1183 1842.8654,-540.4133 1833.4908,-545.3497 1838.6153,-550.1183"/>
+</g>
+<!-- 143&#45;&gt;38 -->
+<g id="edge239" class="edge">
+<title>143-&gt;38</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2625.6446,-575.8314C2620.5674,-567.7079 2614.4773,-557.9637 2608.8824,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2611.7763,-547.0383 2603.5083,-540.4133 2605.8403,-550.7483 2611.7763,-547.0383"/>
+</g>
+<!-- 143&#45;&gt;109 -->
+<g id="edge444" class="edge">
+<title>143-&gt;109</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2651.3835,-575.8314C2657.9486,-567.5386 2665.8507,-557.557 2673.0578,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2675.9599,-550.4262 2679.4228,-540.4133 2670.4716,-546.0813 2675.9599,-550.4262"/>
+</g>
+<!-- 144&#45;&gt;39 -->
+<g id="edge241" class="edge">
+<title>144-&gt;39</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1362.168,-575.8314C1358.3014,-567.8771 1353.6794,-558.369 1349.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1352.4707,-547.8768 1344.9509,-540.4133 1346.1751,-550.9371 1352.4707,-547.8768"/>
+</g>
+<!-- 144&#45;&gt;111 -->
+<g id="edge448" class="edge">
+<title>144-&gt;111</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1387.9069,-575.8314C1395.7813,-567.3694 1405.292,-557.1489 1413.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1416.6153,-550.1183 1420.8654,-540.4133 1411.4908,-545.3497 1416.6153,-550.1183"/>
+</g>
+<!-- 145&#45;&gt;40 -->
+<g id="edge243" class="edge">
+<title>145-&gt;40</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3050.168,-575.8314C3046.3014,-567.8771 3041.6794,-558.369 3037.4032,-549.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3040.4707,-547.8768 3032.9509,-540.4133 3034.1751,-550.9371 3040.4707,-547.8768"/>
+</g>
+<!-- 145&#45;&gt;113 -->
+<g id="edge452" class="edge">
+<title>145-&gt;113</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3075.9069,-575.8314C3083.7813,-567.3694 3093.292,-557.1489 3101.9013,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3104.6153,-550.1183 3108.8654,-540.4133 3099.4908,-545.3497 3104.6153,-550.1183"/>
+</g>
+<!-- 146&#45;&gt;41 -->
+<g id="edge245" class="edge">
+<title>146-&gt;41</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3854.9063,-575.8314C3850.4403,-567.7925 3845.0925,-558.1666 3840.1621,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3843.1456,-547.4551 3835.2296,-540.4133 3837.0265,-550.8546 3843.1456,-547.4551"/>
+</g>
+<!-- 146&#45;&gt;115 -->
+<g id="edge456" class="edge">
+<title>146-&gt;115</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3880.6452,-575.8314C3887.8591,-567.454 3896.557,-557.3531 3904.4605,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3907.2711,-550.2748 3911.1441,-540.4133 3901.9667,-545.7071 3907.2711,-550.2748"/>
+</g>
+<!-- 147&#45;&gt;42 -->
+<g id="edge247" class="edge">
+<title>147-&gt;42</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6887.3648,-575.8314C6892.9509,-567.6232 6899.663,-557.7606 6905.8072,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6908.736,-550.6496 6911.4687,-540.4133 6902.949,-546.7112 6908.736,-550.6496"/>
+</g>
+<!-- 147&#45;&gt;117 -->
+<g id="edge460" class="edge">
+<title>147-&gt;117</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6861.6259,-575.8314C6855.5838,-567.6232 6848.3237,-557.7606 6841.6779,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6844.3011,-546.3918 6835.5542,-540.4133 6838.6637,-550.5415 6844.3011,-546.3918"/>
+</g>
+<!-- 148&#45;&gt;43 -->
+<g id="edge249" class="edge">
+<title>148-&gt;43</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5197.0937,-575.8314C5201.5597,-567.7925 5206.9075,-558.1666 5211.8379,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5214.9735,-550.8546 5216.7704,-540.4133 5208.8544,-547.4551 5214.9735,-550.8546"/>
+</g>
+<!-- 148&#45;&gt;119 -->
+<g id="edge464" class="edge">
+<title>148-&gt;119</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5171.3548,-575.8314C5164.1409,-567.454 5155.443,-557.3531 5147.5395,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5150.0333,-545.7071 5140.8559,-540.4133 5144.7289,-550.2748 5150.0333,-545.7071"/>
+</g>
+<!-- 149&#45;&gt;44 -->
+<g id="edge251" class="edge">
+<title>149-&gt;44</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6465.1124,-575.8314C6470.5281,-567.7079 6477.0242,-557.9637 6482.9921,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6486.0896,-550.6753 6488.7245,-540.4133 6480.2653,-546.7923 6486.0896,-550.6753"/>
+</g>
+<!-- 149&#45;&gt;121 -->
+<g id="edge468" class="edge">
+<title>149-&gt;121</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6439.3735,-575.8314C6433.154,-567.5386 6425.6678,-557.557 6418.84,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6421.61,-546.3133 6412.81,-540.4133 6416.01,-550.5133 6421.61,-546.3133"/>
+</g>
+<!-- 150&#45;&gt;45 -->
+<g id="edge253" class="edge">
+<title>150-&gt;45</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5620.1031,-575.8314C5625.0674,-567.7079 5631.0222,-557.9637 5636.4928,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5639.5194,-550.7712 5641.7474,-540.4133 5633.5464,-547.121 5639.5194,-550.7712"/>
+</g>
+<!-- 150&#45;&gt;123 -->
+<g id="edge472" class="edge">
+<title>150-&gt;123</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5594.3642,-575.8314C5587.6839,-567.5386 5579.6432,-557.557 5572.3096,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5574.8319,-546.0052 5565.8329,-540.4133 5569.3806,-550.3965 5574.8319,-546.0052"/>
+</g>
+<!-- 151&#45;&gt;46 -->
+<g id="edge255" class="edge">
+<title>151-&gt;46</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7731.6171,-575.8314C7737.3172,-567.6232 7744.1663,-557.7606 7750.4359,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7753.3838,-550.6234 7756.213,-540.4133 7747.6342,-546.6306 7753.3838,-550.6234"/>
+</g>
+<!-- 151&#45;&gt;125 -->
+<g id="edge476" class="edge">
+<title>151-&gt;125</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7705.8782,-575.8314C7699.9501,-567.6232 7692.8271,-557.7606 7686.3067,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7688.9908,-546.4708 7680.2985,-540.4133 7683.316,-550.5693 7688.9908,-546.4708"/>
+</g>
+<!-- 152&#45;&gt;47 -->
+<g id="edge257" class="edge">
+<title>152-&gt;47</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6043.1124,-575.8314C6048.5281,-567.7079 6055.0242,-557.9637 6060.9921,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6064.0896,-550.6753 6066.7245,-540.4133 6058.2653,-546.7923 6064.0896,-550.6753"/>
+</g>
+<!-- 152&#45;&gt;127 -->
+<g id="edge480" class="edge">
+<title>152-&gt;127</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6017.3735,-575.8314C6011.154,-567.5386 6003.6678,-557.557 5996.84,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5999.61,-546.3133 5990.81,-540.4133 5994.01,-550.5133 5999.61,-546.3133"/>
+</g>
+<!-- 153&#45;&gt;48 -->
+<g id="edge259" class="edge">
+<title>153-&gt;48</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7310.6265,-575.8314C7316.846,-567.5386 7324.3322,-557.557 7331.16,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7333.99,-550.5133 7337.19,-540.4133 7328.39,-546.3133 7333.99,-550.5133"/>
+</g>
+<!-- 153&#45;&gt;129 -->
+<g id="edge484" class="edge">
+<title>153-&gt;129</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7284.8876,-575.8314C7279.4719,-567.7079 7272.9758,-557.9637 7267.0079,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7269.7347,-546.7923 7261.2755,-540.4133 7263.9104,-550.6753 7269.7347,-546.7923"/>
+</g>
+<!-- 154&#45;&gt;49 -->
+<g id="edge261" class="edge">
+<title>154-&gt;49</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8156.1405,-575.8314C8163.1217,-567.454 8171.5391,-557.3531 8179.1876,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8181.9425,-550.3362 8185.6556,-540.4133 8176.5649,-545.8548 8181.9425,-550.3362"/>
+</g>
+<!-- 154&#45;&gt;131 -->
+<g id="edge488" class="edge">
+<title>154-&gt;131</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8130.4016,-575.8314C8125.7123,-567.7925 8120.0972,-558.1666 8114.9202,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8117.8031,-547.2875 8109.7411,-540.4133 8111.7566,-550.8146 8117.8031,-547.2875"/>
+</g>
+<!-- 155&#45;&gt;50 -->
+<g id="edge263" class="edge">
+<title>155-&gt;50</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8578.1405,-575.8314C8585.1217,-567.454 8593.5391,-557.3531 8601.1876,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8603.9425,-550.3362 8607.6556,-540.4133 8598.5649,-545.8548 8603.9425,-550.3362"/>
+</g>
+<!-- 155&#45;&gt;133 -->
+<g id="edge492" class="edge">
+<title>155-&gt;133</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8552.4016,-575.8314C8547.7123,-567.7925 8542.0972,-558.1666 8536.9202,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8539.8031,-547.2875 8531.7411,-540.4133 8533.7566,-550.8146 8539.8031,-547.2875"/>
+</g>
+<!-- 156&#45;&gt;51 -->
+<g id="edge265" class="edge">
+<title>156-&gt;51</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M9004.4304,-575.8314C9013.732,-567.1337 9025.0204,-556.5783 9035.1286,-547.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="9037.6621,-549.5493 9042.5759,-540.1628 9032.8811,-544.4363 9037.6621,-549.5493"/>
+</g>
+<!-- 156&#45;&gt;135 -->
+<g id="edge496" class="edge">
+<title>156-&gt;135</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8978.6914,-575.8314C8975.9883,-568.0463 8972.7684,-558.7729 8969.769,-550.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8972.98,-548.7119 8966.3935,-540.4133 8966.3673,-551.0081 8972.98,-548.7119"/>
+</g>
+<!-- 157 -->
+<g id="node158" class="node">
+<title>157</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M414.2072,-828C414.2072,-828 349.7928,-828 349.7928,-828 343.7928,-828 337.7928,-822 337.7928,-816 337.7928,-816 337.7928,-804 337.7928,-804 337.7928,-798 343.7928,-792 349.7928,-792 349.7928,-792 414.2072,-792 414.2072,-792 420.2072,-792 426.2072,-798 426.2072,-804 426.2072,-804 426.2072,-816 426.2072,-816 426.2072,-822 420.2072,-828 414.2072,-828"/>
+<text text-anchor="middle" x="382" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="382" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 1A</text>
+</g>
+<!-- 157&#45;&gt;52 -->
+<g id="edge268" class="edge">
+<title>157-&gt;52</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M383.4504,-791.8284C385.5007,-764.5296 389,-711.3034 389,-666 389,-666 389,-666 389,-522 389,-481.2738 378.804,-435.0849 371.182,-406.2458"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="374.5185,-405.1771 368.5139,-396.4481 367.7644,-407.0164 374.5185,-405.1771"/>
+</g>
+<!-- 178 -->
+<g id="node179" class="node">
+<title>178</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M237.0981,-756C237.0981,-756 178.9019,-756 178.9019,-756 172.9019,-756 166.9019,-750 166.9019,-744 166.9019,-744 166.9019,-732 166.9019,-732 166.9019,-726 172.9019,-720 178.9019,-720 178.9019,-720 237.0981,-720 237.0981,-720 243.0981,-720 249.0981,-726 249.0981,-732 249.0981,-732 249.0981,-744 249.0981,-744 249.0981,-750 243.0981,-756 237.0981,-756"/>
+<text text-anchor="middle" x="208" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 157&#45;&gt;178 -->
+<g id="edge540" class="edge">
+<title>157-&gt;178</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M338.0925,-791.8314C313.9,-781.8207 283.7599,-769.3489 258.5842,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="259.7795,-755.6383 249.2011,-755.0487 257.103,-762.1064 259.7795,-755.6383"/>
+</g>
+<!-- 179 -->
+<g id="node180" class="node">
+<title>179</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M349.3175,-756C349.3175,-756 278.6825,-756 278.6825,-756 272.6825,-756 266.6825,-750 266.6825,-744 266.6825,-744 266.6825,-732 266.6825,-732 266.6825,-726 272.6825,-720 278.6825,-720 278.6825,-720 349.3175,-720 349.3175,-720 355.3175,-720 361.3175,-726 361.3175,-732 361.3175,-732 361.3175,-744 361.3175,-744 361.3175,-750 355.3175,-756 349.3175,-756"/>
+<text text-anchor="middle" x="314" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 157&#45;&gt;179 -->
+<g id="edge542" class="edge">
+<title>157-&gt;179</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M364.8407,-791.8314C356.8489,-783.3694 347.1962,-773.1489 338.4584,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="340.8011,-761.2802 331.3903,-756.4133 335.712,-766.0866 340.8011,-761.2802"/>
+</g>
+<!-- 158 -->
+<g id="node159" class="node">
+<title>158</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M828.2072,-828C828.2072,-828 763.7928,-828 763.7928,-828 757.7928,-828 751.7928,-822 751.7928,-816 751.7928,-816 751.7928,-804 751.7928,-804 751.7928,-798 757.7928,-792 763.7928,-792 763.7928,-792 828.2072,-792 828.2072,-792 834.2072,-792 840.2072,-798 840.2072,-804 840.2072,-804 840.2072,-816 840.2072,-816 840.2072,-822 834.2072,-828 828.2072,-828"/>
+<text text-anchor="middle" x="796" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="796" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 2A</text>
+</g>
+<!-- 158&#45;&gt;53 -->
+<g id="edge270" class="edge">
+<title>158-&gt;53</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M799.108,-791.8777C803.5016,-764.6417 811,-711.4948 811,-666 811,-666 811,-666 811,-522 811,-481.2738 800.804,-435.0849 793.182,-406.2458"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="796.5185,-405.1771 790.5139,-396.4481 789.7644,-407.0164 796.5185,-405.1771"/>
+</g>
+<!-- 183 -->
+<g id="node184" class="node">
+<title>183</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M659.0981,-756C659.0981,-756 600.9019,-756 600.9019,-756 594.9019,-756 588.9019,-750 588.9019,-744 588.9019,-744 588.9019,-732 588.9019,-732 588.9019,-726 594.9019,-720 600.9019,-720 600.9019,-720 659.0981,-720 659.0981,-720 665.0981,-720 671.0981,-726 671.0981,-732 671.0981,-732 671.0981,-744 671.0981,-744 671.0981,-750 665.0981,-756 659.0981,-756"/>
+<text text-anchor="middle" x="630" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 158&#45;&gt;183 -->
+<g id="edge545" class="edge">
+<title>158-&gt;183</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M754.1112,-791.8314C731.8253,-782.1652 704.249,-770.2044 680.7545,-760.014"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="681.8673,-756.6817 671.3004,-755.9134 679.0819,-763.1036 681.8673,-756.6817"/>
+</g>
+<!-- 184 -->
+<g id="node185" class="node">
+<title>184</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M771.3175,-756C771.3175,-756 700.6825,-756 700.6825,-756 694.6825,-756 688.6825,-750 688.6825,-744 688.6825,-744 688.6825,-732 688.6825,-732 688.6825,-726 694.6825,-720 700.6825,-720 700.6825,-720 771.3175,-720 771.3175,-720 777.3175,-720 783.3175,-726 783.3175,-732 783.3175,-732 783.3175,-744 783.3175,-744 783.3175,-750 777.3175,-756 771.3175,-756"/>
+<text text-anchor="middle" x="736" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 158&#45;&gt;184 -->
+<g id="edge547" class="edge">
+<title>158-&gt;184</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M780.8595,-791.8314C773.8783,-783.454 765.4609,-773.3531 757.8124,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="760.4351,-761.8548 751.3444,-756.4133 755.0575,-766.3362 760.4351,-761.8548"/>
+</g>
+<!-- 159 -->
+<g id="node160" class="node">
+<title>159</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M2428.2072,-828C2428.2072,-828 2363.7928,-828 2363.7928,-828 2357.7928,-828 2351.7928,-822 2351.7928,-816 2351.7928,-816 2351.7928,-804 2351.7928,-804 2351.7928,-798 2357.7928,-792 2363.7928,-792 2363.7928,-792 2428.2072,-792 2428.2072,-792 2434.2072,-792 2440.2072,-798 2440.2072,-804 2440.2072,-804 2440.2072,-816 2440.2072,-816 2440.2072,-822 2434.2072,-828 2428.2072,-828"/>
+<text text-anchor="middle" x="2396" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="2396" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 3A</text>
+</g>
+<!-- 159&#45;&gt;54 -->
+<g id="edge272" class="edge">
+<title>159-&gt;54</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2395.0202,-791.9095C2392.7196,-743.5419 2388.6687,-612.4394 2410,-576 2424.9478,-550.4653 2451.8217,-565.9699 2466,-540 2473.667,-525.9566 2466.1904,-519.9989 2466,-504 2465.6012,-470.4968 2464.6062,-431.9932 2463.8708,-406.4578"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2467.3664,-406.2533 2463.5741,-396.3605 2460.3694,-406.459 2467.3664,-406.2533"/>
+</g>
+<!-- 186 -->
+<g id="node187" class="node">
+<title>186</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M2362.0981,-756C2362.0981,-756 2303.9019,-756 2303.9019,-756 2297.9019,-756 2291.9019,-750 2291.9019,-744 2291.9019,-744 2291.9019,-732 2291.9019,-732 2291.9019,-726 2297.9019,-720 2303.9019,-720 2303.9019,-720 2362.0981,-720 2362.0981,-720 2368.0981,-720 2374.0981,-726 2374.0981,-732 2374.0981,-732 2374.0981,-744 2374.0981,-744 2374.0981,-750 2368.0981,-756 2362.0981,-756"/>
+<text text-anchor="middle" x="2333" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 159&#45;&gt;186 -->
+<g id="edge550" class="edge">
+<title>159-&gt;186</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2380.1024,-791.8314C2372.7722,-783.454 2363.934,-773.3531 2355.9031,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2358.3307,-761.6343 2349.1116,-756.4133 2353.0627,-766.2438 2358.3307,-761.6343"/>
+</g>
+<!-- 187 -->
+<g id="node188" class="node">
+<title>187</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M2262.3175,-756C2262.3175,-756 2191.6825,-756 2191.6825,-756 2185.6825,-756 2179.6825,-750 2179.6825,-744 2179.6825,-744 2179.6825,-732 2179.6825,-732 2179.6825,-726 2185.6825,-720 2191.6825,-720 2191.6825,-720 2262.3175,-720 2262.3175,-720 2268.3175,-720 2274.3175,-726 2274.3175,-732 2274.3175,-732 2274.3175,-744 2274.3175,-744 2274.3175,-750 2268.3175,-756 2262.3175,-756"/>
+<text text-anchor="middle" x="2227" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 159&#45;&gt;187 -->
+<g id="edge552" class="edge">
+<title>159-&gt;187</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2353.3542,-791.8314C2330.651,-782.159 2302.5549,-770.1891 2278.6258,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2279.9109,-756.7376 2269.3392,-756.038 2277.1672,-763.1775 2279.9109,-756.7376"/>
+</g>
+<!-- 160 -->
+<g id="node161" class="node">
+<title>160</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M3782.2072,-828C3782.2072,-828 3717.7928,-828 3717.7928,-828 3711.7928,-828 3705.7928,-822 3705.7928,-816 3705.7928,-816 3705.7928,-804 3705.7928,-804 3705.7928,-798 3711.7928,-792 3717.7928,-792 3717.7928,-792 3782.2072,-792 3782.2072,-792 3788.2072,-792 3794.2072,-798 3794.2072,-804 3794.2072,-804 3794.2072,-816 3794.2072,-816 3794.2072,-822 3788.2072,-828 3782.2072,-828"/>
+<text text-anchor="middle" x="3750" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="3750" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 4A</text>
+</g>
+<!-- 160&#45;&gt;55 -->
+<g id="edge274" class="edge">
+<title>160-&gt;55</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3750.417,-791.9875C3751.9735,-724.7447 3757.4519,-488.0792 3759.3482,-406.1585"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3762.8488,-406.1677 3759.5813,-396.0894 3755.8507,-406.0057 3762.8488,-406.1677"/>
+</g>
+<!-- 189 -->
+<g id="node190" class="node">
+<title>189</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M3725.0981,-756C3725.0981,-756 3666.9019,-756 3666.9019,-756 3660.9019,-756 3654.9019,-750 3654.9019,-744 3654.9019,-744 3654.9019,-732 3654.9019,-732 3654.9019,-726 3660.9019,-720 3666.9019,-720 3666.9019,-720 3725.0981,-720 3725.0981,-720 3731.0981,-720 3737.0981,-726 3737.0981,-732 3737.0981,-732 3737.0981,-744 3737.0981,-744 3737.0981,-750 3731.0981,-756 3725.0981,-756"/>
+<text text-anchor="middle" x="3696" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 160&#45;&gt;189 -->
+<g id="edge555" class="edge">
+<title>160-&gt;189</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3736.3735,-791.8314C3730.154,-783.5386 3722.6678,-773.557 3715.84,-764.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3718.61,-762.3133 3709.81,-756.4133 3713.01,-766.5133 3718.61,-762.3133"/>
+</g>
+<!-- 190 -->
+<g id="node191" class="node">
+<title>190</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M3625.3175,-756C3625.3175,-756 3554.6825,-756 3554.6825,-756 3548.6825,-756 3542.6825,-750 3542.6825,-744 3542.6825,-744 3542.6825,-732 3542.6825,-732 3542.6825,-726 3548.6825,-720 3554.6825,-720 3554.6825,-720 3625.3175,-720 3625.3175,-720 3631.3175,-720 3637.3175,-726 3637.3175,-732 3637.3175,-732 3637.3175,-744 3637.3175,-744 3637.3175,-750 3631.3175,-756 3625.3175,-756"/>
+<text text-anchor="middle" x="3590" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 160&#45;&gt;190 -->
+<g id="edge557" class="edge">
+<title>160-&gt;190</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3709.6252,-791.8314C3688.3213,-782.2446 3662.0017,-770.4008 3639.4789,-760.2655"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3640.6399,-756.95 3630.0844,-756.038 3637.7674,-763.3334 3640.6399,-756.95"/>
+</g>
+<!-- 161 -->
+<g id="node162" class="node">
+<title>161</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M4572.2072,-828C4572.2072,-828 4507.7928,-828 4507.7928,-828 4501.7928,-828 4495.7928,-822 4495.7928,-816 4495.7928,-816 4495.7928,-804 4495.7928,-804 4495.7928,-798 4501.7928,-792 4507.7928,-792 4507.7928,-792 4572.2072,-792 4572.2072,-792 4578.2072,-792 4584.2072,-798 4584.2072,-804 4584.2072,-804 4584.2072,-816 4584.2072,-816 4584.2072,-822 4578.2072,-828 4572.2072,-828"/>
+<text text-anchor="middle" x="4540" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="4540" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 5A</text>
+</g>
+<!-- 161&#45;&gt;56 -->
+<g id="edge276" class="edge">
+<title>161-&gt;56</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4584.4977,-804.0989C4709.5486,-785.5878 5048.9827,-721.047 4954,-576 4929.9359,-539.252 4655.0501,-435.024 4545.0732,-394.4494"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4546.171,-391.1239 4535.5776,-390.9531 4543.7524,-397.6928 4546.171,-391.1239"/>
+</g>
+<!-- 192 -->
+<g id="node193" class="node">
+<title>192</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M4460.0981,-756C4460.0981,-756 4401.9019,-756 4401.9019,-756 4395.9019,-756 4389.9019,-750 4389.9019,-744 4389.9019,-744 4389.9019,-732 4389.9019,-732 4389.9019,-726 4395.9019,-720 4401.9019,-720 4401.9019,-720 4460.0981,-720 4460.0981,-720 4466.0981,-720 4472.0981,-726 4472.0981,-732 4472.0981,-732 4472.0981,-744 4472.0981,-744 4472.0981,-750 4466.0981,-756 4460.0981,-756"/>
+<text text-anchor="middle" x="4431" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 161&#45;&gt;192 -->
+<g id="edge560" class="edge">
+<title>161-&gt;192</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4512.4947,-791.8314C4498.682,-782.7074 4481.7744,-771.539 4466.9471,-761.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4468.7696,-758.7541 4458.4965,-756.1628 4464.9114,-764.5949 4468.7696,-758.7541"/>
+</g>
+<!-- 193 -->
+<g id="node194" class="node">
+<title>193</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M4572.3175,-756C4572.3175,-756 4501.6825,-756 4501.6825,-756 4495.6825,-756 4489.6825,-750 4489.6825,-744 4489.6825,-744 4489.6825,-732 4489.6825,-732 4489.6825,-726 4495.6825,-720 4501.6825,-720 4501.6825,-720 4572.3175,-720 4572.3175,-720 4578.3175,-720 4584.3175,-726 4584.3175,-732 4584.3175,-732 4584.3175,-744 4584.3175,-744 4584.3175,-750 4578.3175,-756 4572.3175,-756"/>
+<text text-anchor="middle" x="4537" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 161&#45;&gt;193 -->
+<g id="edge562" class="edge">
+<title>161-&gt;193</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4539.243,-791.8314C4538.9221,-784.131 4538.5406,-774.9743 4538.184,-766.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4541.6806,-766.2589 4537.7672,-756.4133 4534.6867,-766.5503 4541.6806,-766.2589"/>
+</g>
+<!-- 162 -->
+<g id="node163" class="node">
+<title>162</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M1262.2072,-828C1262.2072,-828 1197.7928,-828 1197.7928,-828 1191.7928,-828 1185.7928,-822 1185.7928,-816 1185.7928,-816 1185.7928,-804 1185.7928,-804 1185.7928,-798 1191.7928,-792 1197.7928,-792 1197.7928,-792 1262.2072,-792 1262.2072,-792 1268.2072,-792 1274.2072,-798 1274.2072,-804 1274.2072,-804 1274.2072,-816 1274.2072,-816 1274.2072,-822 1268.2072,-828 1262.2072,-828"/>
+<text text-anchor="middle" x="1230" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="1230" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 6A</text>
+</g>
+<!-- 162&#45;&gt;57 -->
+<g id="edge278" class="edge">
+<title>162-&gt;57</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1229.041,-791.9875C1225.4609,-724.7447 1212.8607,-488.0792 1208.4992,-406.1585"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1211.9899,-405.8891 1207.9631,-396.0894 1204.9998,-406.2614 1211.9899,-405.8891"/>
+</g>
+<!-- 195 -->
+<g id="node196" class="node">
+<title>195</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M1196.0981,-756C1196.0981,-756 1137.9019,-756 1137.9019,-756 1131.9019,-756 1125.9019,-750 1125.9019,-744 1125.9019,-744 1125.9019,-732 1125.9019,-732 1125.9019,-726 1131.9019,-720 1137.9019,-720 1137.9019,-720 1196.0981,-720 1196.0981,-720 1202.0981,-720 1208.0981,-726 1208.0981,-732 1208.0981,-732 1208.0981,-744 1208.0981,-744 1208.0981,-750 1202.0981,-756 1196.0981,-756"/>
+<text text-anchor="middle" x="1167" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 162&#45;&gt;195 -->
+<g id="edge565" class="edge">
+<title>162-&gt;195</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1214.1024,-791.8314C1206.7722,-783.454 1197.934,-773.3531 1189.9031,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1192.3307,-761.6343 1183.1116,-756.4133 1187.0627,-766.2438 1192.3307,-761.6343"/>
+</g>
+<!-- 196 -->
+<g id="node197" class="node">
+<title>196</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M1096.3175,-756C1096.3175,-756 1025.6825,-756 1025.6825,-756 1019.6825,-756 1013.6825,-750 1013.6825,-744 1013.6825,-744 1013.6825,-732 1013.6825,-732 1013.6825,-726 1019.6825,-720 1025.6825,-720 1025.6825,-720 1096.3175,-720 1096.3175,-720 1102.3175,-720 1108.3175,-726 1108.3175,-732 1108.3175,-732 1108.3175,-744 1108.3175,-744 1108.3175,-750 1102.3175,-756 1096.3175,-756"/>
+<text text-anchor="middle" x="1061" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 162&#45;&gt;196 -->
+<g id="edge567" class="edge">
+<title>162-&gt;196</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1187.3542,-791.8314C1164.651,-782.159 1136.5549,-770.1891 1112.6258,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1113.9109,-756.7376 1103.3392,-756.038 1111.1672,-763.1775 1113.9109,-756.7376"/>
+</g>
+<!-- 163 -->
+<g id="node164" class="node">
+<title>163</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M2005.2072,-828C2005.2072,-828 1940.7928,-828 1940.7928,-828 1934.7928,-828 1928.7928,-822 1928.7928,-816 1928.7928,-816 1928.7928,-804 1928.7928,-804 1928.7928,-798 1934.7928,-792 1940.7928,-792 1940.7928,-792 2005.2072,-792 2005.2072,-792 2011.2072,-792 2017.2072,-798 2017.2072,-804 2017.2072,-804 2017.2072,-816 2017.2072,-816 2017.2072,-822 2011.2072,-828 2005.2072,-828"/>
+<text text-anchor="middle" x="1973" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="1973" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 7A</text>
+</g>
+<!-- 163&#45;&gt;58 -->
+<g id="edge280" class="edge">
+<title>163-&gt;58</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1972.0172,-791.8525C1969.721,-743.3411 1965.7671,-611.9095 1988,-576 2004.7735,-548.9083 2034.1021,-567.6146 2050,-540 2057.9829,-526.1337 2050.3173,-519.9969 2050,-504 2049.3353,-470.4841 2047.6769,-431.983 2046.4513,-406.4517"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2049.942,-406.1728 2045.9568,-396.3561 2042.9503,-406.5154 2049.942,-406.1728"/>
+</g>
+<!-- 198 -->
+<g id="node199" class="node">
+<title>198</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M1828.0981,-756C1828.0981,-756 1769.9019,-756 1769.9019,-756 1763.9019,-756 1757.9019,-750 1757.9019,-744 1757.9019,-744 1757.9019,-732 1757.9019,-732 1757.9019,-726 1763.9019,-720 1769.9019,-720 1769.9019,-720 1828.0981,-720 1828.0981,-720 1834.0981,-720 1840.0981,-726 1840.0981,-732 1840.0981,-732 1840.0981,-744 1840.0981,-744 1840.0981,-750 1834.0981,-756 1828.0981,-756"/>
+<text text-anchor="middle" x="1799" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 163&#45;&gt;198 -->
+<g id="edge570" class="edge">
+<title>163-&gt;198</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1929.0925,-791.8314C1904.9,-781.8207 1874.7599,-769.3489 1849.5842,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1850.7795,-755.6383 1840.2011,-755.0487 1848.103,-762.1064 1850.7795,-755.6383"/>
+</g>
+<!-- 199 -->
+<g id="node200" class="node">
+<title>199</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M1940.3175,-756C1940.3175,-756 1869.6825,-756 1869.6825,-756 1863.6825,-756 1857.6825,-750 1857.6825,-744 1857.6825,-744 1857.6825,-732 1857.6825,-732 1857.6825,-726 1863.6825,-720 1869.6825,-720 1869.6825,-720 1940.3175,-720 1940.3175,-720 1946.3175,-720 1952.3175,-726 1952.3175,-732 1952.3175,-732 1952.3175,-744 1952.3175,-744 1952.3175,-750 1946.3175,-756 1940.3175,-756"/>
+<text text-anchor="middle" x="1905" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 163&#45;&gt;199 -->
+<g id="edge572" class="edge">
+<title>163-&gt;199</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1955.8407,-791.8314C1947.8489,-783.3694 1938.1962,-773.1489 1929.4584,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1931.8011,-761.2802 1922.3903,-756.4133 1926.712,-766.0866 1931.8011,-761.2802"/>
+</g>
+<!-- 164 -->
+<g id="node165" class="node">
+<title>164</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M2848.2072,-828C2848.2072,-828 2783.7928,-828 2783.7928,-828 2777.7928,-828 2771.7928,-822 2771.7928,-816 2771.7928,-816 2771.7928,-804 2771.7928,-804 2771.7928,-798 2777.7928,-792 2783.7928,-792 2783.7928,-792 2848.2072,-792 2848.2072,-792 2854.2072,-792 2860.2072,-798 2860.2072,-804 2860.2072,-804 2860.2072,-816 2860.2072,-816 2860.2072,-822 2854.2072,-828 2848.2072,-828"/>
+<text text-anchor="middle" x="2816" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="2816" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 1B</text>
+</g>
+<!-- 164&#45;&gt;59 -->
+<g id="edge282" class="edge">
+<title>164-&gt;59</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2815.2577,-791.9409C2813.5794,-743.6522 2811.1272,-612.7304 2832,-576 2845.8878,-551.5612 2870.118,-564.442 2884,-540 2907.6171,-498.4174 2904.7643,-440.8081 2900.152,-406.6721"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2903.5659,-405.8356 2898.624,-396.4639 2896.643,-406.8719 2903.5659,-405.8356"/>
+</g>
+<!-- 201 -->
+<g id="node202" class="node">
+<title>201</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M2672.0981,-756C2672.0981,-756 2613.9019,-756 2613.9019,-756 2607.9019,-756 2601.9019,-750 2601.9019,-744 2601.9019,-744 2601.9019,-732 2601.9019,-732 2601.9019,-726 2607.9019,-720 2613.9019,-720 2613.9019,-720 2672.0981,-720 2672.0981,-720 2678.0981,-720 2684.0981,-726 2684.0981,-732 2684.0981,-732 2684.0981,-744 2684.0981,-744 2684.0981,-750 2678.0981,-756 2672.0981,-756"/>
+<text text-anchor="middle" x="2643" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 164&#45;&gt;201 -->
+<g id="edge575" class="edge">
+<title>164-&gt;201</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2772.3448,-791.8314C2748.3801,-781.8576 2718.5456,-769.4409 2693.5707,-759.0468"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2694.8364,-755.7826 2684.2592,-755.1715 2692.1467,-762.2452 2694.8364,-755.7826"/>
+</g>
+<!-- 202 -->
+<g id="node203" class="node">
+<title>202</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M2784.3175,-756C2784.3175,-756 2713.6825,-756 2713.6825,-756 2707.6825,-756 2701.6825,-750 2701.6825,-744 2701.6825,-744 2701.6825,-732 2701.6825,-732 2701.6825,-726 2707.6825,-720 2713.6825,-720 2713.6825,-720 2784.3175,-720 2784.3175,-720 2790.3175,-720 2796.3175,-726 2796.3175,-732 2796.3175,-732 2796.3175,-744 2796.3175,-744 2796.3175,-750 2790.3175,-756 2784.3175,-756"/>
+<text text-anchor="middle" x="2749" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 164&#45;&gt;202 -->
+<g id="edge577" class="edge">
+<title>164-&gt;202</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2799.0931,-791.8314C2791.2187,-783.3694 2781.708,-773.1489 2773.0987,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2775.5092,-761.3497 2766.1346,-756.4133 2770.3847,-766.1183 2775.5092,-761.3497"/>
+</g>
+<!-- 165 -->
+<g id="node166" class="node">
+<title>165</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M1682.2072,-828C1682.2072,-828 1617.7928,-828 1617.7928,-828 1611.7928,-828 1605.7928,-822 1605.7928,-816 1605.7928,-816 1605.7928,-804 1605.7928,-804 1605.7928,-798 1611.7928,-792 1617.7928,-792 1617.7928,-792 1682.2072,-792 1682.2072,-792 1688.2072,-792 1694.2072,-798 1694.2072,-804 1694.2072,-804 1694.2072,-816 1694.2072,-816 1694.2072,-822 1688.2072,-828 1682.2072,-828"/>
+<text text-anchor="middle" x="1650" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="1650" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 2B</text>
+</g>
+<!-- 165&#45;&gt;60 -->
+<g id="edge284" class="edge">
+<title>165-&gt;60</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1649.1244,-791.9875C1645.8556,-724.7447 1634.3511,-488.0792 1630.3688,-406.1585"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1633.8608,-405.9076 1629.8793,-396.0894 1626.8691,-406.2476 1633.8608,-405.9076"/>
+</g>
+<!-- 204 -->
+<g id="node205" class="node">
+<title>204</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M1618.0981,-756C1618.0981,-756 1559.9019,-756 1559.9019,-756 1553.9019,-756 1547.9019,-750 1547.9019,-744 1547.9019,-744 1547.9019,-732 1547.9019,-732 1547.9019,-726 1553.9019,-720 1559.9019,-720 1559.9019,-720 1618.0981,-720 1618.0981,-720 1624.0981,-720 1630.0981,-726 1630.0981,-732 1630.0981,-732 1630.0981,-744 1630.0981,-744 1630.0981,-750 1624.0981,-756 1618.0981,-756"/>
+<text text-anchor="middle" x="1589" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 165&#45;&gt;204 -->
+<g id="edge580" class="edge">
+<title>165-&gt;204</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1634.6071,-791.8314C1627.5096,-783.454 1618.952,-773.3531 1611.176,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1613.7348,-761.7807 1604.6001,-756.4133 1608.3939,-766.3056 1613.7348,-761.7807"/>
+</g>
+<!-- 205 -->
+<g id="node206" class="node">
+<title>205</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M1518.3175,-756C1518.3175,-756 1447.6825,-756 1447.6825,-756 1441.6825,-756 1435.6825,-750 1435.6825,-744 1435.6825,-744 1435.6825,-732 1435.6825,-732 1435.6825,-726 1441.6825,-720 1447.6825,-720 1447.6825,-720 1518.3175,-720 1518.3175,-720 1524.3175,-720 1530.3175,-726 1530.3175,-732 1530.3175,-732 1530.3175,-744 1530.3175,-744 1530.3175,-750 1524.3175,-756 1518.3175,-756"/>
+<text text-anchor="middle" x="1483" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 165&#45;&gt;205 -->
+<g id="edge582" class="edge">
+<title>165-&gt;205</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1607.8588,-791.8314C1585.5236,-782.2018 1557.9064,-770.295 1534.329,-760.1299"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1535.4067,-756.7831 1524.8381,-756.038 1532.6353,-763.2112 1535.4067,-756.7831"/>
+</g>
+<!-- 166 -->
+<g id="node167" class="node">
+<title>166</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M3368.2072,-828C3368.2072,-828 3303.7928,-828 3303.7928,-828 3297.7928,-828 3291.7928,-822 3291.7928,-816 3291.7928,-816 3291.7928,-804 3291.7928,-804 3291.7928,-798 3297.7928,-792 3303.7928,-792 3303.7928,-792 3368.2072,-792 3368.2072,-792 3374.2072,-792 3380.2072,-798 3380.2072,-804 3380.2072,-804 3380.2072,-816 3380.2072,-816 3380.2072,-822 3374.2072,-828 3368.2072,-828"/>
+<text text-anchor="middle" x="3336" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="3336" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 3B</text>
+</g>
+<!-- 166&#45;&gt;61 -->
+<g id="edge286" class="edge">
+<title>166-&gt;61</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3337.4504,-791.8284C3339.5007,-764.5296 3343,-711.3034 3343,-666 3343,-666 3343,-666 3343,-522 3343,-481.2738 3332.804,-435.0849 3325.182,-406.2458"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3328.5185,-405.1771 3322.5139,-396.4481 3321.7644,-407.0164 3328.5185,-405.1771"/>
+</g>
+<!-- 207 -->
+<g id="node208" class="node">
+<title>207</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M3191.0981,-756C3191.0981,-756 3132.9019,-756 3132.9019,-756 3126.9019,-756 3120.9019,-750 3120.9019,-744 3120.9019,-744 3120.9019,-732 3120.9019,-732 3120.9019,-726 3126.9019,-720 3132.9019,-720 3132.9019,-720 3191.0981,-720 3191.0981,-720 3197.0981,-720 3203.0981,-726 3203.0981,-732 3203.0981,-732 3203.0981,-744 3203.0981,-744 3203.0981,-750 3197.0981,-756 3191.0981,-756"/>
+<text text-anchor="middle" x="3162" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 166&#45;&gt;207 -->
+<g id="edge585" class="edge">
+<title>166-&gt;207</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3292.0925,-791.8314C3267.9,-781.8207 3237.7599,-769.3489 3212.5842,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3213.7795,-755.6383 3203.2011,-755.0487 3211.103,-762.1064 3213.7795,-755.6383"/>
+</g>
+<!-- 208 -->
+<g id="node209" class="node">
+<title>208</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M3303.3175,-756C3303.3175,-756 3232.6825,-756 3232.6825,-756 3226.6825,-756 3220.6825,-750 3220.6825,-744 3220.6825,-744 3220.6825,-732 3220.6825,-732 3220.6825,-726 3226.6825,-720 3232.6825,-720 3232.6825,-720 3303.3175,-720 3303.3175,-720 3309.3175,-720 3315.3175,-726 3315.3175,-732 3315.3175,-732 3315.3175,-744 3315.3175,-744 3315.3175,-750 3309.3175,-756 3303.3175,-756"/>
+<text text-anchor="middle" x="3268" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 166&#45;&gt;208 -->
+<g id="edge587" class="edge">
+<title>166-&gt;208</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3318.8407,-791.8314C3310.8489,-783.3694 3301.1962,-773.1489 3292.4584,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3294.8011,-761.2802 3285.3903,-756.4133 3289.712,-766.0866 3294.8011,-761.2802"/>
+</g>
+<!-- 167 -->
+<g id="node168" class="node">
+<title>167</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M4213.2072,-828C4213.2072,-828 4148.7928,-828 4148.7928,-828 4142.7928,-828 4136.7928,-822 4136.7928,-816 4136.7928,-816 4136.7928,-804 4136.7928,-804 4136.7928,-798 4142.7928,-792 4148.7928,-792 4148.7928,-792 4213.2072,-792 4213.2072,-792 4219.2072,-792 4225.2072,-798 4225.2072,-804 4225.2072,-804 4225.2072,-816 4225.2072,-816 4225.2072,-822 4219.2072,-828 4213.2072,-828"/>
+<text text-anchor="middle" x="4181" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="4181" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 4B</text>
+</g>
+<!-- 167&#45;&gt;62 -->
+<g id="edge288" class="edge">
+<title>167-&gt;62</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4182.2432,-791.8247C4184.0006,-764.5213 4187,-711.2893 4187,-666 4187,-666 4187,-666 4187,-522 4187,-470.9747 4142.3672,-427.6374 4108.7128,-402.2126"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4110.5619,-399.2285 4100.427,-396.1409 4106.4243,-404.8748 4110.5619,-399.2285"/>
+</g>
+<!-- 210 -->
+<g id="node211" class="node">
+<title>210</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M4147.0981,-756C4147.0981,-756 4088.9019,-756 4088.9019,-756 4082.9019,-756 4076.9019,-750 4076.9019,-744 4076.9019,-744 4076.9019,-732 4076.9019,-732 4076.9019,-726 4082.9019,-720 4088.9019,-720 4088.9019,-720 4147.0981,-720 4147.0981,-720 4153.0981,-720 4159.0981,-726 4159.0981,-732 4159.0981,-732 4159.0981,-744 4159.0981,-744 4159.0981,-750 4153.0981,-756 4147.0981,-756"/>
+<text text-anchor="middle" x="4118" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 167&#45;&gt;210 -->
+<g id="edge590" class="edge">
+<title>167-&gt;210</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4165.1024,-791.8314C4157.7722,-783.454 4148.934,-773.3531 4140.9031,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4143.3307,-761.6343 4134.1116,-756.4133 4138.0627,-766.2438 4143.3307,-761.6343"/>
+</g>
+<!-- 211 -->
+<g id="node212" class="node">
+<title>211</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M4047.3175,-756C4047.3175,-756 3976.6825,-756 3976.6825,-756 3970.6825,-756 3964.6825,-750 3964.6825,-744 3964.6825,-744 3964.6825,-732 3964.6825,-732 3964.6825,-726 3970.6825,-720 3976.6825,-720 3976.6825,-720 4047.3175,-720 4047.3175,-720 4053.3175,-720 4059.3175,-726 4059.3175,-732 4059.3175,-732 4059.3175,-744 4059.3175,-744 4059.3175,-750 4053.3175,-756 4047.3175,-756"/>
+<text text-anchor="middle" x="4012" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 167&#45;&gt;211 -->
+<g id="edge592" class="edge">
+<title>167-&gt;211</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4138.3542,-791.8314C4115.651,-782.159 4087.5549,-770.1891 4063.6258,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4064.9109,-756.7376 4054.3392,-756.038 4062.1672,-763.1775 4064.9109,-756.7376"/>
+</g>
+<!-- 168 -->
+<g id="node169" class="node">
+<title>168</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M6727.2072,-828C6727.2072,-828 6662.7928,-828 6662.7928,-828 6656.7928,-828 6650.7928,-822 6650.7928,-816 6650.7928,-816 6650.7928,-804 6650.7928,-804 6650.7928,-798 6656.7928,-792 6662.7928,-792 6662.7928,-792 6727.2072,-792 6727.2072,-792 6733.2072,-792 6739.2072,-798 6739.2072,-804 6739.2072,-804 6739.2072,-816 6739.2072,-816 6739.2072,-822 6733.2072,-828 6727.2072,-828"/>
+<text text-anchor="middle" x="6695" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="6695" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 5B</text>
+</g>
+<!-- 168&#45;&gt;63 -->
+<g id="edge290" class="edge">
+<title>168-&gt;63</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6698.6643,-791.8978C6706.0329,-750.6684 6718.8193,-647.7979 6680,-576 6667.3171,-552.5425 6644.0727,-563.7773 6632,-540 6610.3982,-497.4549 6616.5474,-440.1587 6623.1544,-406.3435"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6626.6466,-406.7446 6625.2811,-396.2381 6619.7967,-405.303 6626.6466,-406.7446"/>
+</g>
+<!-- 213 -->
+<g id="node214" class="node">
+<title>213</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M6786.0981,-756C6786.0981,-756 6727.9019,-756 6727.9019,-756 6721.9019,-756 6715.9019,-750 6715.9019,-744 6715.9019,-744 6715.9019,-732 6715.9019,-732 6715.9019,-726 6721.9019,-720 6727.9019,-720 6727.9019,-720 6786.0981,-720 6786.0981,-720 6792.0981,-720 6798.0981,-726 6798.0981,-732 6798.0981,-732 6798.0981,-744 6798.0981,-744 6798.0981,-750 6792.0981,-756 6786.0981,-756"/>
+<text text-anchor="middle" x="6757" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 168&#45;&gt;213 -->
+<g id="edge595" class="edge">
+<title>168-&gt;213</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6710.6452,-791.8314C6717.8591,-783.454 6726.557,-773.3531 6734.4605,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6737.2711,-766.2748 6741.1441,-756.4133 6731.9667,-761.7071 6737.2711,-766.2748"/>
+</g>
+<!-- 214 -->
+<g id="node215" class="node">
+<title>214</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M6898.3175,-756C6898.3175,-756 6827.6825,-756 6827.6825,-756 6821.6825,-756 6815.6825,-750 6815.6825,-744 6815.6825,-744 6815.6825,-732 6815.6825,-732 6815.6825,-726 6821.6825,-720 6827.6825,-720 6827.6825,-720 6898.3175,-720 6898.3175,-720 6904.3175,-720 6910.3175,-726 6910.3175,-732 6910.3175,-732 6910.3175,-744 6910.3175,-744 6910.3175,-750 6904.3175,-756 6898.3175,-756"/>
+<text text-anchor="middle" x="6863" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 168&#45;&gt;214 -->
+<g id="edge597" class="edge">
+<title>168-&gt;214</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6737.3935,-791.8314C6759.9624,-782.159 6787.8921,-770.1891 6811.6796,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6813.0986,-763.1943 6820.9114,-756.038 6810.3412,-756.7602 6813.0986,-763.1943"/>
+</g>
+<!-- 169 -->
+<g id="node170" class="node">
+<title>169</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M5050.2072,-828C5050.2072,-828 4985.7928,-828 4985.7928,-828 4979.7928,-828 4973.7928,-822 4973.7928,-816 4973.7928,-816 4973.7928,-804 4973.7928,-804 4973.7928,-798 4979.7928,-792 4985.7928,-792 4985.7928,-792 5050.2072,-792 5050.2072,-792 5056.2072,-792 5062.2072,-798 5062.2072,-804 5062.2072,-804 5062.2072,-816 5062.2072,-816 5062.2072,-822 5056.2072,-828 5050.2072,-828"/>
+<text text-anchor="middle" x="5018" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="5018" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 6B</text>
+</g>
+<!-- 169&#45;&gt;64 -->
+<g id="edge292" class="edge">
+<title>169-&gt;64</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5019.0467,-791.9527C5020.5862,-750.3983 5019.3997,-646.1539 4975,-576 4959.6126,-551.6872 4807.1465,-448.9041 4736.0963,-401.7816"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4737.7137,-398.6549 4727.4437,-396.0513 4733.8485,-404.4911 4737.7137,-398.6549"/>
+</g>
+<!-- 216 -->
+<g id="node217" class="node">
+<title>216</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M5109.0981,-756C5109.0981,-756 5050.9019,-756 5050.9019,-756 5044.9019,-756 5038.9019,-750 5038.9019,-744 5038.9019,-744 5038.9019,-732 5038.9019,-732 5038.9019,-726 5044.9019,-720 5050.9019,-720 5050.9019,-720 5109.0981,-720 5109.0981,-720 5115.0981,-720 5121.0981,-726 5121.0981,-732 5121.0981,-732 5121.0981,-744 5121.0981,-744 5121.0981,-750 5115.0981,-756 5109.0981,-756"/>
+<text text-anchor="middle" x="5080" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 169&#45;&gt;216 -->
+<g id="edge600" class="edge">
+<title>169-&gt;216</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5033.6452,-791.8314C5040.8591,-783.454 5049.557,-773.3531 5057.4605,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5060.2711,-766.2748 5064.1441,-756.4133 5054.9667,-761.7071 5060.2711,-766.2748"/>
+</g>
+<!-- 217 -->
+<g id="node218" class="node">
+<title>217</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M5221.3175,-756C5221.3175,-756 5150.6825,-756 5150.6825,-756 5144.6825,-756 5138.6825,-750 5138.6825,-744 5138.6825,-744 5138.6825,-732 5138.6825,-732 5138.6825,-726 5144.6825,-720 5150.6825,-720 5150.6825,-720 5221.3175,-720 5221.3175,-720 5227.3175,-720 5233.3175,-726 5233.3175,-732 5233.3175,-732 5233.3175,-744 5233.3175,-744 5233.3175,-750 5227.3175,-756 5221.3175,-756"/>
+<text text-anchor="middle" x="5186" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 169&#45;&gt;217 -->
+<g id="edge602" class="edge">
+<title>169-&gt;217</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5060.3935,-791.8314C5082.9624,-782.159 5110.8921,-770.1891 5134.6796,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5136.0986,-763.1943 5143.9114,-756.038 5133.3412,-756.7602 5136.0986,-763.1943"/>
+</g>
+<!-- 170 -->
+<g id="node171" class="node">
+<title>170</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M6313.2072,-828C6313.2072,-828 6248.7928,-828 6248.7928,-828 6242.7928,-828 6236.7928,-822 6236.7928,-816 6236.7928,-816 6236.7928,-804 6236.7928,-804 6236.7928,-798 6242.7928,-792 6248.7928,-792 6248.7928,-792 6313.2072,-792 6313.2072,-792 6319.2072,-792 6325.2072,-798 6325.2072,-804 6325.2072,-804 6325.2072,-816 6325.2072,-816 6325.2072,-822 6319.2072,-828 6313.2072,-828"/>
+<text text-anchor="middle" x="6281" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="6281" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 7B</text>
+</g>
+<!-- 170&#45;&gt;65 -->
+<g id="edge294" class="edge">
+<title>170-&gt;65</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6281.0925,-791.9489C6281.0504,-743.6802 6278.9543,-612.8045 6258,-576 6244.6296,-552.5159 6221.2788,-564.0729 6209,-540 6187.3208,-497.4973 6193.9343,-440.1873 6200.8634,-406.358"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6204.3572,-406.7667 6203.0887,-396.2481 6197.5208,-405.2619 6204.3572,-406.7667"/>
+</g>
+<!-- 219 -->
+<g id="node220" class="node">
+<title>219</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M6476.0981,-756C6476.0981,-756 6417.9019,-756 6417.9019,-756 6411.9019,-756 6405.9019,-750 6405.9019,-744 6405.9019,-744 6405.9019,-732 6405.9019,-732 6405.9019,-726 6411.9019,-720 6417.9019,-720 6417.9019,-720 6476.0981,-720 6476.0981,-720 6482.0981,-720 6488.0981,-726 6488.0981,-732 6488.0981,-732 6488.0981,-744 6488.0981,-744 6488.0981,-750 6482.0981,-756 6476.0981,-756"/>
+<text text-anchor="middle" x="6447" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 170&#45;&gt;219 -->
+<g id="edge605" class="edge">
+<title>170-&gt;219</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6322.8888,-791.8314C6345.1747,-782.1652 6372.751,-770.2044 6396.2455,-760.014"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6397.9181,-763.1036 6405.6996,-755.9134 6395.1327,-756.6817 6397.9181,-763.1036"/>
+</g>
+<!-- 220 -->
+<g id="node221" class="node">
+<title>220</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M6376.3175,-756C6376.3175,-756 6305.6825,-756 6305.6825,-756 6299.6825,-756 6293.6825,-750 6293.6825,-744 6293.6825,-744 6293.6825,-732 6293.6825,-732 6293.6825,-726 6299.6825,-720 6305.6825,-720 6305.6825,-720 6376.3175,-720 6376.3175,-720 6382.3175,-720 6388.3175,-726 6388.3175,-732 6388.3175,-732 6388.3175,-744 6388.3175,-744 6388.3175,-750 6382.3175,-756 6376.3175,-756"/>
+<text text-anchor="middle" x="6341" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 170&#45;&gt;220 -->
+<g id="edge607" class="edge">
+<title>170-&gt;220</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6296.1405,-791.8314C6303.1217,-783.454 6311.5391,-773.3531 6319.1876,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6321.9425,-766.3362 6325.6556,-756.4133 6316.5649,-761.8548 6321.9425,-766.3362"/>
+</g>
+<!-- 171 -->
+<g id="node172" class="node">
+<title>171</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M5461.2072,-828C5461.2072,-828 5396.7928,-828 5396.7928,-828 5390.7928,-828 5384.7928,-822 5384.7928,-816 5384.7928,-816 5384.7928,-804 5384.7928,-804 5384.7928,-798 5390.7928,-792 5396.7928,-792 5396.7928,-792 5461.2072,-792 5461.2072,-792 5467.2072,-792 5473.2072,-798 5473.2072,-804 5473.2072,-804 5473.2072,-816 5473.2072,-816 5473.2072,-822 5467.2072,-828 5461.2072,-828"/>
+<text text-anchor="middle" x="5429" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="5429" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 1D</text>
+</g>
+<!-- 171&#45;&gt;66 -->
+<g id="edge296" class="edge">
+<title>171-&gt;66</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5429.8449,-791.9346C5431.7936,-743.6299 5434.9518,-612.6717 5414,-576 5399.8739,-551.2752 5374.7143,-564.9556 5361,-540 5338.0106,-498.1666 5343.2939,-440.6388 5349.4746,-406.5865"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5352.9814,-406.8927 5351.4781,-396.405 5346.1131,-405.5411 5352.9814,-406.8927"/>
+</g>
+<!-- 222 -->
+<g id="node223" class="node">
+<title>222</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M5520.0981,-756C5520.0981,-756 5461.9019,-756 5461.9019,-756 5455.9019,-756 5449.9019,-750 5449.9019,-744 5449.9019,-744 5449.9019,-732 5449.9019,-732 5449.9019,-726 5455.9019,-720 5461.9019,-720 5461.9019,-720 5520.0981,-720 5520.0981,-720 5526.0981,-720 5532.0981,-726 5532.0981,-732 5532.0981,-732 5532.0981,-744 5532.0981,-744 5532.0981,-750 5526.0981,-756 5520.0981,-756"/>
+<text text-anchor="middle" x="5491" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 171&#45;&gt;222 -->
+<g id="edge610" class="edge">
+<title>171-&gt;222</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5444.6452,-791.8314C5451.8591,-783.454 5460.557,-773.3531 5468.4605,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5471.2711,-766.2748 5475.1441,-756.4133 5465.9667,-761.7071 5471.2711,-766.2748"/>
+</g>
+<!-- 223 -->
+<g id="node224" class="node">
+<title>223</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M5632.3175,-756C5632.3175,-756 5561.6825,-756 5561.6825,-756 5555.6825,-756 5549.6825,-750 5549.6825,-744 5549.6825,-744 5549.6825,-732 5549.6825,-732 5549.6825,-726 5555.6825,-720 5561.6825,-720 5561.6825,-720 5632.3175,-720 5632.3175,-720 5638.3175,-720 5644.3175,-726 5644.3175,-732 5644.3175,-732 5644.3175,-744 5644.3175,-744 5644.3175,-750 5638.3175,-756 5632.3175,-756"/>
+<text text-anchor="middle" x="5597" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 171&#45;&gt;223 -->
+<g id="edge612" class="edge">
+<title>171-&gt;223</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5471.3935,-791.8314C5493.9624,-782.159 5521.8921,-770.1891 5545.6796,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5547.0986,-763.1943 5554.9114,-756.038 5544.3412,-756.7602 5547.0986,-763.1943"/>
+</g>
+<!-- 172 -->
+<g id="node173" class="node">
+<title>172</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M7571.2072,-828C7571.2072,-828 7506.7928,-828 7506.7928,-828 7500.7928,-828 7494.7928,-822 7494.7928,-816 7494.7928,-816 7494.7928,-804 7494.7928,-804 7494.7928,-798 7500.7928,-792 7506.7928,-792 7506.7928,-792 7571.2072,-792 7571.2072,-792 7577.2072,-792 7583.2072,-798 7583.2072,-804 7583.2072,-804 7583.2072,-816 7583.2072,-816 7583.2072,-822 7577.2072,-828 7571.2072,-828"/>
+<text text-anchor="middle" x="7539" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="7539" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 2D</text>
+</g>
+<!-- 172&#45;&gt;67 -->
+<g id="edge298" class="edge">
+<title>172-&gt;67</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7542.6129,-791.9254C7549.8749,-750.7533 7562.4549,-647.9937 7524,-576 7511.603,-552.7909 7488.6479,-563.5939 7477,-540 7469.9172,-525.6531 7476.8096,-519.9989 7477,-504 7477.3988,-470.4968 7478.3938,-431.9932 7479.1292,-406.4578"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7482.6306,-406.459 7479.4259,-396.3605 7475.6336,-406.2533 7482.6306,-406.459"/>
+</g>
+<!-- 225 -->
+<g id="node226" class="node">
+<title>225</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M7742.0981,-756C7742.0981,-756 7683.9019,-756 7683.9019,-756 7677.9019,-756 7671.9019,-750 7671.9019,-744 7671.9019,-744 7671.9019,-732 7671.9019,-732 7671.9019,-726 7677.9019,-720 7683.9019,-720 7683.9019,-720 7742.0981,-720 7742.0981,-720 7748.0981,-720 7754.0981,-726 7754.0981,-732 7754.0981,-732 7754.0981,-744 7754.0981,-744 7754.0981,-750 7748.0981,-756 7742.0981,-756"/>
+<text text-anchor="middle" x="7713" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 172&#45;&gt;225 -->
+<g id="edge615" class="edge">
+<title>172-&gt;225</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7582.9075,-791.8314C7607.1,-781.8207 7637.2401,-769.3489 7662.4158,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7663.897,-762.1064 7671.7989,-755.0487 7661.2205,-755.6383 7663.897,-762.1064"/>
+</g>
+<!-- 226 -->
+<g id="node227" class="node">
+<title>226</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M7642.3175,-756C7642.3175,-756 7571.6825,-756 7571.6825,-756 7565.6825,-756 7559.6825,-750 7559.6825,-744 7559.6825,-744 7559.6825,-732 7559.6825,-732 7559.6825,-726 7565.6825,-720 7571.6825,-720 7571.6825,-720 7642.3175,-720 7642.3175,-720 7648.3175,-720 7654.3175,-726 7654.3175,-732 7654.3175,-732 7654.3175,-744 7654.3175,-744 7654.3175,-750 7648.3175,-756 7642.3175,-756"/>
+<text text-anchor="middle" x="7607" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 172&#45;&gt;226 -->
+<g id="edge617" class="edge">
+<title>172-&gt;226</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7556.1593,-791.8314C7564.1511,-783.3694 7573.8038,-773.1489 7582.5416,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7585.288,-766.0866 7589.6097,-756.4133 7580.1989,-761.2802 7585.288,-766.0866"/>
+</g>
+<!-- 173 -->
+<g id="node174" class="node">
+<title>173</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M5883.2072,-828C5883.2072,-828 5818.7928,-828 5818.7928,-828 5812.7928,-828 5806.7928,-822 5806.7928,-816 5806.7928,-816 5806.7928,-804 5806.7928,-804 5806.7928,-798 5812.7928,-792 5818.7928,-792 5818.7928,-792 5883.2072,-792 5883.2072,-792 5889.2072,-792 5895.2072,-798 5895.2072,-804 5895.2072,-804 5895.2072,-816 5895.2072,-816 5895.2072,-822 5889.2072,-828 5883.2072,-828"/>
+<text text-anchor="middle" x="5851" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="5851" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 3D</text>
+</g>
+<!-- 173&#45;&gt;68 -->
+<g id="edge300" class="edge">
+<title>173-&gt;68</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5854.7142,-791.8707C5862.1863,-750.585 5875.1731,-647.6055 5836,-576 5823.0303,-552.2923 5799.5749,-563.9195 5787,-540 5764.7878,-497.7488 5769.8182,-440.3569 5775.7399,-406.4438"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5779.2377,-406.7838 5777.6604,-396.307 5772.36,-405.4807 5779.2377,-406.7838"/>
+</g>
+<!-- 228 -->
+<g id="node229" class="node">
+<title>228</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M6054.0981,-756C6054.0981,-756 5995.9019,-756 5995.9019,-756 5989.9019,-756 5983.9019,-750 5983.9019,-744 5983.9019,-744 5983.9019,-732 5983.9019,-732 5983.9019,-726 5989.9019,-720 5995.9019,-720 5995.9019,-720 6054.0981,-720 6054.0981,-720 6060.0981,-720 6066.0981,-726 6066.0981,-732 6066.0981,-732 6066.0981,-744 6066.0981,-744 6066.0981,-750 6060.0981,-756 6054.0981,-756"/>
+<text text-anchor="middle" x="6025" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 173&#45;&gt;228 -->
+<g id="edge620" class="edge">
+<title>173-&gt;228</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5894.9075,-791.8314C5919.1,-781.8207 5949.2401,-769.3489 5974.4158,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5975.897,-762.1064 5983.7989,-755.0487 5973.2205,-755.6383 5975.897,-762.1064"/>
+</g>
+<!-- 229 -->
+<g id="node230" class="node">
+<title>229</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M5954.3175,-756C5954.3175,-756 5883.6825,-756 5883.6825,-756 5877.6825,-756 5871.6825,-750 5871.6825,-744 5871.6825,-744 5871.6825,-732 5871.6825,-732 5871.6825,-726 5877.6825,-720 5883.6825,-720 5883.6825,-720 5954.3175,-720 5954.3175,-720 5960.3175,-720 5966.3175,-726 5966.3175,-732 5966.3175,-732 5966.3175,-744 5966.3175,-744 5966.3175,-750 5960.3175,-756 5954.3175,-756"/>
+<text text-anchor="middle" x="5919" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 173&#45;&gt;229 -->
+<g id="edge622" class="edge">
+<title>173-&gt;229</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5868.1593,-791.8314C5876.1511,-783.3694 5885.8038,-773.1489 5894.5416,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5897.288,-766.0866 5901.6097,-756.4133 5892.1989,-761.2802 5897.288,-766.0866"/>
+</g>
+<!-- 174 -->
+<g id="node175" class="node">
+<title>174</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M7149.2072,-828C7149.2072,-828 7084.7928,-828 7084.7928,-828 7078.7928,-828 7072.7928,-822 7072.7928,-816 7072.7928,-816 7072.7928,-804 7072.7928,-804 7072.7928,-798 7078.7928,-792 7084.7928,-792 7084.7928,-792 7149.2072,-792 7149.2072,-792 7155.2072,-792 7161.2072,-798 7161.2072,-804 7161.2072,-804 7161.2072,-816 7161.2072,-816 7161.2072,-822 7155.2072,-828 7149.2072,-828"/>
+<text text-anchor="middle" x="7117" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="7117" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 4D</text>
+</g>
+<!-- 174&#45;&gt;69 -->
+<g id="edge302" class="edge">
+<title>174-&gt;69</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7120.4424,-791.7333C7127.2519,-750.5976 7138.7923,-648.6293 7102,-576 7090.7366,-553.7656 7069.9623,-562.3844 7059,-540 7038.0012,-497.1216 7042.1978,-439.9338 7047.4188,-406.2297"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7050.9052,-406.6031 7049.1193,-396.1599 7044.0029,-405.4375 7050.9052,-406.6031"/>
+</g>
+<!-- 231 -->
+<g id="node232" class="node">
+<title>231</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M7208.0981,-756C7208.0981,-756 7149.9019,-756 7149.9019,-756 7143.9019,-756 7137.9019,-750 7137.9019,-744 7137.9019,-744 7137.9019,-732 7137.9019,-732 7137.9019,-726 7143.9019,-720 7149.9019,-720 7149.9019,-720 7208.0981,-720 7208.0981,-720 7214.0981,-720 7220.0981,-726 7220.0981,-732 7220.0981,-732 7220.0981,-744 7220.0981,-744 7220.0981,-750 7214.0981,-756 7208.0981,-756"/>
+<text text-anchor="middle" x="7179" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 174&#45;&gt;231 -->
+<g id="edge625" class="edge">
+<title>174-&gt;231</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7132.6452,-791.8314C7139.8591,-783.454 7148.557,-773.3531 7156.4605,-764.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7159.2711,-766.2748 7163.1441,-756.4133 7153.9667,-761.7071 7159.2711,-766.2748"/>
+</g>
+<!-- 232 -->
+<g id="node233" class="node">
+<title>232</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M7320.3175,-756C7320.3175,-756 7249.6825,-756 7249.6825,-756 7243.6825,-756 7237.6825,-750 7237.6825,-744 7237.6825,-744 7237.6825,-732 7237.6825,-732 7237.6825,-726 7243.6825,-720 7249.6825,-720 7249.6825,-720 7320.3175,-720 7320.3175,-720 7326.3175,-720 7332.3175,-726 7332.3175,-732 7332.3175,-732 7332.3175,-744 7332.3175,-744 7332.3175,-750 7326.3175,-756 7320.3175,-756"/>
+<text text-anchor="middle" x="7285" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 174&#45;&gt;232 -->
+<g id="edge627" class="edge">
+<title>174-&gt;232</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7159.3935,-791.8314C7181.9624,-782.159 7209.8921,-770.1891 7233.6796,-759.9944"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7235.0986,-763.1943 7242.9114,-756.038 7232.3412,-756.7602 7235.0986,-763.1943"/>
+</g>
+<!-- 175 -->
+<g id="node176" class="node">
+<title>175</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M7993.2072,-828C7993.2072,-828 7928.7928,-828 7928.7928,-828 7922.7928,-828 7916.7928,-822 7916.7928,-816 7916.7928,-816 7916.7928,-804 7916.7928,-804 7916.7928,-798 7922.7928,-792 7928.7928,-792 7928.7928,-792 7993.2072,-792 7993.2072,-792 7999.2072,-792 8005.2072,-798 8005.2072,-804 8005.2072,-804 8005.2072,-816 8005.2072,-816 8005.2072,-822 7999.2072,-828 7993.2072,-828"/>
+<text text-anchor="middle" x="7961" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="7961" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 5D</text>
+</g>
+<!-- 175&#45;&gt;70 -->
+<g id="edge304" class="edge">
+<title>175-&gt;70</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7964.0495,-791.9232C7970.0545,-751.1763 7980.0553,-649.9522 7946,-576 7936.403,-555.1597 7918.6364,-560.8221 7909,-540 7888.915,-496.6011 7890.6187,-439.5826 7894.0538,-406.052"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7897.54,-406.372 7895.2046,-396.0378 7890.5858,-405.5729 7897.54,-406.372"/>
+</g>
+<!-- 234 -->
+<g id="node235" class="node">
+<title>234</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M8164.0981,-756C8164.0981,-756 8105.9019,-756 8105.9019,-756 8099.9019,-756 8093.9019,-750 8093.9019,-744 8093.9019,-744 8093.9019,-732 8093.9019,-732 8093.9019,-726 8099.9019,-720 8105.9019,-720 8105.9019,-720 8164.0981,-720 8164.0981,-720 8170.0981,-720 8176.0981,-726 8176.0981,-732 8176.0981,-732 8176.0981,-744 8176.0981,-744 8176.0981,-750 8170.0981,-756 8164.0981,-756"/>
+<text text-anchor="middle" x="8135" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 175&#45;&gt;234 -->
+<g id="edge630" class="edge">
+<title>175-&gt;234</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8004.9075,-791.8314C8029.1,-781.8207 8059.2401,-769.3489 8084.4158,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8085.897,-762.1064 8093.7989,-755.0487 8083.2205,-755.6383 8085.897,-762.1064"/>
+</g>
+<!-- 235 -->
+<g id="node236" class="node">
+<title>235</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M8064.3175,-756C8064.3175,-756 7993.6825,-756 7993.6825,-756 7987.6825,-756 7981.6825,-750 7981.6825,-744 7981.6825,-744 7981.6825,-732 7981.6825,-732 7981.6825,-726 7987.6825,-720 7993.6825,-720 7993.6825,-720 8064.3175,-720 8064.3175,-720 8070.3175,-720 8076.3175,-726 8076.3175,-732 8076.3175,-732 8076.3175,-744 8076.3175,-744 8076.3175,-750 8070.3175,-756 8064.3175,-756"/>
+<text text-anchor="middle" x="8029" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 175&#45;&gt;235 -->
+<g id="edge632" class="edge">
+<title>175-&gt;235</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7978.1593,-791.8314C7986.1511,-783.3694 7995.8038,-773.1489 8004.5416,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8007.288,-766.0866 8011.6097,-756.4133 8002.1989,-761.2802 8007.288,-766.0866"/>
+</g>
+<!-- 176 -->
+<g id="node177" class="node">
+<title>176</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M8415.2072,-828C8415.2072,-828 8350.7928,-828 8350.7928,-828 8344.7928,-828 8338.7928,-822 8338.7928,-816 8338.7928,-816 8338.7928,-804 8338.7928,-804 8338.7928,-798 8344.7928,-792 8350.7928,-792 8350.7928,-792 8415.2072,-792 8415.2072,-792 8421.2072,-792 8427.2072,-798 8427.2072,-804 8427.2072,-804 8427.2072,-816 8427.2072,-816 8427.2072,-822 8421.2072,-828 8415.2072,-828"/>
+<text text-anchor="middle" x="8383" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="8383" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 6D</text>
+</g>
+<!-- 176&#45;&gt;71 -->
+<g id="edge306" class="edge">
+<title>176-&gt;71</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8386.0495,-791.9232C8392.0545,-751.1763 8402.0553,-649.9522 8368,-576 8358.403,-555.1597 8339.9904,-561.1091 8331,-540 8312.354,-496.2199 8317.9173,-439.549 8323.8346,-406.1487"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8327.3026,-406.6467 8325.738,-396.168 8320.4266,-405.3353 8327.3026,-406.6467"/>
+</g>
+<!-- 237 -->
+<g id="node238" class="node">
+<title>237</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M8586.0981,-756C8586.0981,-756 8527.9019,-756 8527.9019,-756 8521.9019,-756 8515.9019,-750 8515.9019,-744 8515.9019,-744 8515.9019,-732 8515.9019,-732 8515.9019,-726 8521.9019,-720 8527.9019,-720 8527.9019,-720 8586.0981,-720 8586.0981,-720 8592.0981,-720 8598.0981,-726 8598.0981,-732 8598.0981,-732 8598.0981,-744 8598.0981,-744 8598.0981,-750 8592.0981,-756 8586.0981,-756"/>
+<text text-anchor="middle" x="8557" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 176&#45;&gt;237 -->
+<g id="edge635" class="edge">
+<title>176-&gt;237</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8426.9075,-791.8314C8451.1,-781.8207 8481.2401,-769.3489 8506.4158,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8507.897,-762.1064 8515.7989,-755.0487 8505.2205,-755.6383 8507.897,-762.1064"/>
+</g>
+<!-- 238 -->
+<g id="node239" class="node">
+<title>238</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M8486.3175,-756C8486.3175,-756 8415.6825,-756 8415.6825,-756 8409.6825,-756 8403.6825,-750 8403.6825,-744 8403.6825,-744 8403.6825,-732 8403.6825,-732 8403.6825,-726 8409.6825,-720 8415.6825,-720 8415.6825,-720 8486.3175,-720 8486.3175,-720 8492.3175,-720 8498.3175,-726 8498.3175,-732 8498.3175,-732 8498.3175,-744 8498.3175,-744 8498.3175,-750 8492.3175,-756 8486.3175,-756"/>
+<text text-anchor="middle" x="8451" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 176&#45;&gt;238 -->
+<g id="edge637" class="edge">
+<title>176-&gt;238</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8400.1593,-791.8314C8408.1511,-783.3694 8417.8038,-773.1489 8426.5416,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8429.288,-766.0866 8433.6097,-756.4133 8424.1989,-761.2802 8429.288,-766.0866"/>
+</g>
+<!-- 177 -->
+<g id="node178" class="node">
+<title>177</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M8837.2072,-828C8837.2072,-828 8772.7928,-828 8772.7928,-828 8766.7928,-828 8760.7928,-822 8760.7928,-816 8760.7928,-816 8760.7928,-804 8760.7928,-804 8760.7928,-798 8766.7928,-792 8772.7928,-792 8772.7928,-792 8837.2072,-792 8837.2072,-792 8843.2072,-792 8849.2072,-798 8849.2072,-804 8849.2072,-804 8849.2072,-816 8849.2072,-816 8849.2072,-822 8843.2072,-828 8837.2072,-828"/>
+<text text-anchor="middle" x="8805" y="-813" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+<text text-anchor="middle" x="8805" y="-801" font-family="sans" font-size="10.00" fill="#000000">chrom: 7D</text>
+</g>
+<!-- 177&#45;&gt;72 -->
+<g id="edge308" class="edge">
+<title>177-&gt;72</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8806.4942,-791.9242C8809.2259,-752.0114 8812.8198,-653.7292 8790,-576 8784.8441,-558.4379 8775.564,-557.4371 8770,-540 8755.6247,-494.9492 8752.347,-439.6843 8751.8039,-406.7368"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8755.3015,-406.4343 8751.7125,-396.4659 8748.3018,-406.4967 8755.3015,-406.4343"/>
+</g>
+<!-- 240 -->
+<g id="node241" class="node">
+<title>240</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M9008.0981,-756C9008.0981,-756 8949.9019,-756 8949.9019,-756 8943.9019,-756 8937.9019,-750 8937.9019,-744 8937.9019,-744 8937.9019,-732 8937.9019,-732 8937.9019,-726 8943.9019,-720 8949.9019,-720 8949.9019,-720 9008.0981,-720 9008.0981,-720 9014.0981,-720 9020.0981,-726 9020.0981,-732 9020.0981,-732 9020.0981,-744 9020.0981,-744 9020.0981,-750 9014.0981,-756 9008.0981,-756"/>
+<text text-anchor="middle" x="8979" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 177&#45;&gt;240 -->
+<g id="edge640" class="edge">
+<title>177-&gt;240</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8848.9075,-791.8314C8873.1,-781.8207 8903.2401,-769.3489 8928.4158,-758.9314"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8929.897,-762.1064 8937.7989,-755.0487 8927.2205,-755.6383 8929.897,-762.1064"/>
+</g>
+<!-- 241 -->
+<g id="node242" class="node">
+<title>241</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M8908.3175,-756C8908.3175,-756 8837.6825,-756 8837.6825,-756 8831.6825,-756 8825.6825,-750 8825.6825,-744 8825.6825,-744 8825.6825,-732 8825.6825,-732 8825.6825,-726 8831.6825,-720 8837.6825,-720 8837.6825,-720 8908.3175,-720 8908.3175,-720 8914.3175,-720 8920.3175,-726 8920.3175,-732 8920.3175,-732 8920.3175,-744 8920.3175,-744 8920.3175,-750 8914.3175,-756 8908.3175,-756"/>
+<text text-anchor="middle" x="8873" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 177&#45;&gt;241 -->
+<g id="edge642" class="edge">
+<title>177-&gt;241</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8822.1593,-791.8314C8830.1511,-783.3694 8839.8038,-773.1489 8848.5416,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8851.288,-766.0866 8855.6097,-756.4133 8846.1989,-761.2802 8851.288,-766.0866"/>
+</g>
+<!-- 178&#45;&gt;73 -->
+<g id="edge309" class="edge">
+<title>178-&gt;73</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M210.5234,-719.8314C211.5929,-712.131 212.8647,-702.9743 214.0532,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="217.5336,-694.7997 215.4426,-684.4133 210.6001,-693.8367 217.5336,-694.7997"/>
+</g>
+<!-- 179&#45;&gt;73 -->
+<g id="edge310" class="edge">
+<title>179-&gt;73</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M289.7751,-719.8314C277.8372,-710.8779 263.2744,-699.9558 250.394,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="252.3171,-687.3629 242.2171,-684.1628 248.1171,-692.9629 252.3171,-687.3629"/>
+</g>
+<!-- 180 -->
+<g id="node181" class="node">
+<title>180</title>
+<path fill="none" stroke="#566bd8" stroke-width="2" stroke-dasharray="5,2" d="M4691.7053,-756C4691.7053,-756 4652.2947,-756 4652.2947,-756 4646.2947,-756 4640.2947,-750 4640.2947,-744 4640.2947,-744 4640.2947,-732 4640.2947,-732 4640.2947,-726 4646.2947,-720 4652.2947,-720 4652.2947,-720 4691.7053,-720 4691.7053,-720 4697.7053,-720 4703.7053,-726 4703.7053,-732 4703.7053,-732 4703.7053,-744 4703.7053,-744 4703.7053,-750 4697.7053,-756 4691.7053,-756"/>
+<text text-anchor="middle" x="4672" y="-735" font-family="sans" font-size="10.00" fill="#000000">indexQuery</text>
+</g>
+<!-- 180&#45;&gt;73 -->
+<g id="edge311" class="edge">
+<title>180-&gt;73</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3672,-729.1532C4626.0304,-725.5694 4608.7879,-721.846 4593,-720 4139.9577,-667.028 943.8051,-701.1778 488,-684 419.5296,-681.4196 341.4391,-675.9368 286.9149,-671.6964"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="286.9184,-668.186 276.6753,-670.8931 286.3709,-675.1646 286.9184,-668.186"/>
+</g>
+<!-- 180&#45;&gt;74 -->
+<g id="edge316" class="edge">
+<title>180-&gt;74</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3663,-729.1605C4626.0294,-725.5782 4608.787,-721.8538 4593,-720 4185.8888,-672.1944 1313.5831,-700.3271 904,-684 840.2093,-681.4571 767.6591,-676.1542 715.9478,-671.9595"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="716.1444,-668.464 705.8921,-671.1365 715.5733,-675.4406 716.1444,-668.464"/>
+</g>
+<!-- 180&#45;&gt;75 -->
+<g id="edge321" class="edge">
+<title>180-&gt;75</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.359,-729.2218C4626.0206,-725.6513 4608.7792,-721.9193 4593,-720 4153.0591,-666.4889 3041.8168,-702.021 2599,-684 2525.4231,-681.0057 2441.25,-675.3963 2383.7614,-671.232"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2383.9311,-667.7352 2373.703,-670.4984 2383.4219,-674.7166 2383.9311,-667.7352"/>
+</g>
+<!-- 180&#45;&gt;76 -->
+<g id="edge326" class="edge">
+<title>180-&gt;76</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3256,-729.4777C4625.9808,-725.9567 4608.7435,-722.1926 4593,-720 4292.3685,-678.1309 4214.0632,-700.8832 3911,-684 3829.1959,-679.4428 3735.151,-673.8812 3672.9353,-670.1569"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3673.0396,-666.657 3662.8481,-669.5525 3672.6208,-673.6445 3673.0396,-666.657"/>
+</g>
+<!-- 180&#45;&gt;77 -->
+<g id="edge331" class="edge">
+<title>180-&gt;77</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4639.9347,-725.128C4635.2789,-723.3538 4630.5297,-721.5952 4626,-720 4592.1568,-708.0818 4554.132,-696.0088 4522.4576,-686.3097"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4523.4292,-682.947 4512.8432,-683.3787 4521.3879,-689.6427 4523.4292,-682.947"/>
+</g>
+<!-- 180&#45;&gt;78 -->
+<g id="edge336" class="edge">
+<title>180-&gt;78</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3656,-729.1664C4626.0285,-725.5852 4608.7863,-721.8601 4593,-720 3840.6075,-631.3436 1939.0767,-745.7549 1184,-684 1168.3736,-682.722 1151.6704,-680.6072 1135.9197,-678.2678"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1136.1429,-674.7611 1125.7278,-676.7046 1135.0816,-681.6802 1136.1429,-674.7611"/>
+</g>
+<!-- 180&#45;&gt;79 -->
+<g id="edge341" class="edge">
+<title>180-&gt;79</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3618,-729.1985C4626.024,-725.6235 4608.7822,-721.8944 4593,-720 4059.8784,-656.0077 2713.5381,-704.988 2177,-684 2103.4185,-681.1217 2019.2461,-675.4932 1961.759,-671.2927"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1961.9308,-667.796 1951.7008,-670.5525 1961.4169,-674.7771 1961.9308,-667.796"/>
+</g>
+<!-- 180&#45;&gt;80 -->
+<g id="edge346" class="edge">
+<title>180-&gt;80</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3549,-729.2557C4626.0157,-725.6917 4608.7747,-721.9554 4593,-720 4242.2606,-676.5224 3356.0645,-699.9347 3003,-684 2935.9946,-680.9759 2859.6151,-675.6078 2805.9439,-671.5184"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2806.0968,-668.02 2795.8583,-670.7447 2805.5612,-674.9995 2806.0968,-668.02"/>
+</g>
+<!-- 180&#45;&gt;81 -->
+<g id="edge351" class="edge">
+<title>180-&gt;81</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3643,-729.1775C4626.027,-725.5984 4608.7849,-721.8719 4593,-720 3933.7932,-641.8254 2267.5764,-738.6046 1606,-684 1590.3746,-682.7103 1573.6717,-680.5908 1557.9212,-678.2505"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1558.1443,-674.7439 1547.7292,-676.6873 1557.083,-681.663 1558.1443,-674.7439"/>
+</g>
+<!-- 180&#45;&gt;82 -->
+<g id="edge356" class="edge">
+<title>180-&gt;82</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3468,-729.3193C4626.0061,-725.7677 4608.7661,-722.0235 4593,-720 4085.3581,-654.8477 3953.1712,-709.4778 3442,-684 3376.1136,-680.7161 3301.0443,-675.4237 3248.0206,-671.4257"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3247.9552,-667.9108 3237.7191,-670.6444 3247.4257,-674.8908 3247.9552,-667.9108"/>
+</g>
+<!-- 180&#45;&gt;83 -->
+<g id="edge361" class="edge">
+<title>180-&gt;83</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.2788,-729.7895C4625.9249,-726.3288 4608.6935,-722.5257 4593,-720 4498.9439,-704.8627 4224.9477,-681.8528 4095.8309,-671.4478"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4095.9146,-667.9434 4085.6662,-670.6306 4095.3535,-674.9208 4095.9146,-667.9434"/>
+</g>
+<!-- 180&#45;&gt;84 -->
+<g id="edge366" class="edge">
+<title>180-&gt;84</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0783,-736.0923C4766.7079,-732.433 4909.6629,-724.4014 5030,-720 5728.8269,-694.4398 5905.1186,-728.429 6603,-684 6637.0671,-681.8312 6674.8004,-678.0384 6706.2238,-674.4919"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6706.6545,-677.9656 6716.1918,-673.3515 6705.8588,-671.0109 6706.6545,-677.9656"/>
+</g>
+<!-- 180&#45;&gt;85 -->
+<g id="edge371" class="edge">
+<title>180-&gt;85</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4703.6712,-732.6471C4772.2292,-721.0598 4935.7255,-693.4267 5029.245,-677.6206"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5029.9042,-681.0589 5039.1811,-675.9412 5028.7376,-674.1568 5029.9042,-681.0589"/>
+</g>
+<!-- 180&#45;&gt;86 -->
+<g id="edge376" class="edge">
+<title>180-&gt;86</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0818,-736.1825C4766.7174,-732.6793 4909.6824,-724.9059 5030,-720 5541.3808,-699.1487 5670.3691,-718.6582 6181,-684 6215.0577,-681.6884 6252.7899,-677.8797 6284.2151,-674.3596"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6284.6419,-677.8337 6294.1838,-673.2291 6283.8531,-670.8783 6284.6419,-677.8337"/>
+</g>
+<!-- 180&#45;&gt;87 -->
+<g id="edge381" class="edge">
+<title>180-&gt;87</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4703.6178,-735.7191C4799.3772,-728.751 5094.6387,-706.8249 5339,-684 5372.1863,-680.9002 5408.9719,-677.056 5439.8123,-673.7171"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5440.4665,-677.1667 5450.0294,-672.606 5439.7096,-670.2077 5440.4665,-677.1667"/>
+</g>
+<!-- 180&#45;&gt;88 -->
+<g id="edge386" class="edge">
+<title>180-&gt;88</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0753,-736.0063C4766.6998,-732.1982 4909.6463,-723.9207 5030,-720 6103.7718,-685.02 6374.5651,-747.9741 7447,-684 7481.0755,-681.9673 7518.8097,-678.1897 7550.2316,-674.6181"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7550.6661,-678.0913 7560.199,-673.4682 7549.8638,-671.1374 7550.6661,-678.0913"/>
+</g>
+<!-- 180&#45;&gt;89 -->
+<g id="edge391" class="edge">
+<title>180-&gt;89</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4703.6665,-736.4024C4873.424,-727.8339 5669.9585,-687.5782 5722,-684 5768.7251,-680.7874 5821.2478,-676.2601 5861.9519,-672.5497"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5862.3964,-676.0237 5872.0351,-671.6253 5861.7572,-669.0529 5862.3964,-676.0237"/>
+</g>
+<!-- 180&#45;&gt;90 -->
+<g id="edge396" class="edge">
+<title>180-&gt;90</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0764,-736.0402C4766.7029,-732.2908 4909.6526,-724.1103 5030,-720 5916.2943,-689.7301 6139.8469,-738.2012 7025,-684 7059.0723,-681.9136 7096.8061,-678.1301 7128.2286,-674.5683"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7128.6616,-678.0417 7138.1963,-673.4222 7127.8619,-671.0875 7128.6616,-678.0417"/>
+</g>
+<!-- 180&#45;&gt;91 -->
+<g id="edge401" class="edge">
+<title>180-&gt;91</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0745,-735.9825C4766.6977,-732.1332 4909.642,-723.7875 5030,-720 6291.2549,-680.3098 6609.2776,-757.7473 7869,-684 7903.0777,-682.005 7940.8122,-678.2317 7972.2336,-674.6531"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7972.6692,-678.1261 7982.2009,-673.5005 7971.8651,-671.1724 7972.6692,-678.1261"/>
+</g>
+<!-- 180&#45;&gt;92 -->
+<g id="edge406" class="edge">
+<title>180-&gt;92</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.074,-735.9648C4766.6962,-732.085 4909.639,-723.6888 5030,-720 5754.3707,-697.7997 7567.4934,-725.7603 8291,-684 8325.0794,-682.033 8362.814,-678.2627 8394.2351,-674.679"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8394.6715,-678.1519 8404.2023,-673.5245 8393.866,-671.1984 8394.6715,-678.1519"/>
+</g>
+<!-- 180&#45;&gt;93 -->
+<g id="edge411" class="edge">
+<title>180-&gt;93</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0736,-735.9512C4766.6951,-732.0478 4909.6367,-723.6127 5030,-720 5848.1151,-695.4445 7895.8468,-730.6471 8713,-684 8747.0806,-682.0545 8784.8154,-678.2867 8816.2363,-674.699"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8816.6732,-678.1718 8826.2034,-673.543 8815.8667,-671.2184 8816.6732,-678.1718"/>
+</g>
+<!-- 180&#45;&gt;243 -->
+<g id="edge646" class="edge">
+<title>180-&gt;243</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.367,-729.1547C4626.0302,-725.5712 4608.7877,-721.8476 4593,-720 4150.0052,-668.1581 1018.6381,-759.1687 579,-684 538.335,-677.0471 434.6783,-639.2376 370.3079,-614.8888"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="371.3104,-611.5257 360.7191,-611.2514 368.8276,-618.0707 371.3104,-611.5257"/>
+</g>
+<!-- 180&#45;&gt;244 -->
+<g id="edge649" class="edge">
+<title>180-&gt;244</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3661,-729.1624C4626.0291,-725.5804 4608.7868,-721.8558 4593,-720 4196.3778,-673.3743 1392.5263,-751.972 999,-684 958.7358,-677.0453 856.3338,-639.4336 792.422,-615.0852"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="793.4878,-611.7457 782.8972,-611.4463 790.9896,-618.2848 793.4878,-611.7457"/>
+</g>
+<!-- 180&#45;&gt;245 -->
+<g id="edge652" class="edge">
+<title>180-&gt;245</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3584,-729.2266C4626.0199,-725.6571 4608.7785,-721.9244 4593,-720 4380.7576,-694.1137 2877.8376,-729.8674 2669,-684 2652.8504,-680.453 2567.6022,-641.8601 2512.2461,-616.3764"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2513.5049,-613.1028 2502.9582,-612.0946 2510.5743,-619.4598 2513.5049,-613.1028"/>
+</g>
+<!-- 180&#45;&gt;246 -->
+<g id="edge655" class="edge">
+<title>180-&gt;246</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3215,-729.507C4625.9759,-725.9917 4608.7391,-722.224 4593,-720 4313.5444,-680.5124 4233.6063,-749.1621 3959,-684 3919.8771,-674.7164 3913.8079,-661.6877 3876,-648 3833.2231,-632.5134 3783.6856,-618.1734 3746.794,-608.1687"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3747.306,-604.6821 3736.7401,-605.4645 3745.4878,-611.4419 3747.306,-604.6821"/>
+</g>
+<!-- 180&#45;&gt;247 -->
+<g id="edge658" class="edge">
+<title>180-&gt;247</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4649.9628,-719.7623C4618.9772,-694.119 4562.4491,-647.3372 4527.7566,-618.6262"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4529.7938,-615.7689 4519.8583,-612.0896 4525.3308,-621.1617 4529.7938,-615.7689"/>
+</g>
+<!-- 180&#45;&gt;248 -->
+<g id="edge661" class="edge">
+<title>180-&gt;248</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3649,-729.1723C4626.0277,-725.5922 4608.7855,-721.8664 4593,-720 4242.9709,-678.6152 1768.2841,-744.2231 1421,-684 1344.5308,-670.7393 1260.3791,-638.2477 1208.8562,-616.1577"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1210.1921,-612.9222 1199.6246,-612.161 1207.4109,-619.346 1210.1921,-612.9222"/>
+</g>
+<!-- 180&#45;&gt;249 -->
+<g id="edge664" class="edge">
+<title>180-&gt;249</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3614,-729.2018C4626.0235,-725.6274 4608.7818,-721.8979 4593,-720 4334.1676,-688.8732 2501.722,-739.496 2247,-684 2230.8444,-680.4802 2145.5982,-641.8783 2090.2441,-616.3856"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2091.5031,-613.112 2080.9565,-612.1022 2088.5715,-619.4685 2091.5031,-613.112"/>
+</g>
+<!-- 180&#45;&gt;250 -->
+<g id="edge667" class="edge">
+<title>180-&gt;250</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3533,-729.2678C4626.0138,-725.7062 4608.7731,-721.9684 4593,-720 4266.1053,-679.2045 3433.706,-750.2213 3111,-684 3044.8212,-670.4197 2973.1379,-638.4653 2928.8938,-616.5307"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2930.3891,-613.3652 2919.8809,-612.0124 2927.2519,-619.6228 2930.3891,-613.3652"/>
+</g>
+<!-- 180&#45;&gt;251 -->
+<g id="edge670" class="edge">
+<title>180-&gt;251</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3635,-729.1845C4626.026,-725.6068 4608.784,-721.8794 4593,-720 4287.576,-683.6324 2127.3976,-740.2325 1825,-684 1753.6794,-670.7375 1675.7952,-638.475 1627.9126,-616.4099"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1629.2898,-613.1903 1618.747,-612.1415 1626.3346,-619.536 1629.2898,-613.1903"/>
+</g>
+<!-- 180&#45;&gt;252 -->
+<g id="edge673" class="edge">
+<title>180-&gt;252</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.3442,-729.3399C4626.0029,-725.7922 4608.7633,-722.0454 4593,-720 4126.8576,-659.5154 3998.4432,-768.2224 3536,-684 3494.8838,-676.5117 3389.5322,-638.6861 3324.4266,-614.517"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3325.3252,-611.117 3314.7324,-610.9088 3322.8834,-617.6773 3325.3252,-611.117"/>
+</g>
+<!-- 180&#45;&gt;253 -->
+<g id="edge676" class="edge">
+<title>180-&gt;253</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4640.1768,-730.3537C4625.8032,-727.0022 4608.5846,-723.1284 4593,-720 4501.4455,-701.6213 4476.5727,-706.7287 4386,-684 4309.3128,-664.7558 4222.9911,-634.7109 4168.5658,-614.6976"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4169.7097,-611.389 4159.1164,-611.2057 4167.2833,-617.9551 4169.7097,-611.389"/>
+</g>
+<!-- 180&#45;&gt;254 -->
+<g id="edge679" class="edge">
+<title>180-&gt;254</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0787,-736.1046C4766.7091,-732.4666 4909.6655,-724.4703 5030,-720 5113.1889,-716.9096 6450.7991,-715.1442 6528,-684 6560.4828,-670.8959 6588.8667,-641.7411 6606.6118,-620.1465"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6609.3791,-622.29 6612.8782,-612.2896 6603.9065,-617.9252 6609.3791,-622.29"/>
+</g>
+<!-- 180&#45;&gt;255 -->
+<g id="edge682" class="edge">
+<title>180-&gt;255</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4700.8764,-719.7623C4741.9921,-693.7945 4817.43,-646.1495 4862.721,-617.5446"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4864.7722,-620.3888 4871.3581,-612.0896 4861.0342,-614.4704 4864.7722,-620.3888"/>
+</g>
+<!-- 180&#45;&gt;256 -->
+<g id="edge685" class="edge">
+<title>180-&gt;256</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0833,-736.2187C4766.7215,-732.7782 4909.6909,-725.1085 5030,-720 5145.4097,-715.0995 5959.039,-719.3835 6069,-684 6110.3747,-670.6864 6150.9177,-640.7257 6176.6005,-619.0223"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6179.1116,-621.4785 6184.3991,-612.2974 6174.5403,-616.1773 6179.1116,-621.4785"/>
+</g>
+<!-- 180&#45;&gt;257 -->
+<g id="edge688" class="edge">
+<title>180-&gt;257</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4703.6425,-736.3619C4819.3674,-730.2027 5215.5523,-707.5799 5267,-684 5297.6539,-669.9505 5324.3288,-641.4426 5341.1549,-620.2571"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5343.9876,-622.3151 5347.3212,-612.2584 5338.4438,-618.0413 5343.9876,-622.3151"/>
+</g>
+<!-- 180&#45;&gt;258 -->
+<g id="edge691" class="edge">
+<title>180-&gt;258</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0756,-736.0141C4766.7005,-732.2195 4909.6477,-723.9643 5030,-720 5158.0018,-715.7838 7212.7176,-722.069 7335,-684 7376.7421,-671.0048 7417.4907,-640.6868 7443.1079,-618.8267"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7445.6349,-621.2671 7450.8756,-612.0591 7441.0366,-615.9892 7445.6349,-621.2671"/>
+</g>
+<!-- 180&#45;&gt;259 -->
+<g id="edge694" class="edge">
+<title>180-&gt;259</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4703.7545,-736.3546C4870.2722,-727.7126 5635.5342,-687.8208 5647,-684 5688.2348,-670.259 5728.8065,-640.3861 5754.5342,-618.8199"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5757.0207,-621.299 5762.3478,-612.1408 5752.4723,-615.978 5757.0207,-621.299"/>
+</g>
+<!-- 180&#45;&gt;260 -->
+<g id="edge697" class="edge">
+<title>180-&gt;260</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0768,-736.0517C4766.7039,-732.3223 4909.6548,-724.1748 5030,-720 5134.5673,-716.3725 6813.1536,-715.2759 6913,-684 6954.7193,-670.9318 6995.4727,-640.6293 7021.0973,-618.7927"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7023.6201,-621.2371 7028.8674,-612.033 7019.0256,-615.9559 7023.6201,-621.2371"/>
+</g>
+<!-- 180&#45;&gt;261 -->
+<g id="edge700" class="edge">
+<title>180-&gt;261</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0747,-735.9862C4766.698,-732.1433 4909.6427,-723.8082 5030,-720 5106.7459,-717.5717 7722.6348,-712.3344 7794,-684 7826.5544,-671.0748 7854.9251,-641.887 7872.6475,-620.2357"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7875.4268,-622.364 7878.9049,-612.3563 7869.9451,-618.0107 7875.4268,-622.364"/>
+</g>
+<!-- 180&#45;&gt;262 -->
+<g id="edge703" class="edge">
+<title>180-&gt;262</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0741,-735.969C4766.6965,-732.0965 4909.6397,-723.7124 5030,-720 5204.8727,-714.6062 8011.8437,-735.6557 8179,-684 8220.7692,-671.0922 8261.512,-640.7556 8287.1205,-618.8673"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8289.6527,-621.3029 8294.8853,-612.0904 8285.0497,-616.0291 8289.6527,-621.3029"/>
+</g>
+<!-- 180&#45;&gt;263 -->
+<g id="edge706" class="edge">
+<title>180-&gt;263</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4704.0737,-735.9545C4766.6953,-732.0568 4909.6372,-723.6311 5030,-720 5129.1544,-717.0087 8506.2031,-713.2246 8601,-684 8642.7779,-671.1204 8683.5189,-640.7778 8709.1246,-618.8804"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8711.6584,-621.3145 8716.8884,-612.1005 8707.054,-616.0419 8711.6584,-621.3145"/>
+</g>
+<!-- 181 -->
+<g id="node182" class="node">
+<title>181</title>
+<path fill="none" stroke="#70d856" stroke-width="2" stroke-dasharray="5,2" d="M4360.3138,-756C4360.3138,-756 4319.6862,-756 4319.6862,-756 4313.6862,-756 4307.6862,-750 4307.6862,-744 4307.6862,-744 4307.6862,-732 4307.6862,-732 4307.6862,-726 4313.6862,-720 4319.6862,-720 4319.6862,-720 4360.3138,-720 4360.3138,-720 4366.3138,-720 4372.3138,-726 4372.3138,-732 4372.3138,-732 4372.3138,-744 4372.3138,-744 4372.3138,-750 4366.3138,-756 4360.3138,-756"/>
+<text text-anchor="middle" x="4340" y="-735" font-family="sans" font-size="10.00" fill="#000000">indexTarget</text>
+</g>
+<!-- 181&#45;&gt;73 -->
+<g id="edge312" class="edge">
+<title>181-&gt;73</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7392,-733.6996C4273.2308,-729.3164 4216.8605,-722.7789 4168,-720 3314.0093,-671.4306 1170.6855,-763.3152 319,-684 308.5846,-683.03 297.6323,-681.5578 286.9376,-679.8647"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="287.2266,-676.3649 276.7889,-678.183 286.0822,-683.2707 287.2266,-676.3649"/>
+</g>
+<!-- 181&#45;&gt;74 -->
+<g id="edge317" class="edge">
+<title>181-&gt;74</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7385,-733.7108C4273.2297,-729.3369 4216.8588,-722.8071 4168,-720 3407.8781,-676.329 1499.6563,-759.1627 742,-684 733.4435,-683.1512 724.5078,-681.9214 715.6871,-680.4971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="716.2488,-677.0424 705.8035,-678.8163 715.0752,-683.9433 716.2488,-677.0424"/>
+</g>
+<!-- 181&#45;&gt;75 -->
+<g id="edge322" class="edge">
+<title>181-&gt;75</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7322,-733.8162C4273.218,-729.5304 4216.8428,-723.0734 4168,-720 3422.1927,-673.0701 3232.8073,-730.9299 2487,-684 2452.9313,-681.8562 2415.1979,-678.0662 2383.7747,-674.5151"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2384.1403,-671.0342 2373.8068,-673.373 2383.3433,-677.9887 2384.1403,-671.0342"/>
+</g>
+<!-- 181&#45;&gt;76 -->
+<g id="edge327" class="edge">
+<title>181-&gt;76</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.6739,-734.5311C4273.111,-730.8424 4216.6956,-724.8791 4168,-720 3989.6892,-702.134 3779.5311,-682.3484 3673.1599,-672.4237"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3673.1656,-668.9091 3662.8838,-671.4655 3672.5156,-675.8789 3673.1656,-668.9091"/>
+</g>
+<!-- 181&#45;&gt;77 -->
+<g id="edge332" class="edge">
+<title>181-&gt;77</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4368.767,-719.8314C4383.2133,-710.7074 4400.8965,-699.539 4416.404,-689.7449"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4418.6563,-692.462 4425.2422,-684.1628 4414.9183,-686.5436 4418.6563,-692.462"/>
+</g>
+<!-- 181&#45;&gt;78 -->
+<g id="edge337" class="edge">
+<title>181-&gt;78</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7377,-733.7244C4273.2282,-729.3618 4216.8569,-722.8414 4168,-720 3497.5297,-681.0073 1812.9355,-763.044 1146,-684 1142.7173,-683.6109 1139.3715,-683.1416 1136.002,-682.6101"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1136.3131,-679.1117 1125.8613,-680.8467 1135.1138,-686.0082 1136.3131,-679.1117"/>
+</g>
+<!-- 181&#45;&gt;79 -->
+<g id="edge342" class="edge">
+<title>181-&gt;79</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7347,-733.7747C4273.2227,-729.4542 4216.8493,-722.9685 4168,-720 3234.9177,-663.2977 2998.0823,-740.7023 2065,-684 2030.9268,-681.9294 1993.1928,-678.1476 1961.7705,-674.583"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1962.1376,-671.1022 1951.8029,-673.4357 1961.3371,-678.0563 1962.1376,-671.1022"/>
+</g>
+<!-- 181&#45;&gt;80 -->
+<g id="edge347" class="edge">
+<title>181-&gt;80</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7275,-733.8876C4273.2095,-729.6614 4216.8311,-723.2536 4168,-720 3613.4437,-683.0498 3472.6496,-719.5221 2918,-684 2881.0153,-681.6313 2839.9013,-677.6515 2806.2169,-674.0355"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2806.3339,-670.5278 2796.0144,-672.9272 2805.5779,-677.4868 2806.3339,-670.5278"/>
+</g>
+<!-- 181&#45;&gt;81 -->
+<g id="edge352" class="edge">
+<title>181-&gt;81</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7366,-733.7431C4273.2262,-729.3961 4216.8541,-722.8886 4168,-720 3591.1743,-685.8939 2141.7511,-752.5624 1568,-684 1564.7177,-683.6078 1561.3722,-683.1359 1558.0029,-682.6022"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1558.3154,-679.104 1547.8628,-680.834 1557.1129,-685.9999 1558.3154,-679.104"/>
+</g>
+<!-- 181&#45;&gt;82 -->
+<g id="edge357" class="edge">
+<title>181-&gt;82</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7199,-733.9983C4273.1954,-729.8645 4216.8117,-723.5332 4168,-720 3771.3824,-691.2908 3669.0855,-729.1359 3274,-684 3265.4571,-683.024 3256.5295,-681.718 3247.7131,-680.253"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3248.2838,-676.7998 3237.8329,-678.5406 3247.0883,-683.697 3248.2838,-676.7998"/>
+</g>
+<!-- 181&#45;&gt;83 -->
+<g id="edge362" class="edge">
+<title>181-&gt;83</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.6824,-730.5659C4257.9126,-719.1173 4161.3778,-696.9112 4095.563,-681.7717"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4096.2107,-678.3293 4085.6806,-679.4984 4094.6415,-685.1512 4096.2107,-678.3293"/>
+</g>
+<!-- 181&#45;&gt;84 -->
+<g id="edge367" class="edge">
+<title>181-&gt;84</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2798,-722.4446C4375.1816,-721.4711 4378.1141,-720.6309 4381,-720 4614.0843,-669.0446 6289.6498,-694.6747 6528,-684 6588.1504,-681.3061 6656.405,-676.1732 6705.8981,-672.0758"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6706.4909,-675.5385 6716.1649,-671.2184 6705.9083,-668.5628 6706.4909,-675.5385"/>
+</g>
+<!-- 181&#45;&gt;85 -->
+<g id="edge372" class="edge">
+<title>181-&gt;85</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.3226,-722.6273C4375.215,-721.6142 4378.1338,-720.7149 4381,-720 4502.5086,-689.6936 4873.9794,-673.7222 5028.9586,-668.2319"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5029.4216,-671.7179 5039.293,-667.87 5029.1766,-664.7222 5029.4216,-671.7179"/>
+</g>
+<!-- 181&#45;&gt;86 -->
+<g id="edge377" class="edge">
+<title>181-&gt;86</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.283,-722.4589C4375.184,-721.4823 4378.1155,-720.6375 4381,-720 4564.1781,-679.5171 5881.5697,-691.9349 6069,-684 6142.5719,-680.8853 6226.7458,-675.2957 6284.236,-671.169"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6284.5729,-674.6539 6294.2947,-670.4423 6284.0684,-667.6721 6284.5729,-674.6539"/>
+</g>
+<!-- 181&#45;&gt;87 -->
+<g id="edge382" class="edge">
+<title>181-&gt;87</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2967,-722.5193C4375.1947,-721.5296 4378.1218,-720.6653 4381,-720 4572.9896,-675.6238 5070.2735,-695.3098 5267,-684 5325.3121,-680.6476 5391.4403,-675.6472 5439.8169,-671.7668"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5440.175,-675.2494 5449.8613,-670.9568 5439.6123,-668.2721 5440.175,-675.2494"/>
+</g>
+<!-- 181&#45;&gt;88 -->
+<g id="edge387" class="edge">
+<title>181-&gt;88</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2767,-722.4302C4375.1791,-721.4598 4378.1127,-720.6243 4381,-720 4541.4165,-685.3155 7170.9936,-690.1927 7335,-684 7408.5853,-681.2215 7492.7571,-675.5766 7550.243,-671.345"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7550.5873,-674.8292 7560.3009,-670.599 7550.0694,-667.8484 7550.5873,-674.8292"/>
+</g>
+<!-- 181&#45;&gt;89 -->
+<g id="edge392" class="edge">
+<title>181-&gt;89</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.288,-722.4812C4375.1879,-721.4997 4378.1178,-720.6477 4381,-720 4518.2991,-689.1446 5506.4244,-690.4516 5647,-684 5720.5603,-680.624 5804.7362,-675.0774 5862.2299,-671.0322"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5862.5612,-674.5176 5872.2893,-670.3206 5862.0672,-667.535 5862.5612,-674.5176"/>
+</g>
+<!-- 181&#45;&gt;90 -->
+<g id="edge397" class="edge">
+<title>181-&gt;90</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2781,-722.4366C4375.1802,-721.4648 4378.1133,-720.6272 4381,-720 4518.4732,-690.13 6772.4248,-689.4509 6913,-684 6986.5825,-681.1468 7070.7547,-675.5142 7128.2415,-671.3059"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7128.5841,-674.7902 7138.2996,-670.5642 7128.0693,-667.8092 7128.5841,-674.7902"/>
+</g>
+<!-- 181&#45;&gt;91 -->
+<g id="edge402" class="edge">
+<title>181-&gt;91</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2756,-722.425C4375.1783,-721.4558 4378.1122,-720.6219 4381,-720 4566.3717,-680.0787 7604.5428,-691.8948 7794,-684 7854.1585,-681.4931 7922.4124,-676.3426 7971.903,-672.1909"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7972.5004,-675.6529 7982.1693,-671.3214 7971.9096,-668.6779 7972.5004,-675.6529"/>
+</g>
+<!-- 181&#45;&gt;92 -->
+<g id="edge407" class="edge">
+<title>181-&gt;92</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2749,-722.4217C4375.1777,-721.4532 4378.1118,-720.6204 4381,-720 4587.3039,-675.6862 7968.1302,-691.6763 8179,-684 8252.589,-681.3211 8336.7602,-675.6599 8394.2449,-671.3972"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8394.5914,-674.8811 8404.3027,-670.6454 8394.0696,-667.9006 8394.5914,-674.8811"/>
+</g>
+<!-- 181&#45;&gt;93 -->
+<g id="edge412" class="edge">
+<title>181-&gt;93</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2742,-722.4187C4375.1772,-721.4509 4378.1115,-720.619 4381,-720 4610.2479,-670.8715 8366.6982,-692.4181 8601,-684 8674.5903,-681.356 8758.7612,-675.689 8816.2456,-671.4154"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8816.5928,-674.8993 8826.3033,-670.6617 8816.0696,-667.9189 8816.5928,-674.8993"/>
+</g>
+<!-- 181&#45;&gt;243 -->
+<g id="edge647" class="edge">
+<title>181-&gt;243</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7389,-733.7038C4273.2304,-729.324 4216.8599,-722.7894 4168,-720 3963.8781,-708.3469 686.3024,-733.7762 488,-684 436.3888,-671.045 383.0134,-639.8349 349.6826,-617.8157"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="351.4969,-614.8182 341.2428,-612.1524 347.5964,-620.6308 351.4969,-614.8182"/>
+</g>
+<!-- 181&#45;&gt;244 -->
+<g id="edge650" class="edge">
+<title>181-&gt;244</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7382,-733.7158C4273.2291,-729.3462 4216.8581,-722.8198 4168,-720 3986.9569,-709.5512 1079.5296,-729.5537 904,-684 854.1122,-671.053 802.8911,-640.0638 770.7903,-618.0762"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="772.4665,-614.9785 762.2602,-612.1358 768.4661,-620.7228 772.4665,-614.9785"/>
+</g>
+<!-- 181&#45;&gt;245 -->
+<g id="edge653" class="edge">
+<title>181-&gt;245</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7312,-733.831C4273.2163,-729.5575 4216.8405,-723.1107 4168,-720 3993.9734,-708.9159 2765.3064,-736.4433 2599,-684 2557.3057,-670.8521 2516.547,-640.5665 2490.9144,-618.7556"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2492.9865,-615.9195 2483.1415,-612.0044 2488.3962,-621.2044 2492.9865,-615.9195"/>
+</g>
+<!-- 181&#45;&gt;246 -->
+<g id="edge656" class="edge">
+<title>181-&gt;246</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7818,-734.4425C4214.635,-724.0875 3949.2008,-694.0628 3911,-684 3848.5994,-667.5626 3780.3786,-637.4421 3736.9397,-616.6005"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3738.3159,-613.3782 3727.79,-612.1717 3735.2661,-619.6789 3738.3159,-613.3782"/>
+</g>
+<!-- 181&#45;&gt;247 -->
+<g id="edge659" class="edge">
+<title>181-&gt;247</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4345.3332,-719.9984C4352.0085,-700.1557 4365.1648,-668.3566 4386,-648 4402.1951,-632.1769 4423.9209,-620.2549 4443.9265,-611.6935"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4445.3387,-614.8974 4453.2732,-607.8765 4442.6922,-608.417 4445.3387,-614.8974"/>
+</g>
+<!-- 181&#45;&gt;248 -->
+<g id="edge662" class="edge">
+<title>181-&gt;248</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7376,-733.7258C4273.2281,-729.3645 4216.8566,-722.8451 4168,-720 4085.2453,-715.1809 1249.4289,-734.8982 1184,-684 1165.6311,-669.7106 1160.3302,-643.0446 1159.2097,-622.4332"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1162.7054,-622.2141 1158.9577,-612.3043 1155.7076,-622.3883 1162.7054,-622.2141"/>
+</g>
+<!-- 181&#45;&gt;249 -->
+<g id="edge665" class="edge">
+<title>181-&gt;249</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7342,-733.784C4273.2217,-729.4713 4216.8479,-722.992 4168,-720 4057.5778,-713.2364 2282.5882,-717.0144 2177,-684 2135.2739,-670.9534 2094.5219,-640.6463 2068.8995,-618.8028"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2070.9711,-615.9658 2061.1302,-612.0407 2066.3755,-621.246 2070.9711,-615.9658"/>
+</g>
+<!-- 181&#45;&gt;250 -->
+<g id="edge668" class="edge">
+<title>181-&gt;250</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7262,-733.9079C4273.207,-729.6986 4216.8277,-723.3049 4168,-720 4038.7894,-711.2544 3124.9497,-727.5905 3003,-684 2966.0871,-670.8056 2931.5142,-641.2464 2909.6638,-619.5898"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2911.9935,-616.9673 2902.4826,-612.2989 2907.0063,-621.8794 2911.9935,-616.9673"/>
+</g>
+<!-- 181&#45;&gt;251 -->
+<g id="edge671" class="edge">
+<title>181-&gt;251</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7365,-733.745C4273.226,-729.3998 4216.8538,-722.8936 4168,-720 4096.9508,-715.7917 1662.1339,-727.757 1606,-684 1587.6453,-669.6923 1582.3427,-643.0286 1581.2178,-622.4227"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1584.7136,-622.2058 1580.9635,-612.2969 1577.7158,-622.3817 1584.7136,-622.2058"/>
+</g>
+<!-- 181&#45;&gt;252 -->
+<g id="edge674" class="edge">
+<title>181-&gt;252</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4307.7131,-734.0881C4273.1831,-730.0294 4216.7948,-723.7602 4168,-720 4006.9459,-707.589 3597.8585,-726.4333 3442,-684 3390.955,-670.1027 3337.8399,-639.4099 3304.3855,-617.7439"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3306.1826,-614.7368 3295.9033,-612.1702 3302.3385,-620.5868 3306.1826,-614.7368"/>
+</g>
+<!-- 181&#45;&gt;253 -->
+<g id="edge677" class="edge">
+<title>181-&gt;253</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4311.3769,-719.7623C4270.6218,-693.7945 4195.8457,-646.1495 4150.952,-617.5446"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4152.705,-614.5115 4142.3906,-612.0896 4148.9434,-620.415 4152.705,-614.5115"/>
+</g>
+<!-- 181&#45;&gt;254 -->
+<g id="edge680" class="edge">
+<title>181-&gt;254</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2805,-722.4473C4375.182,-721.4733 4378.1144,-720.6322 4381,-720 4823.9003,-622.9719 5978.0997,-781.0281 6421,-684 6481.5867,-670.727 6546.292,-639.033 6586.4418,-617.0394"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6588.3171,-620.0016 6595.3636,-612.0897 6584.9212,-613.8805 6588.3171,-620.0016"/>
+</g>
+<!-- 181&#45;&gt;255 -->
+<g id="edge683" class="edge">
+<title>181-&gt;255</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.4597,-723.0994C4375.3224,-721.9838 4378.1968,-720.9319 4381,-720 4429.1215,-704.0023 4763.5973,-633.042 4845.6486,-611.8509"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4846.5618,-615.2297 4855.3108,-609.2544 4844.7451,-608.4696 4846.5618,-615.2297"/>
+</g>
+<!-- 181&#45;&gt;256 -->
+<g id="edge686" class="edge">
+<title>181-&gt;256</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2836,-722.4618C4375.1845,-721.4846 4378.1158,-720.6388 4381,-720 4732.135,-642.2284 5650.4142,-772.4994 5999,-684 6032.9086,-675.3912 6037.1679,-662.5126 6069,-648 6095.1572,-636.0747 6124.758,-624.073 6149.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6151.1018,-617.5803 6159.1672,-610.71 6148.5778,-611.0511 6151.1018,-617.5803"/>
+</g>
+<!-- 181&#45;&gt;257 -->
+<g id="edge689" class="edge">
+<title>181-&gt;257</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.3005,-722.5357C4375.1977,-721.5424 4378.1236,-720.6728 4381,-720 4721.0776,-640.4597 4826.7629,-767.0521 5166,-684 5223.0915,-670.0229 5283.7605,-638.9156 5321.7501,-617.2094"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5323.5332,-620.2214 5330.436,-612.1839 5320.0276,-614.1625 5323.5332,-620.2214"/>
+</g>
+<!-- 181&#45;&gt;258 -->
+<g id="edge692" class="edge">
+<title>181-&gt;258</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2769,-722.4311C4375.1793,-721.4606 4378.1128,-720.6247 4381,-720 4694.2214,-652.2282 6954.0035,-761.3421 7265,-684 7298.9502,-675.5569 7303.1679,-662.5126 7335,-648 7361.1572,-636.0747 7390.758,-624.073 7415.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7417.1018,-617.5803 7425.1672,-610.71 7414.5778,-611.0511 7417.1018,-617.5803"/>
+</g>
+<!-- 181&#45;&gt;259 -->
+<g id="edge695" class="edge">
+<title>181-&gt;259</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2891,-722.4864C4375.1888,-721.5038 4378.1184,-720.6501 4381,-720 4640.3792,-661.4828 5319.5366,-750.4413 5577,-684 5610.8745,-675.2583 5615.1679,-662.5126 5647,-648 5673.1572,-636.0747 5702.758,-624.073 5727.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5729.1018,-617.5803 5737.1672,-610.71 5726.5778,-611.0511 5729.1018,-617.5803"/>
+</g>
+<!-- 181&#45;&gt;260 -->
+<g id="edge698" class="edge">
+<title>181-&gt;260</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2784,-722.4378C4375.1804,-721.4658 4378.1134,-720.6278 4381,-720 4648.3351,-661.8572 6577.573,-750.3109 6843,-684 6876.9411,-675.5206 6881.1679,-662.5126 6913,-648 6939.1572,-636.0747 6968.758,-624.073 6993.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6995.1018,-617.5803 7003.1672,-610.71 6992.5778,-611.0511 6995.1018,-617.5803"/>
+</g>
+<!-- 181&#45;&gt;261 -->
+<g id="edge701" class="edge">
+<title>181-&gt;261</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2758,-722.4261C4375.1784,-721.4567 4378.1123,-720.6224 4381,-720 4740.1084,-642.599 7327.8916,-761.401 7687,-684 7747.6312,-670.9318 7812.3255,-639.1873 7852.4607,-617.1266"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7854.3447,-620.0836 7861.3791,-612.161 7850.9394,-613.9677 7854.3447,-620.0836"/>
+</g>
+<!-- 181&#45;&gt;262 -->
+<g id="edge704" class="edge">
+<title>181-&gt;262</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.275,-722.4223C4375.1778,-721.4536 4378.1119,-720.6206 4381,-720 4785.996,-632.9697 7706.8623,-783.405 8109,-684 8142.9621,-675.6049 8147.1679,-662.5126 8179,-648 8205.1572,-636.0747 8234.758,-624.073 8259.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8261.1018,-617.5803 8269.1672,-610.71 8258.5778,-611.0511 8261.1018,-617.5803"/>
+</g>
+<!-- 181&#45;&gt;263 -->
+<g id="edge707" class="edge">
+<title>181-&gt;263</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4372.2743,-722.4192C4375.1773,-721.4512 4378.1116,-720.6192 4381,-720 4606.442,-671.6701 8307.1456,-739.2183 8531,-684 8564.9662,-675.6215 8569.1679,-662.5126 8601,-648 8627.1572,-636.0747 8656.758,-624.073 8681.5622,-614.423"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8683.1018,-617.5803 8691.1672,-610.71 8680.5778,-611.0511 8683.1018,-617.5803"/>
+</g>
+<!-- 182 -->
+<g id="node183" class="node">
+<title>182</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M257.545,-972C257.545,-972 222.455,-972 222.455,-972 216.455,-972 210.455,-966 210.455,-960 210.455,-960 210.455,-948 210.455,-948 210.455,-942 216.455,-936 222.455,-936 222.455,-936 257.545,-936 257.545,-936 263.545,-936 269.545,-942 269.545,-948 269.545,-948 269.545,-960 269.545,-960 269.545,-966 263.545,-972 257.545,-972"/>
+<text text-anchor="middle" x="240" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="240" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 1A</text>
+</g>
+<!-- 182&#45;&gt;73 -->
+<g id="edge313" class="edge">
+<title>182-&gt;73</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M226.0726,-935.9878C208.7692,-912.5479 179.8407,-869.6481 166,-828 155.8461,-797.4461 159.7805,-788.1477 158,-756 157.1152,-740.0245 151.4906,-734.616 158,-720 163.0334,-708.6983 171.7305,-698.7696 180.9659,-690.611"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="183.2815,-693.2382 188.7816,-684.1828 178.835,-687.8319 183.2815,-693.2382"/>
+</g>
+<!-- 265 -->
+<g id="node266" class="node">
+<title>265</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M292.8571,-828C292.8571,-828 187.1429,-828 187.1429,-828 181.1429,-828 175.1429,-822 175.1429,-816 175.1429,-816 175.1429,-804 175.1429,-804 175.1429,-798 181.1429,-792 187.1429,-792 187.1429,-792 292.8571,-792 292.8571,-792 298.8571,-792 304.8571,-798 304.8571,-804 304.8571,-804 304.8571,-816 304.8571,-816 304.8571,-822 298.8571,-828 292.8571,-828"/>
+<text text-anchor="middle" x="240" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 182&#45;&gt;265 -->
+<g id="edge709" class="edge">
+<title>182-&gt;265</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M232.3321,-935.8756C228.3861,-925.5642 223.9945,-912.2907 222,-900 219.4371,-884.2066 219.4371,-879.7934 222,-864 223.418,-855.2621 226.0475,-846.0275 228.8671,-837.7136"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="232.2254,-838.7187 232.3321,-828.1244 225.642,-836.3399 232.2254,-838.7187"/>
+</g>
+<!-- 287 -->
+<g id="node288" class="node">
+<title>287</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M311.1477,-900C311.1477,-900 242.8523,-900 242.8523,-900 236.8523,-900 230.8523,-894 230.8523,-888 230.8523,-888 230.8523,-876 230.8523,-876 230.8523,-870 236.8523,-864 242.8523,-864 242.8523,-864 311.1477,-864 311.1477,-864 317.1477,-864 323.1477,-870 323.1477,-876 323.1477,-876 323.1477,-888 323.1477,-888 323.1477,-894 317.1477,-900 311.1477,-900"/>
+<text text-anchor="middle" x="277" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 182&#45;&gt;287 -->
+<g id="edge750" class="edge">
+<title>182-&gt;287</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M249.3367,-935.8314C253.4243,-927.8771 258.3104,-918.369 262.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="266.0799,-910.9074 267.5376,-900.4133 259.8539,-907.7078 266.0799,-910.9074"/>
+</g>
+<!-- 183&#45;&gt;74 -->
+<g id="edge314" class="edge">
+<title>183-&gt;74</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M634.2898,-719.8314C636.108,-712.131 638.2699,-702.9743 640.2905,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="643.7608,-694.95 642.6524,-684.4133 636.9481,-693.3414 643.7608,-694.95"/>
+</g>
+<!-- 184&#45;&gt;74 -->
+<g id="edge315" class="edge">
+<title>184-&gt;74</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M713.5415,-719.8314C702.5795,-710.9632 689.2301,-700.1637 677.3735,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="679.4271,-687.7313 669.4513,-684.1628 675.0245,-693.1734 679.4271,-687.7313"/>
+</g>
+<!-- 185 -->
+<g id="node186" class="node">
+<title>185</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M658.545,-972C658.545,-972 623.455,-972 623.455,-972 617.455,-972 611.455,-966 611.455,-960 611.455,-960 611.455,-948 611.455,-948 611.455,-942 617.455,-936 623.455,-936 623.455,-936 658.545,-936 658.545,-936 664.545,-936 670.545,-942 670.545,-948 670.545,-948 670.545,-960 670.545,-960 670.545,-966 664.545,-972 658.545,-972"/>
+<text text-anchor="middle" x="641" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="641" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 2A</text>
+</g>
+<!-- 185&#45;&gt;74 -->
+<g id="edge318" class="edge">
+<title>185-&gt;74</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M628.1158,-935.8777C601.091,-895.4594 543.8552,-795.5548 580,-720 585.596,-708.3025 595.0993,-698.3295 605.2172,-690.2563"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="607.4496,-692.9583 613.4003,-684.1924 603.282,-687.3341 607.4496,-692.9583"/>
+</g>
+<!-- 267 -->
+<g id="node268" class="node">
+<title>267</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M718.8571,-828C718.8571,-828 613.1429,-828 613.1429,-828 607.1429,-828 601.1429,-822 601.1429,-816 601.1429,-816 601.1429,-804 601.1429,-804 601.1429,-798 607.1429,-792 613.1429,-792 613.1429,-792 718.8571,-792 718.8571,-792 724.8571,-792 730.8571,-798 730.8571,-804 730.8571,-804 730.8571,-816 730.8571,-816 730.8571,-822 724.8571,-828 718.8571,-828"/>
+<text text-anchor="middle" x="666" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 185&#45;&gt;267 -->
+<g id="edge711" class="edge">
+<title>185-&gt;267</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M631.7559,-935.6769C623.7224,-917.2068 614.5882,-888.0674 623,-864 626.5957,-853.7121 633.0628,-843.9193 639.9076,-835.568"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="642.5502,-837.863 646.5044,-828.0337 637.2836,-833.2517 642.5502,-837.863"/>
+</g>
+<!-- 288 -->
+<g id="node289" class="node">
+<title>288</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M712.1477,-900C712.1477,-900 643.8523,-900 643.8523,-900 637.8523,-900 631.8523,-894 631.8523,-888 631.8523,-888 631.8523,-876 631.8523,-876 631.8523,-870 637.8523,-864 643.8523,-864 643.8523,-864 712.1477,-864 712.1477,-864 718.1477,-864 724.1477,-870 724.1477,-876 724.1477,-876 724.1477,-888 724.1477,-888 724.1477,-894 718.1477,-900 712.1477,-900"/>
+<text text-anchor="middle" x="678" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 185&#45;&gt;288 -->
+<g id="edge751" class="edge">
+<title>185-&gt;288</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M650.3367,-935.8314C654.4243,-927.8771 659.3104,-918.369 663.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="667.0799,-910.9074 668.5376,-900.4133 660.8539,-907.7078 667.0799,-910.9074"/>
+</g>
+<!-- 186&#45;&gt;75 -->
+<g id="edge319" class="edge">
+<title>186-&gt;75</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2328.4578,-719.8314C2326.5116,-712.0463 2324.1932,-702.7729 2322.0337,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2325.4242,-693.2658 2319.6033,-684.4133 2318.6332,-694.9636 2325.4242,-693.2658"/>
+</g>
+<!-- 187&#45;&gt;75 -->
+<g id="edge320" class="edge">
+<title>187-&gt;75</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2249.2061,-719.8314C2260.045,-710.9632 2273.2444,-700.1637 2284.9678,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2287.2777,-693.2041 2292.801,-684.1628 2282.845,-687.7864 2287.2777,-693.2041"/>
+</g>
+<!-- 188 -->
+<g id="node189" class="node">
+<title>188</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M2287.545,-972C2287.545,-972 2252.455,-972 2252.455,-972 2246.455,-972 2240.455,-966 2240.455,-960 2240.455,-960 2240.455,-948 2240.455,-948 2240.455,-942 2246.455,-936 2252.455,-936 2252.455,-936 2287.545,-936 2287.545,-936 2293.545,-936 2299.545,-942 2299.545,-948 2299.545,-948 2299.545,-960 2299.545,-960 2299.545,-966 2293.545,-972 2287.545,-972"/>
+<text text-anchor="middle" x="2270" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="2270" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 3A</text>
+</g>
+<!-- 188&#45;&gt;75 -->
+<g id="edge323" class="edge">
+<title>188-&gt;75</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2240.065,-944.9677C2218.8133,-936.8512 2191.7139,-922.6569 2178,-900 2136.5433,-831.509 2125.398,-785.8038 2171,-720 2180.3376,-706.5259 2213.8499,-693.5534 2246.1964,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2247.5755,-686.9434 2256.1695,-680.7471 2245.5872,-680.2317 2247.5755,-686.9434"/>
+</g>
+<!-- 268 -->
+<g id="node269" class="node">
+<title>268</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M2309.8571,-828C2309.8571,-828 2204.1429,-828 2204.1429,-828 2198.1429,-828 2192.1429,-822 2192.1429,-816 2192.1429,-816 2192.1429,-804 2192.1429,-804 2192.1429,-798 2198.1429,-792 2204.1429,-792 2204.1429,-792 2309.8571,-792 2309.8571,-792 2315.8571,-792 2321.8571,-798 2321.8571,-804 2321.8571,-804 2321.8571,-816 2321.8571,-816 2321.8571,-822 2315.8571,-828 2309.8571,-828"/>
+<text text-anchor="middle" x="2257" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 188&#45;&gt;268 -->
+<g id="edge713" class="edge">
+<title>188-&gt;268</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2278.4663,-935.9161C2285.895,-917.6321 2294.5683,-888.6345 2288,-864 2285.5048,-854.6419 2280.9592,-845.2199 2276.1039,-836.925"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2279.0608,-835.0521 2270.7963,-828.4228 2273.1229,-838.759 2279.0608,-835.0521"/>
+</g>
+<!-- 289 -->
+<g id="node290" class="node">
+<title>289</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M2267.1477,-900C2267.1477,-900 2198.8523,-900 2198.8523,-900 2192.8523,-900 2186.8523,-894 2186.8523,-888 2186.8523,-888 2186.8523,-876 2186.8523,-876 2186.8523,-870 2192.8523,-864 2198.8523,-864 2198.8523,-864 2267.1477,-864 2267.1477,-864 2273.1477,-864 2279.1477,-870 2279.1477,-876 2279.1477,-876 2279.1477,-888 2279.1477,-888 2279.1477,-894 2273.1477,-900 2267.1477,-900"/>
+<text text-anchor="middle" x="2233" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 188&#45;&gt;289 -->
+<g id="edge752" class="edge">
+<title>188-&gt;289</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2260.6633,-935.8314C2256.5757,-927.8771 2251.6896,-918.369 2247.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2250.1461,-907.7078 2242.4624,-900.4133 2243.9201,-910.9074 2250.1461,-907.7078"/>
+</g>
+<!-- 189&#45;&gt;76 -->
+<g id="edge324" class="edge">
+<title>189-&gt;76</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3672.7845,-719.8314C3661.453,-710.9632 3647.6536,-700.1637 3635.3973,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3637.2402,-687.5697 3627.2081,-684.1628 3632.926,-693.0822 3637.2402,-687.5697"/>
+</g>
+<!-- 190&#45;&gt;76 -->
+<g id="edge325" class="edge">
+<title>190-&gt;76</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3593.5328,-719.8314C3595.0301,-712.131 3596.8105,-702.9743 3598.4745,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3601.9465,-694.8975 3600.4196,-684.4133 3595.0752,-693.5614 3601.9465,-694.8975"/>
+</g>
+<!-- 191 -->
+<g id="node192" class="node">
+<title>191</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M3660.545,-972C3660.545,-972 3625.455,-972 3625.455,-972 3619.455,-972 3613.455,-966 3613.455,-960 3613.455,-960 3613.455,-948 3613.455,-948 3613.455,-942 3619.455,-936 3625.455,-936 3625.455,-936 3660.545,-936 3660.545,-936 3666.545,-936 3672.545,-942 3672.545,-948 3672.545,-948 3672.545,-960 3672.545,-960 3672.545,-966 3666.545,-972 3660.545,-972"/>
+<text text-anchor="middle" x="3643" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="3643" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 4A</text>
+</g>
+<!-- 191&#45;&gt;76 -->
+<g id="edge328" class="edge">
+<title>191-&gt;76</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3613.2085,-944.421C3592.3185,-936.0901 3565.6101,-921.8672 3551,-900 3506.3589,-833.1849 3498.5523,-792.1148 3534,-720 3539.8234,-708.1528 3549.6351,-698.171 3560.0978,-690.1383"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3562.4445,-692.7642 3568.5646,-684.1158 3558.3871,-687.0601 3562.4445,-692.7642"/>
+</g>
+<!-- 269 -->
+<g id="node270" class="node">
+<title>269</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M3667.8571,-828C3667.8571,-828 3562.1429,-828 3562.1429,-828 3556.1429,-828 3550.1429,-822 3550.1429,-816 3550.1429,-816 3550.1429,-804 3550.1429,-804 3550.1429,-798 3556.1429,-792 3562.1429,-792 3562.1429,-792 3667.8571,-792 3667.8571,-792 3673.8571,-792 3679.8571,-798 3679.8571,-804 3679.8571,-804 3679.8571,-816 3679.8571,-816 3679.8571,-822 3673.8571,-828 3667.8571,-828"/>
+<text text-anchor="middle" x="3615" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 191&#45;&gt;269 -->
+<g id="edge715" class="edge">
+<title>191-&gt;269</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3652.2586,-935.9627C3660.4593,-917.4649 3669.8639,-888.0745 3661,-864 3657.195,-853.6656 3650.4356,-843.9621 3643.25,-835.7098"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3645.692,-833.1965 3636.3127,-828.2692 3640.5721,-837.9701 3645.692,-833.1965"/>
+</g>
+<!-- 290 -->
+<g id="node291" class="node">
+<title>290</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M3640.1477,-900C3640.1477,-900 3571.8523,-900 3571.8523,-900 3565.8523,-900 3559.8523,-894 3559.8523,-888 3559.8523,-888 3559.8523,-876 3559.8523,-876 3559.8523,-870 3565.8523,-864 3571.8523,-864 3571.8523,-864 3640.1477,-864 3640.1477,-864 3646.1477,-864 3652.1477,-870 3652.1477,-876 3652.1477,-876 3652.1477,-888 3652.1477,-888 3652.1477,-894 3646.1477,-900 3640.1477,-900"/>
+<text text-anchor="middle" x="3606" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 191&#45;&gt;290 -->
+<g id="edge753" class="edge">
+<title>191-&gt;290</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3633.6633,-935.8314C3629.5757,-927.8771 3624.6896,-918.369 3620.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3623.1461,-907.7078 3615.4624,-900.4133 3616.9201,-910.9074 3623.1461,-907.7078"/>
+</g>
+<!-- 192&#45;&gt;77 -->
+<g id="edge329" class="edge">
+<title>192-&gt;77</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4436.8039,-719.8314C4439.2908,-712.0463 4442.2531,-702.7729 4445.0125,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4448.409,-695.0041 4448.118,-684.4133 4441.7409,-692.874 4448.409,-695.0041"/>
+</g>
+<!-- 193&#45;&gt;77 -->
+<g id="edge330" class="edge">
+<title>193-&gt;77</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4516.0556,-719.8314C4505.9309,-711.0485 4493.6223,-700.3712 4482.6452,-690.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4484.7851,-688.0718 4474.9377,-684.1628 4480.1981,-693.3595 4484.7851,-688.0718"/>
+</g>
+<!-- 194 -->
+<g id="node195" class="node">
+<title>194</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M4456.545,-972C4456.545,-972 4421.455,-972 4421.455,-972 4415.455,-972 4409.455,-966 4409.455,-960 4409.455,-960 4409.455,-948 4409.455,-948 4409.455,-942 4415.455,-936 4421.455,-936 4421.455,-936 4456.545,-936 4456.545,-936 4462.545,-936 4468.545,-942 4468.545,-948 4468.545,-948 4468.545,-960 4468.545,-960 4468.545,-966 4462.545,-972 4456.545,-972"/>
+<text text-anchor="middle" x="4439" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="4439" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 5A</text>
+</g>
+<!-- 194&#45;&gt;77 -->
+<g id="edge333" class="edge">
+<title>194-&gt;77</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4468.7557,-947.4948C4508.4245,-938.1646 4575.3531,-919.8999 4590,-900 4602.5073,-883.007 4602.7551,-734.2552 4593,-720 4584.2267,-707.1796 4553.1312,-694.5119 4522.5707,-684.6713"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4523.2853,-681.2276 4512.6963,-681.5791 4521.1933,-687.9077 4523.2853,-681.2276"/>
+</g>
+<!-- 270 -->
+<g id="node271" class="node">
+<title>270</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M4465.8571,-828C4465.8571,-828 4360.1429,-828 4360.1429,-828 4354.1429,-828 4348.1429,-822 4348.1429,-816 4348.1429,-816 4348.1429,-804 4348.1429,-804 4348.1429,-798 4354.1429,-792 4360.1429,-792 4360.1429,-792 4465.8571,-792 4465.8571,-792 4471.8571,-792 4477.8571,-798 4477.8571,-804 4477.8571,-804 4477.8571,-816 4477.8571,-816 4477.8571,-822 4471.8571,-828 4465.8571,-828"/>
+<text text-anchor="middle" x="4413" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 194&#45;&gt;270 -->
+<g id="edge717" class="edge">
+<title>194-&gt;270</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4412.7437,-935.8151C4401.6578,-926.5285 4389.9542,-914.1902 4384,-900 4375.3458,-879.3751 4384.1183,-855.2106 4394.219,-837.1165"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4397.3903,-838.6339 4399.5368,-828.2587 4391.3888,-835.0308 4397.3903,-838.6339"/>
+</g>
+<!-- 291 -->
+<g id="node292" class="node">
+<title>291</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M4473.1477,-900C4473.1477,-900 4404.8523,-900 4404.8523,-900 4398.8523,-900 4392.8523,-894 4392.8523,-888 4392.8523,-888 4392.8523,-876 4392.8523,-876 4392.8523,-870 4398.8523,-864 4404.8523,-864 4404.8523,-864 4473.1477,-864 4473.1477,-864 4479.1477,-864 4485.1477,-870 4485.1477,-876 4485.1477,-876 4485.1477,-888 4485.1477,-888 4485.1477,-894 4479.1477,-900 4473.1477,-900"/>
+<text text-anchor="middle" x="4439" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 194&#45;&gt;291 -->
+<g id="edge754" class="edge">
+<title>194-&gt;291</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4439,-935.8314C4439,-928.131 4439,-918.9743 4439,-910.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4442.5001,-910.4132 4439,-900.4133 4435.5001,-910.4133 4442.5001,-910.4132"/>
+</g>
+<!-- 195&#45;&gt;78 -->
+<g id="edge334" class="edge">
+<title>195-&gt;78</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1141.7658,-719.8314C1129.212,-710.7927 1113.8717,-699.7476 1100.3609,-690.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1102.3866,-687.1655 1092.2261,-684.1628 1098.2964,-692.8463 1102.3866,-687.1655"/>
+</g>
+<!-- 196&#45;&gt;78 -->
+<g id="edge335" class="edge">
+<title>196-&gt;78</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1062.5141,-719.8314C1063.1558,-712.131 1063.9188,-702.9743 1064.6319,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1068.1229,-694.6694 1065.4656,-684.4133 1061.1471,-694.088 1068.1229,-694.6694"/>
+</g>
+<!-- 197 -->
+<g id="node198" class="node">
+<title>197</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M1138.545,-972C1138.545,-972 1103.455,-972 1103.455,-972 1097.455,-972 1091.455,-966 1091.455,-960 1091.455,-960 1091.455,-948 1091.455,-948 1091.455,-942 1097.455,-936 1103.455,-936 1103.455,-936 1138.545,-936 1138.545,-936 1144.545,-936 1150.545,-942 1150.545,-948 1150.545,-948 1150.545,-960 1150.545,-960 1150.545,-966 1144.545,-972 1138.545,-972"/>
+<text text-anchor="middle" x="1121" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="1121" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 6A</text>
+</g>
+<!-- 197&#45;&gt;78 -->
+<g id="edge338" class="edge">
+<title>197-&gt;78</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1091.3842,-944.3019C1070.5816,-935.9117 1043.9055,-921.6669 1029,-900 983.2568,-833.5069 971.5661,-793.4571 1005,-720 1010.174,-708.6322 1019.0543,-698.7268 1028.5028,-690.6122"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1030.8729,-693.1986 1036.5042,-684.2243 1026.5055,-687.7281 1030.8729,-693.1986"/>
+</g>
+<!-- 271 -->
+<g id="node272" class="node">
+<title>271</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M1143.8571,-828C1143.8571,-828 1038.1429,-828 1038.1429,-828 1032.1429,-828 1026.1429,-822 1026.1429,-816 1026.1429,-816 1026.1429,-804 1026.1429,-804 1026.1429,-798 1032.1429,-792 1038.1429,-792 1038.1429,-792 1143.8571,-792 1143.8571,-792 1149.8571,-792 1155.8571,-798 1155.8571,-804 1155.8571,-804 1155.8571,-816 1155.8571,-816 1155.8571,-822 1149.8571,-828 1143.8571,-828"/>
+<text text-anchor="middle" x="1091" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 197&#45;&gt;271 -->
+<g id="edge719" class="edge">
+<title>197-&gt;271</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1130.3632,-935.9236C1138.6472,-917.3946 1148.1171,-887.9798 1139,-864 1134.9728,-853.4076 1127.81,-843.5662 1120.2263,-835.2649"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1122.7138,-832.8025 1113.2213,-828.0968 1117.7074,-837.695 1122.7138,-832.8025"/>
+</g>
+<!-- 292 -->
+<g id="node293" class="node">
+<title>292</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M1118.1477,-900C1118.1477,-900 1049.8523,-900 1049.8523,-900 1043.8523,-900 1037.8523,-894 1037.8523,-888 1037.8523,-888 1037.8523,-876 1037.8523,-876 1037.8523,-870 1043.8523,-864 1049.8523,-864 1049.8523,-864 1118.1477,-864 1118.1477,-864 1124.1477,-864 1130.1477,-870 1130.1477,-876 1130.1477,-876 1130.1477,-888 1130.1477,-888 1130.1477,-894 1124.1477,-900 1118.1477,-900"/>
+<text text-anchor="middle" x="1084" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 197&#45;&gt;292 -->
+<g id="edge755" class="edge">
+<title>197-&gt;292</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1111.6633,-935.8314C1107.5757,-927.8771 1102.6896,-918.369 1098.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1101.1461,-907.7078 1093.4624,-900.4133 1094.9201,-910.9074 1101.1461,-907.7078"/>
+</g>
+<!-- 198&#45;&gt;79 -->
+<g id="edge339" class="edge">
+<title>198-&gt;79</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1822.7202,-719.8314C1834.4094,-710.8779 1848.6688,-699.9558 1861.2809,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1863.4769,-693.0222 1869.2874,-684.1628 1859.2203,-687.4651 1863.4769,-693.0222"/>
+</g>
+<!-- 199&#45;&gt;79 -->
+<g id="edge340" class="edge">
+<title>199-&gt;79</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1901.9719,-719.8314C1900.6885,-712.131 1899.1624,-702.9743 1897.7361,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1901.1653,-693.7018 1896.0689,-684.4133 1894.2606,-694.8526 1901.1653,-693.7018"/>
+</g>
+<!-- 200 -->
+<g id="node201" class="node">
+<title>200</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M1854.545,-972C1854.545,-972 1819.455,-972 1819.455,-972 1813.455,-972 1807.455,-966 1807.455,-960 1807.455,-960 1807.455,-948 1807.455,-948 1807.455,-942 1813.455,-936 1819.455,-936 1819.455,-936 1854.545,-936 1854.545,-936 1860.545,-936 1866.545,-942 1866.545,-948 1866.545,-948 1866.545,-960 1866.545,-960 1866.545,-966 1860.545,-972 1854.545,-972"/>
+<text text-anchor="middle" x="1837" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="1837" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 7A</text>
+</g>
+<!-- 200&#45;&gt;79 -->
+<g id="edge343" class="edge">
+<title>200-&gt;79</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1819.396,-935.8595C1781.4876,-894.5505 1699.4324,-791.5261 1749,-720 1758.3376,-706.5259 1791.8499,-693.5534 1824.1964,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1825.5755,-686.9434 1834.1695,-680.7471 1823.5872,-680.2317 1825.5755,-686.9434"/>
+</g>
+<!-- 272 -->
+<g id="node273" class="node">
+<title>272</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M1883.8571,-828C1883.8571,-828 1778.1429,-828 1778.1429,-828 1772.1429,-828 1766.1429,-822 1766.1429,-816 1766.1429,-816 1766.1429,-804 1766.1429,-804 1766.1429,-798 1772.1429,-792 1778.1429,-792 1778.1429,-792 1883.8571,-792 1883.8571,-792 1889.8571,-792 1895.8571,-798 1895.8571,-804 1895.8571,-804 1895.8571,-816 1895.8571,-816 1895.8571,-822 1889.8571,-828 1883.8571,-828"/>
+<text text-anchor="middle" x="1831" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 200&#45;&gt;272 -->
+<g id="edge721" class="edge">
+<title>200-&gt;272</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1829.3321,-935.8756C1825.3861,-925.5642 1820.9945,-912.2907 1819,-900 1815.6439,-879.3189 1819.0075,-855.8521 1823.0178,-838.0672"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1826.4266,-838.862 1825.4079,-828.3162 1819.6278,-837.1955 1826.4266,-838.862"/>
+</g>
+<!-- 293 -->
+<g id="node294" class="node">
+<title>293</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M1908.1477,-900C1908.1477,-900 1839.8523,-900 1839.8523,-900 1833.8523,-900 1827.8523,-894 1827.8523,-888 1827.8523,-888 1827.8523,-876 1827.8523,-876 1827.8523,-870 1833.8523,-864 1839.8523,-864 1839.8523,-864 1908.1477,-864 1908.1477,-864 1914.1477,-864 1920.1477,-870 1920.1477,-876 1920.1477,-876 1920.1477,-888 1920.1477,-888 1920.1477,-894 1914.1477,-900 1908.1477,-900"/>
+<text text-anchor="middle" x="1874" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 200&#45;&gt;293 -->
+<g id="edge756" class="edge">
+<title>200-&gt;293</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1846.3367,-935.8314C1850.4243,-927.8771 1855.3104,-918.369 1859.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1863.0799,-910.9074 1864.5376,-900.4133 1856.8539,-907.7078 1863.0799,-910.9074"/>
+</g>
+<!-- 201&#45;&gt;80 -->
+<g id="edge344" class="edge">
+<title>201-&gt;80</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2666.7202,-719.8314C2678.4094,-710.8779 2692.6688,-699.9558 2705.2809,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2707.4769,-693.0222 2713.2874,-684.1628 2703.2203,-687.4651 2707.4769,-693.0222"/>
+</g>
+<!-- 202&#45;&gt;80 -->
+<g id="edge345" class="edge">
+<title>202-&gt;80</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2745.9719,-719.8314C2744.6885,-712.131 2743.1624,-702.9743 2741.7361,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2745.1653,-693.7018 2740.0689,-684.4133 2738.2606,-694.8526 2745.1653,-693.7018"/>
+</g>
+<!-- 203 -->
+<g id="node204" class="node">
+<title>203</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M2697.4971,-972C2697.4971,-972 2662.5029,-972 2662.5029,-972 2656.5029,-972 2650.5029,-966 2650.5029,-960 2650.5029,-960 2650.5029,-948 2650.5029,-948 2650.5029,-942 2656.5029,-936 2662.5029,-936 2662.5029,-936 2697.4971,-936 2697.4971,-936 2703.4971,-936 2709.4971,-942 2709.4971,-948 2709.4971,-948 2709.4971,-960 2709.4971,-960 2709.4971,-966 2703.4971,-972 2697.4971,-972"/>
+<text text-anchor="middle" x="2680" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="2680" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 1B</text>
+</g>
+<!-- 203&#45;&gt;80 -->
+<g id="edge348" class="edge">
+<title>203-&gt;80</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2662.5264,-935.8454C2624.9043,-894.5071 2543.5018,-791.4259 2593,-720 2602.3376,-706.5259 2635.8499,-693.5534 2668.1964,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2669.5755,-686.9434 2678.1695,-680.7471 2667.5872,-680.2317 2669.5755,-686.9434"/>
+</g>
+<!-- 273 -->
+<g id="node274" class="node">
+<title>273</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M2726.8571,-828C2726.8571,-828 2621.1429,-828 2621.1429,-828 2615.1429,-828 2609.1429,-822 2609.1429,-816 2609.1429,-816 2609.1429,-804 2609.1429,-804 2609.1429,-798 2615.1429,-792 2621.1429,-792 2621.1429,-792 2726.8571,-792 2726.8571,-792 2732.8571,-792 2738.8571,-798 2738.8571,-804 2738.8571,-804 2738.8571,-816 2738.8571,-816 2738.8571,-822 2732.8571,-828 2726.8571,-828"/>
+<text text-anchor="middle" x="2674" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 203&#45;&gt;273 -->
+<g id="edge723" class="edge">
+<title>203-&gt;273</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2672.3321,-935.8756C2668.3861,-925.5642 2663.9945,-912.2907 2662,-900 2658.6439,-879.3189 2662.0075,-855.8521 2666.0178,-838.0672"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2669.4266,-838.862 2668.4079,-828.3162 2662.6278,-837.1955 2669.4266,-838.862"/>
+</g>
+<!-- 294 -->
+<g id="node295" class="node">
+<title>294</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M2751.1477,-900C2751.1477,-900 2682.8523,-900 2682.8523,-900 2676.8523,-900 2670.8523,-894 2670.8523,-888 2670.8523,-888 2670.8523,-876 2670.8523,-876 2670.8523,-870 2676.8523,-864 2682.8523,-864 2682.8523,-864 2751.1477,-864 2751.1477,-864 2757.1477,-864 2763.1477,-870 2763.1477,-876 2763.1477,-876 2763.1477,-888 2763.1477,-888 2763.1477,-894 2757.1477,-900 2751.1477,-900"/>
+<text text-anchor="middle" x="2717" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 203&#45;&gt;294 -->
+<g id="edge757" class="edge">
+<title>203-&gt;294</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2689.3367,-935.8314C2693.4243,-927.8771 2698.3104,-918.369 2702.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2706.0799,-910.9074 2707.5376,-900.4133 2699.8539,-907.7078 2706.0799,-910.9074"/>
+</g>
+<!-- 204&#45;&gt;81 -->
+<g id="edge349" class="edge">
+<title>204-&gt;81</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1563.7658,-719.8314C1551.212,-710.7927 1535.8717,-699.7476 1522.3609,-690.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1524.3866,-687.1655 1514.2261,-684.1628 1520.2964,-692.8463 1524.3866,-687.1655"/>
+</g>
+<!-- 205&#45;&gt;81 -->
+<g id="edge350" class="edge">
+<title>205-&gt;81</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1484.5141,-719.8314C1485.1558,-712.131 1485.9188,-702.9743 1486.6319,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1490.1229,-694.6694 1487.4656,-684.4133 1483.1471,-694.088 1490.1229,-694.6694"/>
+</g>
+<!-- 206 -->
+<g id="node207" class="node">
+<title>206</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M1527.4971,-972C1527.4971,-972 1492.5029,-972 1492.5029,-972 1486.5029,-972 1480.5029,-966 1480.5029,-960 1480.5029,-960 1480.5029,-948 1480.5029,-948 1480.5029,-942 1486.5029,-936 1492.5029,-936 1492.5029,-936 1527.4971,-936 1527.4971,-936 1533.4971,-936 1539.4971,-942 1539.4971,-948 1539.4971,-948 1539.4971,-960 1539.4971,-960 1539.4971,-966 1533.4971,-972 1527.4971,-972"/>
+<text text-anchor="middle" x="1510" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="1510" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 2B</text>
+</g>
+<!-- 206&#45;&gt;81 -->
+<g id="edge353" class="edge">
+<title>206-&gt;81</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1495.2842,-935.6775C1477.3737,-912.2514 1447.815,-869.7112 1434,-828 1423.8915,-797.4796 1428.5574,-788.1131 1427,-756 1426.225,-740.0188 1420.3719,-734.5626 1427,-720 1432.174,-708.6322 1441.0543,-698.7268 1450.5028,-690.6122"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1452.8729,-693.1986 1458.5042,-684.2243 1448.5055,-687.7281 1452.8729,-693.1986"/>
+</g>
+<!-- 274 -->
+<g id="node275" class="node">
+<title>274</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M1560.8571,-828C1560.8571,-828 1455.1429,-828 1455.1429,-828 1449.1429,-828 1443.1429,-822 1443.1429,-816 1443.1429,-816 1443.1429,-804 1443.1429,-804 1443.1429,-798 1449.1429,-792 1455.1429,-792 1455.1429,-792 1560.8571,-792 1560.8571,-792 1566.8571,-792 1572.8571,-798 1572.8571,-804 1572.8571,-804 1572.8571,-816 1572.8571,-816 1572.8571,-822 1566.8571,-828 1560.8571,-828"/>
+<text text-anchor="middle" x="1508" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 206&#45;&gt;274 -->
+<g id="edge725" class="edge">
+<title>206-&gt;274</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1502.3321,-935.8756C1498.3861,-925.5642 1493.9945,-912.2907 1492,-900 1489.4371,-884.2066 1489.7035,-879.8343 1492,-864 1493.2572,-855.3319 1495.5936,-846.1182 1498.1,-837.802"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1501.4582,-838.7916 1501.1805,-828.2004 1494.7928,-836.6531 1501.4582,-838.7916"/>
+</g>
+<!-- 295 -->
+<g id="node296" class="node">
+<title>295</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M1581.1477,-900C1581.1477,-900 1512.8523,-900 1512.8523,-900 1506.8523,-900 1500.8523,-894 1500.8523,-888 1500.8523,-888 1500.8523,-876 1500.8523,-876 1500.8523,-870 1506.8523,-864 1512.8523,-864 1512.8523,-864 1581.1477,-864 1581.1477,-864 1587.1477,-864 1593.1477,-870 1593.1477,-876 1593.1477,-876 1593.1477,-888 1593.1477,-888 1593.1477,-894 1587.1477,-900 1581.1477,-900"/>
+<text text-anchor="middle" x="1547" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 206&#45;&gt;295 -->
+<g id="edge758" class="edge">
+<title>206-&gt;295</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1519.3367,-935.8314C1523.4243,-927.8771 1528.3104,-918.369 1532.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1536.0799,-910.9074 1537.5376,-900.4133 1529.8539,-907.7078 1536.0799,-910.9074"/>
+</g>
+<!-- 207&#45;&gt;82 -->
+<g id="edge354" class="edge">
+<title>207-&gt;82</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3166.2898,-719.8314C3168.108,-712.131 3170.2699,-702.9743 3172.2905,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3175.7608,-694.95 3174.6524,-684.4133 3168.9481,-693.3414 3175.7608,-694.95"/>
+</g>
+<!-- 208&#45;&gt;82 -->
+<g id="edge355" class="edge">
+<title>208-&gt;82</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3245.5415,-719.8314C3234.5795,-710.9632 3221.2301,-700.1637 3209.3735,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3211.4271,-687.7313 3201.4513,-684.1628 3207.0245,-693.1734 3211.4271,-687.7313"/>
+</g>
+<!-- 209 -->
+<g id="node210" class="node">
+<title>209</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M3238.4971,-972C3238.4971,-972 3203.5029,-972 3203.5029,-972 3197.5029,-972 3191.5029,-966 3191.5029,-960 3191.5029,-960 3191.5029,-948 3191.5029,-948 3191.5029,-942 3197.5029,-936 3203.5029,-936 3203.5029,-936 3238.4971,-936 3238.4971,-936 3244.4971,-936 3250.4971,-942 3250.4971,-948 3250.4971,-948 3250.4971,-960 3250.4971,-960 3250.4971,-966 3244.4971,-972 3238.4971,-972"/>
+<text text-anchor="middle" x="3221" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="3221" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 3B</text>
+</g>
+<!-- 209&#45;&gt;82 -->
+<g id="edge358" class="edge">
+<title>209-&gt;82</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3191.5609,-944.6546C3170.5623,-936.3782 3143.5624,-922.1211 3129,-900 3084.816,-832.8818 3077.3222,-792.4882 3112,-720 3117.596,-708.3025 3127.0993,-698.3295 3137.2172,-690.2563"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3139.4496,-692.9583 3145.4003,-684.1924 3135.282,-687.3341 3139.4496,-692.9583"/>
+</g>
+<!-- 275 -->
+<g id="node276" class="node">
+<title>275</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M3246.8571,-828C3246.8571,-828 3141.1429,-828 3141.1429,-828 3135.1429,-828 3129.1429,-822 3129.1429,-816 3129.1429,-816 3129.1429,-804 3129.1429,-804 3129.1429,-798 3135.1429,-792 3141.1429,-792 3141.1429,-792 3246.8571,-792 3246.8571,-792 3252.8571,-792 3258.8571,-798 3258.8571,-804 3258.8571,-804 3258.8571,-816 3258.8571,-816 3258.8571,-822 3252.8571,-828 3246.8571,-828"/>
+<text text-anchor="middle" x="3194" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 209&#45;&gt;275 -->
+<g id="edge727" class="edge">
+<title>209-&gt;275</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3230.2047,-935.9824C3238.3624,-917.5002 3247.7334,-888.1221 3239,-864 3235.2851,-853.7392 3228.6748,-844.0579 3221.6452,-835.8033"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3224.18,-833.3886 3214.8578,-828.3539 3219.0056,-838.1031 3224.18,-833.3886"/>
+</g>
+<!-- 296 -->
+<g id="node297" class="node">
+<title>296</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M3218.1477,-900C3218.1477,-900 3149.8523,-900 3149.8523,-900 3143.8523,-900 3137.8523,-894 3137.8523,-888 3137.8523,-888 3137.8523,-876 3137.8523,-876 3137.8523,-870 3143.8523,-864 3149.8523,-864 3149.8523,-864 3218.1477,-864 3218.1477,-864 3224.1477,-864 3230.1477,-870 3230.1477,-876 3230.1477,-876 3230.1477,-888 3230.1477,-888 3230.1477,-894 3224.1477,-900 3218.1477,-900"/>
+<text text-anchor="middle" x="3184" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 209&#45;&gt;296 -->
+<g id="edge759" class="edge">
+<title>209-&gt;296</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3211.6633,-935.8314C3207.5757,-927.8771 3202.6896,-918.369 3198.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3201.1461,-907.7078 3193.4624,-900.4133 3194.9201,-910.9074 3201.1461,-907.7078"/>
+</g>
+<!-- 210&#45;&gt;83 -->
+<g id="edge359" class="edge">
+<title>210-&gt;83</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4095.0369,-719.8314C4083.8285,-710.9632 4070.1791,-700.1637 4058.0561,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4059.9697,-687.6229 4049.9558,-684.1628 4055.6263,-693.1125 4059.9697,-687.6229"/>
+</g>
+<!-- 211&#45;&gt;83 -->
+<g id="edge360" class="edge">
+<title>211-&gt;83</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4015.7851,-719.8314C4017.3894,-712.131 4019.297,-702.9743 4021.0799,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4024.5507,-694.9169 4023.1639,-684.4133 4017.6979,-693.4892 4024.5507,-694.9169"/>
+</g>
+<!-- 212 -->
+<g id="node213" class="node">
+<title>212</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M4089.4971,-972C4089.4971,-972 4054.5029,-972 4054.5029,-972 4048.5029,-972 4042.5029,-966 4042.5029,-960 4042.5029,-960 4042.5029,-948 4042.5029,-948 4042.5029,-942 4048.5029,-936 4054.5029,-936 4054.5029,-936 4089.4971,-936 4089.4971,-936 4095.4971,-936 4101.4971,-942 4101.4971,-948 4101.4971,-948 4101.4971,-960 4101.4971,-960 4101.4971,-966 4095.4971,-972 4089.4971,-972"/>
+<text text-anchor="middle" x="4072" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="4072" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 4B</text>
+</g>
+<!-- 212&#45;&gt;83 -->
+<g id="edge363" class="edge">
+<title>212-&gt;83</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4042.3842,-944.3019C4021.5816,-935.9117 3994.9055,-921.6669 3980,-900 3943.2261,-846.5448 3961.3516,-820.6617 3956,-756 3954.6803,-740.0545 3948.8928,-734.3348 3956,-720 3961.9752,-707.9485 3972.0692,-697.8585 3982.7993,-689.7863"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3984.8776,-692.6039 3991.0709,-684.0077 3980.8687,-686.8655 3984.8776,-692.6039"/>
+</g>
+<!-- 276 -->
+<g id="node277" class="node">
+<title>276</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M4094.8571,-828C4094.8571,-828 3989.1429,-828 3989.1429,-828 3983.1429,-828 3977.1429,-822 3977.1429,-816 3977.1429,-816 3977.1429,-804 3977.1429,-804 3977.1429,-798 3983.1429,-792 3989.1429,-792 3989.1429,-792 4094.8571,-792 4094.8571,-792 4100.8571,-792 4106.8571,-798 4106.8571,-804 4106.8571,-804 4106.8571,-816 4106.8571,-816 4106.8571,-822 4100.8571,-828 4094.8571,-828"/>
+<text text-anchor="middle" x="4042" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 212&#45;&gt;276 -->
+<g id="edge729" class="edge">
+<title>212-&gt;276</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4081.3632,-935.9236C4089.6472,-917.3946 4099.1171,-887.9798 4090,-864 4085.9728,-853.4076 4078.81,-843.5662 4071.2263,-835.2649"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4073.7138,-832.8025 4064.2213,-828.0968 4068.7074,-837.695 4073.7138,-832.8025"/>
+</g>
+<!-- 297 -->
+<g id="node298" class="node">
+<title>297</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M4069.1477,-900C4069.1477,-900 4000.8523,-900 4000.8523,-900 3994.8523,-900 3988.8523,-894 3988.8523,-888 3988.8523,-888 3988.8523,-876 3988.8523,-876 3988.8523,-870 3994.8523,-864 4000.8523,-864 4000.8523,-864 4069.1477,-864 4069.1477,-864 4075.1477,-864 4081.1477,-870 4081.1477,-876 4081.1477,-876 4081.1477,-888 4081.1477,-888 4081.1477,-894 4075.1477,-900 4069.1477,-900"/>
+<text text-anchor="middle" x="4035" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 212&#45;&gt;297 -->
+<g id="edge760" class="edge">
+<title>212-&gt;297</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4062.6633,-935.8314C4058.5757,-927.8771 4053.6896,-918.369 4049.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4052.1461,-907.7078 4044.4624,-900.4133 4045.9201,-910.9074 4052.1461,-907.7078"/>
+</g>
+<!-- 213&#45;&gt;84 -->
+<g id="edge364" class="edge">
+<title>213-&gt;84</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6761.5422,-719.8314C6763.4884,-712.0463 6765.8068,-702.7729 6767.9663,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6771.3668,-694.9636 6770.3967,-684.4133 6764.5758,-693.2658 6771.3668,-694.9636"/>
+</g>
+<!-- 214&#45;&gt;84 -->
+<g id="edge365" class="edge">
+<title>214-&gt;84</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6840.7939,-719.8314C6829.955,-710.9632 6816.7556,-700.1637 6805.0322,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6807.155,-687.7864 6797.199,-684.1628 6802.7223,-693.2041 6807.155,-687.7864"/>
+</g>
+<!-- 215 -->
+<g id="node216" class="node">
+<title>215</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M6827.4971,-972C6827.4971,-972 6792.5029,-972 6792.5029,-972 6786.5029,-972 6780.5029,-966 6780.5029,-960 6780.5029,-960 6780.5029,-948 6780.5029,-948 6780.5029,-942 6786.5029,-936 6792.5029,-936 6792.5029,-936 6827.4971,-936 6827.4971,-936 6833.4971,-936 6839.4971,-942 6839.4971,-948 6839.4971,-948 6839.4971,-960 6839.4971,-960 6839.4971,-966 6833.4971,-972 6827.4971,-972"/>
+<text text-anchor="middle" x="6810" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="6810" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 5B</text>
+</g>
+<!-- 215&#45;&gt;84 -->
+<g id="edge368" class="edge">
+<title>215-&gt;84</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6839.4834,-944.6836C6860.5046,-936.4221 6887.5134,-922.1708 6902,-900 6945.9541,-832.731 6964.7704,-786.0467 6919,-720 6909.6624,-706.5259 6876.1501,-693.5534 6843.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6844.4128,-680.2317 6833.8305,-680.7471 6842.4245,-686.9434 6844.4128,-680.2317"/>
+</g>
+<!-- 277 -->
+<g id="node278" class="node">
+<title>277</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M6882.8571,-828C6882.8571,-828 6777.1429,-828 6777.1429,-828 6771.1429,-828 6765.1429,-822 6765.1429,-816 6765.1429,-816 6765.1429,-804 6765.1429,-804 6765.1429,-798 6771.1429,-792 6777.1429,-792 6777.1429,-792 6882.8571,-792 6882.8571,-792 6888.8571,-792 6894.8571,-798 6894.8571,-804 6894.8571,-804 6894.8571,-816 6894.8571,-816 6894.8571,-822 6888.8571,-828 6882.8571,-828"/>
+<text text-anchor="middle" x="6830" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 215&#45;&gt;277 -->
+<g id="edge731" class="edge">
+<title>215-&gt;277</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6801.0584,-935.7776C6793.26,-917.3858 6784.305,-888.3061 6792,-864 6795.0815,-854.2664 6800.6183,-844.7695 6806.5289,-836.5228"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6809.431,-838.49 6812.7365,-828.4239 6803.8752,-834.2316 6809.431,-838.49"/>
+</g>
+<!-- 298 -->
+<g id="node299" class="node">
+<title>298</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M6881.1477,-900C6881.1477,-900 6812.8523,-900 6812.8523,-900 6806.8523,-900 6800.8523,-894 6800.8523,-888 6800.8523,-888 6800.8523,-876 6800.8523,-876 6800.8523,-870 6806.8523,-864 6812.8523,-864 6812.8523,-864 6881.1477,-864 6881.1477,-864 6887.1477,-864 6893.1477,-870 6893.1477,-876 6893.1477,-876 6893.1477,-888 6893.1477,-888 6893.1477,-894 6887.1477,-900 6881.1477,-900"/>
+<text text-anchor="middle" x="6847" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 215&#45;&gt;298 -->
+<g id="edge761" class="edge">
+<title>215-&gt;298</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6819.3367,-935.8314C6823.4243,-927.8771 6828.3104,-918.369 6832.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6836.0799,-910.9074 6837.5376,-900.4133 6829.8539,-907.7078 6836.0799,-910.9074"/>
+</g>
+<!-- 216&#45;&gt;85 -->
+<g id="edge369" class="edge">
+<title>216-&gt;85</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5084.5422,-719.8314C5086.4884,-712.0463 5088.8068,-702.7729 5090.9663,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5094.3668,-694.9636 5093.3967,-684.4133 5087.5758,-693.2658 5094.3668,-694.9636"/>
+</g>
+<!-- 217&#45;&gt;85 -->
+<g id="edge370" class="edge">
+<title>217-&gt;85</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5163.7939,-719.8314C5152.955,-710.9632 5139.7556,-700.1637 5128.0322,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5130.155,-687.7864 5120.199,-684.1628 5125.7223,-693.2041 5130.155,-687.7864"/>
+</g>
+<!-- 218 -->
+<g id="node219" class="node">
+<title>218</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M5153.4971,-972C5153.4971,-972 5118.5029,-972 5118.5029,-972 5112.5029,-972 5106.5029,-966 5106.5029,-960 5106.5029,-960 5106.5029,-948 5106.5029,-948 5106.5029,-942 5112.5029,-936 5118.5029,-936 5118.5029,-936 5153.4971,-936 5153.4971,-936 5159.4971,-936 5165.4971,-942 5165.4971,-948 5165.4971,-948 5165.4971,-960 5165.4971,-960 5165.4971,-966 5159.4971,-972 5153.4971,-972"/>
+<text text-anchor="middle" x="5136" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="5136" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 6B</text>
+</g>
+<!-- 218&#45;&gt;85 -->
+<g id="edge373" class="edge">
+<title>218-&gt;85</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5165.6173,-944.7701C5186.7068,-936.5528 5213.7425,-922.3188 5228,-900 5271.1975,-832.3783 5287.7052,-785.9526 5242,-720 5232.6624,-706.5259 5199.1501,-693.5534 5166.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5167.4128,-680.2317 5156.8305,-680.7471 5165.4245,-686.9434 5167.4128,-680.2317"/>
+</g>
+<!-- 278 -->
+<g id="node279" class="node">
+<title>278</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M5212.8571,-828C5212.8571,-828 5107.1429,-828 5107.1429,-828 5101.1429,-828 5095.1429,-822 5095.1429,-816 5095.1429,-816 5095.1429,-804 5095.1429,-804 5095.1429,-798 5101.1429,-792 5107.1429,-792 5107.1429,-792 5212.8571,-792 5212.8571,-792 5218.8571,-792 5224.8571,-798 5224.8571,-804 5224.8571,-804 5224.8571,-816 5224.8571,-816 5224.8571,-822 5218.8571,-828 5212.8571,-828"/>
+<text text-anchor="middle" x="5160" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 218&#45;&gt;278 -->
+<g id="edge733" class="edge">
+<title>218-&gt;278</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5126.8141,-935.697C5118.8257,-917.2426 5109.7259,-888.1151 5118,-864 5121.469,-853.8894 5127.6899,-844.2137 5134.299,-835.9166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5137.1265,-837.9949 5140.95,-828.1141 5131.7992,-833.4539 5137.1265,-837.9949"/>
+</g>
+<!-- 299 -->
+<g id="node300" class="node">
+<title>299</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M5207.1477,-900C5207.1477,-900 5138.8523,-900 5138.8523,-900 5132.8523,-900 5126.8523,-894 5126.8523,-888 5126.8523,-888 5126.8523,-876 5126.8523,-876 5126.8523,-870 5132.8523,-864 5138.8523,-864 5138.8523,-864 5207.1477,-864 5207.1477,-864 5213.1477,-864 5219.1477,-870 5219.1477,-876 5219.1477,-876 5219.1477,-888 5219.1477,-888 5219.1477,-894 5213.1477,-900 5207.1477,-900"/>
+<text text-anchor="middle" x="5173" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 218&#45;&gt;299 -->
+<g id="edge762" class="edge">
+<title>218-&gt;299</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5145.3367,-935.8314C5149.4243,-927.8771 5154.3104,-918.369 5158.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5162.0799,-910.9074 5163.5376,-900.4133 5155.8539,-907.7078 5162.0799,-910.9074"/>
+</g>
+<!-- 219&#45;&gt;86 -->
+<g id="edge374" class="edge">
+<title>219-&gt;86</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6423.2798,-719.8314C6411.5906,-710.8779 6397.3312,-699.9558 6384.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6386.7797,-687.4651 6376.7126,-684.1628 6382.5231,-693.0222 6386.7797,-687.4651"/>
+</g>
+<!-- 220&#45;&gt;86 -->
+<g id="edge375" class="edge">
+<title>220-&gt;86</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6344.0281,-719.8314C6345.3115,-712.131 6346.8376,-702.9743 6348.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6351.7394,-694.8526 6349.9311,-684.4133 6344.8347,-693.7018 6351.7394,-694.8526"/>
+</g>
+<!-- 221 -->
+<g id="node222" class="node">
+<title>221</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M6408.4971,-972C6408.4971,-972 6373.5029,-972 6373.5029,-972 6367.5029,-972 6361.5029,-966 6361.5029,-960 6361.5029,-960 6361.5029,-948 6361.5029,-948 6361.5029,-942 6367.5029,-936 6373.5029,-936 6373.5029,-936 6408.4971,-936 6408.4971,-936 6414.4971,-936 6420.4971,-942 6420.4971,-948 6420.4971,-948 6420.4971,-960 6420.4971,-960 6420.4971,-966 6414.4971,-972 6408.4971,-972"/>
+<text text-anchor="middle" x="6391" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="6391" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 7B</text>
+</g>
+<!-- 221&#45;&gt;86 -->
+<g id="edge378" class="edge">
+<title>221-&gt;86</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6420.6173,-944.7701C6441.7068,-936.5528 6468.7425,-922.3188 6483,-900 6526.1975,-832.3783 6542.7052,-785.9526 6497,-720 6487.6624,-706.5259 6454.1501,-693.5534 6421.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6422.4128,-680.2317 6411.8305,-680.7471 6420.4245,-686.9434 6422.4128,-680.2317"/>
+</g>
+<!-- 279 -->
+<g id="node280" class="node">
+<title>279</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M6467.8571,-828C6467.8571,-828 6362.1429,-828 6362.1429,-828 6356.1429,-828 6350.1429,-822 6350.1429,-816 6350.1429,-816 6350.1429,-804 6350.1429,-804 6350.1429,-798 6356.1429,-792 6362.1429,-792 6362.1429,-792 6467.8571,-792 6467.8571,-792 6473.8571,-792 6479.8571,-798 6479.8571,-804 6479.8571,-804 6479.8571,-816 6479.8571,-816 6479.8571,-822 6473.8571,-828 6467.8571,-828"/>
+<text text-anchor="middle" x="6415" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 221&#45;&gt;279 -->
+<g id="edge735" class="edge">
+<title>221-&gt;279</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6381.8141,-935.697C6373.8257,-917.2426 6364.7259,-888.1151 6373,-864 6376.469,-853.8894 6382.6899,-844.2137 6389.299,-835.9166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6392.1265,-837.9949 6395.95,-828.1141 6386.7992,-833.4539 6392.1265,-837.9949"/>
+</g>
+<!-- 300 -->
+<g id="node301" class="node">
+<title>300</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M6462.1477,-900C6462.1477,-900 6393.8523,-900 6393.8523,-900 6387.8523,-900 6381.8523,-894 6381.8523,-888 6381.8523,-888 6381.8523,-876 6381.8523,-876 6381.8523,-870 6387.8523,-864 6393.8523,-864 6393.8523,-864 6462.1477,-864 6462.1477,-864 6468.1477,-864 6474.1477,-870 6474.1477,-876 6474.1477,-876 6474.1477,-888 6474.1477,-888 6474.1477,-894 6468.1477,-900 6462.1477,-900"/>
+<text text-anchor="middle" x="6428" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 221&#45;&gt;300 -->
+<g id="edge763" class="edge">
+<title>221-&gt;300</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6400.3367,-935.8314C6404.4243,-927.8771 6409.3104,-918.369 6413.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6417.0799,-910.9074 6418.5376,-900.4133 6410.8539,-907.7078 6417.0799,-910.9074"/>
+</g>
+<!-- 222&#45;&gt;87 -->
+<g id="edge379" class="edge">
+<title>222-&gt;87</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5495.5422,-719.8314C5497.4884,-712.0463 5499.8068,-702.7729 5501.9663,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5505.3668,-694.9636 5504.3967,-684.4133 5498.5758,-693.2658 5505.3668,-694.9636"/>
+</g>
+<!-- 223&#45;&gt;87 -->
+<g id="edge380" class="edge">
+<title>223-&gt;87</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5574.7939,-719.8314C5563.955,-710.9632 5550.7556,-700.1637 5539.0322,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5541.155,-687.7864 5531.199,-684.1628 5536.7223,-693.2041 5541.155,-687.7864"/>
+</g>
+<!-- 224 -->
+<g id="node225" class="node">
+<title>224</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M5579.545,-972C5579.545,-972 5544.455,-972 5544.455,-972 5538.455,-972 5532.455,-966 5532.455,-960 5532.455,-960 5532.455,-948 5532.455,-948 5532.455,-942 5538.455,-936 5544.455,-936 5544.455,-936 5579.545,-936 5579.545,-936 5585.545,-936 5591.545,-942 5591.545,-948 5591.545,-948 5591.545,-960 5591.545,-960 5591.545,-966 5585.545,-972 5579.545,-972"/>
+<text text-anchor="middle" x="5562" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="5562" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 1D</text>
+</g>
+<!-- 224&#45;&gt;87 -->
+<g id="edge383" class="edge">
+<title>224-&gt;87</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5579.9959,-935.9027C5618.7643,-894.6835 5702.7801,-791.8327 5653,-720 5643.6624,-706.5259 5610.1501,-693.5534 5577.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5578.4128,-680.2317 5567.8305,-680.7471 5576.4245,-686.9434 5578.4128,-680.2317"/>
+</g>
+<!-- 280 -->
+<g id="node281" class="node">
+<title>280</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M5616.8571,-828C5616.8571,-828 5511.1429,-828 5511.1429,-828 5505.1429,-828 5499.1429,-822 5499.1429,-816 5499.1429,-816 5499.1429,-804 5499.1429,-804 5499.1429,-798 5505.1429,-792 5511.1429,-792 5511.1429,-792 5616.8571,-792 5616.8571,-792 5622.8571,-792 5628.8571,-798 5628.8571,-804 5628.8571,-804 5628.8571,-816 5628.8571,-816 5628.8571,-822 5622.8571,-828 5616.8571,-828"/>
+<text text-anchor="middle" x="5564" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 224&#45;&gt;280 -->
+<g id="edge737" class="edge">
+<title>224-&gt;280</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5569.6679,-935.8756C5573.6139,-925.5642 5578.0055,-912.2907 5580,-900 5582.5629,-884.2066 5582.2965,-879.8343 5580,-864 5578.7428,-855.3319 5576.4064,-846.1182 5573.9,-837.802"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5577.2072,-836.6531 5570.8195,-828.2004 5570.5418,-838.7916 5577.2072,-836.6531"/>
+</g>
+<!-- 301 -->
+<g id="node302" class="node">
+<title>301</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M5559.1477,-900C5559.1477,-900 5490.8523,-900 5490.8523,-900 5484.8523,-900 5478.8523,-894 5478.8523,-888 5478.8523,-888 5478.8523,-876 5478.8523,-876 5478.8523,-870 5484.8523,-864 5490.8523,-864 5490.8523,-864 5559.1477,-864 5559.1477,-864 5565.1477,-864 5571.1477,-870 5571.1477,-876 5571.1477,-876 5571.1477,-888 5571.1477,-888 5571.1477,-894 5565.1477,-900 5559.1477,-900"/>
+<text text-anchor="middle" x="5525" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 224&#45;&gt;301 -->
+<g id="edge764" class="edge">
+<title>224-&gt;301</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5552.6633,-935.8314C5548.5757,-927.8771 5543.6896,-918.369 5539.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5542.1461,-907.7078 5534.4624,-900.4133 5535.9201,-910.9074 5542.1461,-907.7078"/>
+</g>
+<!-- 225&#45;&gt;88 -->
+<g id="edge384" class="edge">
+<title>225-&gt;88</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7689.2798,-719.8314C7677.5906,-710.8779 7663.3312,-699.9558 7650.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7652.7797,-687.4651 7642.7126,-684.1628 7648.5231,-693.0222 7652.7797,-687.4651"/>
+</g>
+<!-- 226&#45;&gt;88 -->
+<g id="edge385" class="edge">
+<title>226-&gt;88</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7610.0281,-719.8314C7611.3115,-712.131 7612.8376,-702.9743 7614.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7617.7394,-694.8526 7615.9311,-684.4133 7610.8347,-693.7018 7617.7394,-694.8526"/>
+</g>
+<!-- 227 -->
+<g id="node228" class="node">
+<title>227</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M7674.545,-972C7674.545,-972 7639.455,-972 7639.455,-972 7633.455,-972 7627.455,-966 7627.455,-960 7627.455,-960 7627.455,-948 7627.455,-948 7627.455,-942 7633.455,-936 7639.455,-936 7639.455,-936 7674.545,-936 7674.545,-936 7680.545,-936 7686.545,-942 7686.545,-948 7686.545,-948 7686.545,-960 7686.545,-960 7686.545,-966 7680.545,-972 7674.545,-972"/>
+<text text-anchor="middle" x="7657" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="7657" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 2D</text>
+</g>
+<!-- 227&#45;&gt;88 -->
+<g id="edge388" class="edge">
+<title>227-&gt;88</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7686.6173,-944.7701C7707.7068,-936.5528 7734.7425,-922.3188 7749,-900 7792.1975,-832.3783 7808.7052,-785.9526 7763,-720 7753.6624,-706.5259 7720.1501,-693.5534 7687.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7688.4128,-680.2317 7677.8305,-680.7471 7686.4245,-686.9434 7688.4128,-680.2317"/>
+</g>
+<!-- 281 -->
+<g id="node282" class="node">
+<title>281</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M7733.8571,-828C7733.8571,-828 7628.1429,-828 7628.1429,-828 7622.1429,-828 7616.1429,-822 7616.1429,-816 7616.1429,-816 7616.1429,-804 7616.1429,-804 7616.1429,-798 7622.1429,-792 7628.1429,-792 7628.1429,-792 7733.8571,-792 7733.8571,-792 7739.8571,-792 7745.8571,-798 7745.8571,-804 7745.8571,-804 7745.8571,-816 7745.8571,-816 7745.8571,-822 7739.8571,-828 7733.8571,-828"/>
+<text text-anchor="middle" x="7681" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 227&#45;&gt;281 -->
+<g id="edge739" class="edge">
+<title>227-&gt;281</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7647.8141,-935.697C7639.8257,-917.2426 7630.7259,-888.1151 7639,-864 7642.469,-853.8894 7648.6899,-844.2137 7655.299,-835.9166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7658.1265,-837.9949 7661.95,-828.1141 7652.7992,-833.4539 7658.1265,-837.9949"/>
+</g>
+<!-- 302 -->
+<g id="node303" class="node">
+<title>302</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M7728.1477,-900C7728.1477,-900 7659.8523,-900 7659.8523,-900 7653.8523,-900 7647.8523,-894 7647.8523,-888 7647.8523,-888 7647.8523,-876 7647.8523,-876 7647.8523,-870 7653.8523,-864 7659.8523,-864 7659.8523,-864 7728.1477,-864 7728.1477,-864 7734.1477,-864 7740.1477,-870 7740.1477,-876 7740.1477,-876 7740.1477,-888 7740.1477,-888 7740.1477,-894 7734.1477,-900 7728.1477,-900"/>
+<text text-anchor="middle" x="7694" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 227&#45;&gt;302 -->
+<g id="edge765" class="edge">
+<title>227-&gt;302</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7666.3367,-935.8314C7670.4243,-927.8771 7675.3104,-918.369 7679.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7683.0799,-910.9074 7684.5376,-900.4133 7676.8539,-907.7078 7683.0799,-910.9074"/>
+</g>
+<!-- 228&#45;&gt;89 -->
+<g id="edge389" class="edge">
+<title>228-&gt;89</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6001.2798,-719.8314C5989.5906,-710.8779 5975.3312,-699.9558 5962.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5964.7797,-687.4651 5954.7126,-684.1628 5960.5231,-693.0222 5964.7797,-687.4651"/>
+</g>
+<!-- 229&#45;&gt;89 -->
+<g id="edge390" class="edge">
+<title>229-&gt;89</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5922.0281,-719.8314C5923.3115,-712.131 5924.8376,-702.9743 5926.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5929.7394,-694.8526 5927.9311,-684.4133 5922.8347,-693.7018 5929.7394,-694.8526"/>
+</g>
+<!-- 230 -->
+<g id="node231" class="node">
+<title>230</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M6001.545,-972C6001.545,-972 5966.455,-972 5966.455,-972 5960.455,-972 5954.455,-966 5954.455,-960 5954.455,-960 5954.455,-948 5954.455,-948 5954.455,-942 5960.455,-936 5966.455,-936 5966.455,-936 6001.545,-936 6001.545,-936 6007.545,-936 6013.545,-942 6013.545,-948 6013.545,-948 6013.545,-960 6013.545,-960 6013.545,-966 6007.545,-972 6001.545,-972"/>
+<text text-anchor="middle" x="5984" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="5984" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 3D</text>
+</g>
+<!-- 230&#45;&gt;89 -->
+<g id="edge393" class="edge">
+<title>230-&gt;89</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6001.9959,-935.9027C6040.7643,-894.6835 6124.7801,-791.8327 6075,-720 6065.6624,-706.5259 6032.1501,-693.5534 5999.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6000.4128,-680.2317 5989.8305,-680.7471 5998.4245,-686.9434 6000.4128,-680.2317"/>
+</g>
+<!-- 282 -->
+<g id="node283" class="node">
+<title>282</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M6038.8571,-828C6038.8571,-828 5933.1429,-828 5933.1429,-828 5927.1429,-828 5921.1429,-822 5921.1429,-816 5921.1429,-816 5921.1429,-804 5921.1429,-804 5921.1429,-798 5927.1429,-792 5933.1429,-792 5933.1429,-792 6038.8571,-792 6038.8571,-792 6044.8571,-792 6050.8571,-798 6050.8571,-804 6050.8571,-804 6050.8571,-816 6050.8571,-816 6050.8571,-822 6044.8571,-828 6038.8571,-828"/>
+<text text-anchor="middle" x="5986" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 230&#45;&gt;282 -->
+<g id="edge741" class="edge">
+<title>230-&gt;282</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5991.6679,-935.8756C5995.6139,-925.5642 6000.0055,-912.2907 6002,-900 6004.5629,-884.2066 6004.2965,-879.8343 6002,-864 6000.7428,-855.3319 5998.4064,-846.1182 5995.9,-837.802"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5999.2072,-836.6531 5992.8195,-828.2004 5992.5418,-838.7916 5999.2072,-836.6531"/>
+</g>
+<!-- 303 -->
+<g id="node304" class="node">
+<title>303</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M5981.1477,-900C5981.1477,-900 5912.8523,-900 5912.8523,-900 5906.8523,-900 5900.8523,-894 5900.8523,-888 5900.8523,-888 5900.8523,-876 5900.8523,-876 5900.8523,-870 5906.8523,-864 5912.8523,-864 5912.8523,-864 5981.1477,-864 5981.1477,-864 5987.1477,-864 5993.1477,-870 5993.1477,-876 5993.1477,-876 5993.1477,-888 5993.1477,-888 5993.1477,-894 5987.1477,-900 5981.1477,-900"/>
+<text text-anchor="middle" x="5947" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 230&#45;&gt;303 -->
+<g id="edge766" class="edge">
+<title>230-&gt;303</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5974.6633,-935.8314C5970.5757,-927.8771 5965.6896,-918.369 5961.1691,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5964.1461,-907.7078 5956.4624,-900.4133 5957.9201,-910.9074 5964.1461,-907.7078"/>
+</g>
+<!-- 231&#45;&gt;90 -->
+<g id="edge394" class="edge">
+<title>231-&gt;90</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7183.5422,-719.8314C7185.4884,-712.0463 7187.8068,-702.7729 7189.9663,-694.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7193.3668,-694.9636 7192.3967,-684.4133 7186.5758,-693.2658 7193.3668,-694.9636"/>
+</g>
+<!-- 232&#45;&gt;90 -->
+<g id="edge395" class="edge">
+<title>232-&gt;90</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7262.7939,-719.8314C7251.955,-710.9632 7238.7556,-700.1637 7227.0322,-690.5718"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7229.155,-687.7864 7219.199,-684.1628 7224.7223,-693.2041 7229.155,-687.7864"/>
+</g>
+<!-- 233 -->
+<g id="node234" class="node">
+<title>233</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M7253.545,-972C7253.545,-972 7218.455,-972 7218.455,-972 7212.455,-972 7206.455,-966 7206.455,-960 7206.455,-960 7206.455,-948 7206.455,-948 7206.455,-942 7212.455,-936 7218.455,-936 7218.455,-936 7253.545,-936 7253.545,-936 7259.545,-936 7265.545,-942 7265.545,-948 7265.545,-948 7265.545,-960 7265.545,-960 7265.545,-966 7259.545,-972 7253.545,-972"/>
+<text text-anchor="middle" x="7236" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="7236" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 4D</text>
+</g>
+<!-- 233&#45;&gt;90 -->
+<g id="edge398" class="edge">
+<title>233-&gt;90</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7265.6622,-944.7987C7286.7747,-936.596 7313.8194,-922.3677 7328,-900 7370.9467,-832.2581 7386.6863,-785.9253 7341,-720 7331.6624,-706.5259 7298.1501,-693.5534 7265.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7266.4128,-680.2317 7255.8305,-680.7471 7264.4245,-686.9434 7266.4128,-680.2317"/>
+</g>
+<!-- 283 -->
+<g id="node284" class="node">
+<title>283</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M7311.8571,-828C7311.8571,-828 7206.1429,-828 7206.1429,-828 7200.1429,-828 7194.1429,-822 7194.1429,-816 7194.1429,-816 7194.1429,-804 7194.1429,-804 7194.1429,-798 7200.1429,-792 7206.1429,-792 7206.1429,-792 7311.8571,-792 7311.8571,-792 7317.8571,-792 7323.8571,-798 7323.8571,-804 7323.8571,-804 7323.8571,-816 7323.8571,-816 7323.8571,-822 7317.8571,-828 7311.8571,-828"/>
+<text text-anchor="middle" x="7259" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 233&#45;&gt;283 -->
+<g id="edge743" class="edge">
+<title>233-&gt;283</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7226.8733,-935.7172C7218.9311,-917.2784 7209.8664,-888.1629 7218,-864 7221.3797,-853.9596 7227.4505,-844.3047 7233.9025,-836.0052"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7236.6952,-838.1208 7240.396,-828.1933 7231.3121,-833.6461 7236.6952,-838.1208"/>
+</g>
+<!-- 304 -->
+<g id="node305" class="node">
+<title>304</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M7307.1477,-900C7307.1477,-900 7238.8523,-900 7238.8523,-900 7232.8523,-900 7226.8523,-894 7226.8523,-888 7226.8523,-888 7226.8523,-876 7226.8523,-876 7226.8523,-870 7232.8523,-864 7238.8523,-864 7238.8523,-864 7307.1477,-864 7307.1477,-864 7313.1477,-864 7319.1477,-870 7319.1477,-876 7319.1477,-876 7319.1477,-888 7319.1477,-888 7319.1477,-894 7313.1477,-900 7307.1477,-900"/>
+<text text-anchor="middle" x="7273" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 233&#45;&gt;304 -->
+<g id="edge767" class="edge">
+<title>233-&gt;304</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7245.3367,-935.8314C7249.4243,-927.8771 7254.3104,-918.369 7258.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7262.0799,-910.9074 7263.5376,-900.4133 7255.8539,-907.7078 7262.0799,-910.9074"/>
+</g>
+<!-- 234&#45;&gt;91 -->
+<g id="edge399" class="edge">
+<title>234-&gt;91</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8111.2798,-719.8314C8099.5906,-710.8779 8085.3312,-699.9558 8072.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8074.7797,-687.4651 8064.7126,-684.1628 8070.5231,-693.0222 8074.7797,-687.4651"/>
+</g>
+<!-- 235&#45;&gt;91 -->
+<g id="edge400" class="edge">
+<title>235-&gt;91</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8032.0281,-719.8314C8033.3115,-712.131 8034.8376,-702.9743 8036.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8039.7394,-694.8526 8037.9311,-684.4133 8032.8347,-693.7018 8039.7394,-694.8526"/>
+</g>
+<!-- 236 -->
+<g id="node237" class="node">
+<title>236</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M8093.545,-972C8093.545,-972 8058.455,-972 8058.455,-972 8052.455,-972 8046.455,-966 8046.455,-960 8046.455,-960 8046.455,-948 8046.455,-948 8046.455,-942 8052.455,-936 8058.455,-936 8058.455,-936 8093.545,-936 8093.545,-936 8099.545,-936 8105.545,-942 8105.545,-948 8105.545,-948 8105.545,-960 8105.545,-960 8105.545,-966 8099.545,-972 8093.545,-972"/>
+<text text-anchor="middle" x="8076" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="8076" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 5D</text>
+</g>
+<!-- 236&#45;&gt;91 -->
+<g id="edge403" class="edge">
+<title>236-&gt;91</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8105.9253,-944.5094C8126.8817,-936.2224 8153.6147,-922.0158 8168,-900 8211.9541,-832.731 8230.7704,-786.0467 8185,-720 8175.6624,-706.5259 8142.1501,-693.5534 8109.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8110.4128,-680.2317 8099.8305,-680.7471 8108.4245,-686.9434 8110.4128,-680.2317"/>
+</g>
+<!-- 284 -->
+<g id="node285" class="node">
+<title>284</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M8148.8571,-828C8148.8571,-828 8043.1429,-828 8043.1429,-828 8037.1429,-828 8031.1429,-822 8031.1429,-816 8031.1429,-816 8031.1429,-804 8031.1429,-804 8031.1429,-798 8037.1429,-792 8043.1429,-792 8043.1429,-792 8148.8571,-792 8148.8571,-792 8154.8571,-792 8160.8571,-798 8160.8571,-804 8160.8571,-804 8160.8571,-816 8160.8571,-816 8160.8571,-822 8154.8571,-828 8148.8571,-828"/>
+<text text-anchor="middle" x="8096" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 236&#45;&gt;284 -->
+<g id="edge745" class="edge">
+<title>236-&gt;284</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8067.0584,-935.7776C8059.26,-917.3858 8050.305,-888.3061 8058,-864 8061.0815,-854.2664 8066.6183,-844.7695 8072.5289,-836.5228"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8075.431,-838.49 8078.7365,-828.4239 8069.8752,-834.2316 8075.431,-838.49"/>
+</g>
+<!-- 305 -->
+<g id="node306" class="node">
+<title>305</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M8147.1477,-900C8147.1477,-900 8078.8523,-900 8078.8523,-900 8072.8523,-900 8066.8523,-894 8066.8523,-888 8066.8523,-888 8066.8523,-876 8066.8523,-876 8066.8523,-870 8072.8523,-864 8078.8523,-864 8078.8523,-864 8147.1477,-864 8147.1477,-864 8153.1477,-864 8159.1477,-870 8159.1477,-876 8159.1477,-876 8159.1477,-888 8159.1477,-888 8159.1477,-894 8153.1477,-900 8147.1477,-900"/>
+<text text-anchor="middle" x="8113" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 236&#45;&gt;305 -->
+<g id="edge768" class="edge">
+<title>236-&gt;305</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8085.3367,-935.8314C8089.4243,-927.8771 8094.3104,-918.369 8098.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8102.0799,-910.9074 8103.5376,-900.4133 8095.8539,-907.7078 8102.0799,-910.9074"/>
+</g>
+<!-- 237&#45;&gt;92 -->
+<g id="edge404" class="edge">
+<title>237-&gt;92</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8533.2798,-719.8314C8521.5906,-710.8779 8507.3312,-699.9558 8494.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8496.7797,-687.4651 8486.7126,-684.1628 8492.5231,-693.0222 8496.7797,-687.4651"/>
+</g>
+<!-- 238&#45;&gt;92 -->
+<g id="edge405" class="edge">
+<title>238-&gt;92</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8454.0281,-719.8314C8455.3115,-712.131 8456.8376,-702.9743 8458.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8461.7394,-694.8526 8459.9311,-684.4133 8454.8347,-693.7018 8461.7394,-694.8526"/>
+</g>
+<!-- 239 -->
+<g id="node240" class="node">
+<title>239</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M8519.545,-972C8519.545,-972 8484.455,-972 8484.455,-972 8478.455,-972 8472.455,-966 8472.455,-960 8472.455,-960 8472.455,-948 8472.455,-948 8472.455,-942 8478.455,-936 8484.455,-936 8484.455,-936 8519.545,-936 8519.545,-936 8525.545,-936 8531.545,-942 8531.545,-948 8531.545,-948 8531.545,-960 8531.545,-960 8531.545,-966 8525.545,-972 8519.545,-972"/>
+<text text-anchor="middle" x="8502" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="8502" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 6D</text>
+</g>
+<!-- 239&#45;&gt;92 -->
+<g id="edge408" class="edge">
+<title>239-&gt;92</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8531.6622,-944.7987C8552.7747,-936.596 8579.8194,-922.3677 8594,-900 8636.9467,-832.2581 8652.6863,-785.9253 8607,-720 8597.6624,-706.5259 8564.1501,-693.5534 8531.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8532.4128,-680.2317 8521.8305,-680.7471 8530.4245,-686.9434 8532.4128,-680.2317"/>
+</g>
+<!-- 285 -->
+<g id="node286" class="node">
+<title>285</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M8577.8571,-828C8577.8571,-828 8472.1429,-828 8472.1429,-828 8466.1429,-828 8460.1429,-822 8460.1429,-816 8460.1429,-816 8460.1429,-804 8460.1429,-804 8460.1429,-798 8466.1429,-792 8472.1429,-792 8472.1429,-792 8577.8571,-792 8577.8571,-792 8583.8571,-792 8589.8571,-798 8589.8571,-804 8589.8571,-804 8589.8571,-816 8589.8571,-816 8589.8571,-822 8583.8571,-828 8577.8571,-828"/>
+<text text-anchor="middle" x="8525" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 239&#45;&gt;285 -->
+<g id="edge747" class="edge">
+<title>239-&gt;285</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8492.8733,-935.7172C8484.9311,-917.2784 8475.8664,-888.1629 8484,-864 8487.3797,-853.9596 8493.4505,-844.3047 8499.9025,-836.0052"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8502.6952,-838.1208 8506.396,-828.1933 8497.3121,-833.6461 8502.6952,-838.1208"/>
+</g>
+<!-- 306 -->
+<g id="node307" class="node">
+<title>306</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M8573.1477,-900C8573.1477,-900 8504.8523,-900 8504.8523,-900 8498.8523,-900 8492.8523,-894 8492.8523,-888 8492.8523,-888 8492.8523,-876 8492.8523,-876 8492.8523,-870 8498.8523,-864 8504.8523,-864 8504.8523,-864 8573.1477,-864 8573.1477,-864 8579.1477,-864 8585.1477,-870 8585.1477,-876 8585.1477,-876 8585.1477,-888 8585.1477,-888 8585.1477,-894 8579.1477,-900 8573.1477,-900"/>
+<text text-anchor="middle" x="8539" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 239&#45;&gt;306 -->
+<g id="edge769" class="edge">
+<title>239-&gt;306</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8511.3367,-935.8314C8515.4243,-927.8771 8520.3104,-918.369 8524.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8528.0799,-910.9074 8529.5376,-900.4133 8521.8539,-907.7078 8528.0799,-910.9074"/>
+</g>
+<!-- 240&#45;&gt;93 -->
+<g id="edge409" class="edge">
+<title>240-&gt;93</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8955.2798,-719.8314C8943.5906,-710.8779 8929.3312,-699.9558 8916.7191,-690.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8918.7797,-687.4651 8908.7126,-684.1628 8914.5231,-693.0222 8918.7797,-687.4651"/>
+</g>
+<!-- 241&#45;&gt;93 -->
+<g id="edge410" class="edge">
+<title>241-&gt;93</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8876.0281,-719.8314C8877.3115,-712.131 8878.8376,-702.9743 8880.2639,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8883.7394,-694.8526 8881.9311,-684.4133 8876.8347,-693.7018 8883.7394,-694.8526"/>
+</g>
+<!-- 242 -->
+<g id="node243" class="node">
+<title>242</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" stroke-dasharray="5,2" d="M8940.545,-972C8940.545,-972 8905.455,-972 8905.455,-972 8899.455,-972 8893.455,-966 8893.455,-960 8893.455,-960 8893.455,-948 8893.455,-948 8893.455,-942 8899.455,-936 8905.455,-936 8905.455,-936 8940.545,-936 8940.545,-936 8946.545,-936 8952.545,-942 8952.545,-948 8952.545,-948 8952.545,-960 8952.545,-960 8952.545,-966 8946.545,-972 8940.545,-972"/>
+<text text-anchor="middle" x="8923" y="-957" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+<text text-anchor="middle" x="8923" y="-945" font-family="sans" font-size="10.00" fill="#000000">chrom: 7D</text>
+</g>
+<!-- 242&#45;&gt;93 -->
+<g id="edge413" class="edge">
+<title>242-&gt;93</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8952.6173,-944.7701C8973.7068,-936.5528 9000.7425,-922.3188 9015,-900 9058.1975,-832.3783 9074.7052,-785.9526 9029,-720 9019.6624,-706.5259 8986.1501,-693.5534 8953.8036,-683.7015"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8954.4128,-680.2317 8943.8305,-680.7471 8952.4245,-686.9434 8954.4128,-680.2317"/>
+</g>
+<!-- 286 -->
+<g id="node287" class="node">
+<title>286</title>
+<path fill="none" stroke="#d85656" stroke-width="2" stroke-dasharray="5,2" d="M8999.8571,-828C8999.8571,-828 8894.1429,-828 8894.1429,-828 8888.1429,-828 8882.1429,-822 8882.1429,-816 8882.1429,-816 8882.1429,-804 8882.1429,-804 8882.1429,-798 8888.1429,-792 8894.1429,-792 8894.1429,-792 8999.8571,-792 8999.8571,-792 9005.8571,-792 9011.8571,-798 9011.8571,-804 9011.8571,-804 9011.8571,-816 9011.8571,-816 9011.8571,-822 9005.8571,-828 8999.8571,-828"/>
+<text text-anchor="middle" x="8947" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 242&#45;&gt;286 -->
+<g id="edge749" class="edge">
+<title>242-&gt;286</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8913.8141,-935.697C8905.8257,-917.2426 8896.7259,-888.1151 8905,-864 8908.469,-853.8894 8914.6899,-844.2137 8921.299,-835.9166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8924.1265,-837.9949 8927.95,-828.1141 8918.7992,-833.4539 8924.1265,-837.9949"/>
+</g>
+<!-- 307 -->
+<g id="node308" class="node">
+<title>307</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" stroke-dasharray="5,2" d="M8994.1477,-900C8994.1477,-900 8925.8523,-900 8925.8523,-900 8919.8523,-900 8913.8523,-894 8913.8523,-888 8913.8523,-888 8913.8523,-876 8913.8523,-876 8913.8523,-870 8919.8523,-864 8925.8523,-864 8925.8523,-864 8994.1477,-864 8994.1477,-864 9000.1477,-864 9006.1477,-870 9006.1477,-876 9006.1477,-876 9006.1477,-888 9006.1477,-888 9006.1477,-894 9000.1477,-900 8994.1477,-900"/>
+<text text-anchor="middle" x="8960" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 242&#45;&gt;307 -->
+<g id="edge770" class="edge">
+<title>242-&gt;307</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8932.3367,-935.8314C8936.4243,-927.8771 8941.3104,-918.369 8945.8309,-909.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8949.0799,-910.9074 8950.5376,-900.4133 8942.8539,-907.7078 8949.0799,-910.9074"/>
+</g>
+<!-- 243&#45;&gt;94 -->
+<g id="edge414" class="edge">
+<title>243-&gt;94</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M314.2336,-575.8314C313.485,-568.131 312.5947,-558.9743 311.7627,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="315.2415,-550.0276 310.7902,-540.4133 308.2744,-550.7051 315.2415,-550.0276"/>
+</g>
+<!-- 244&#45;&gt;96 -->
+<g id="edge418" class="edge">
+<title>244-&gt;96</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M737.4953,-575.8314C737.2814,-568.131 737.0271,-558.9743 736.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="740.2879,-550.3122 736.5115,-540.4133 733.2906,-550.5066 740.2879,-550.3122"/>
+</g>
+<!-- 245&#45;&gt;98 -->
+<g id="edge422" class="edge">
+<title>245-&gt;98</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2452.3923,-575.8314C2447.2022,-567.7079 2440.9768,-557.9637 2435.2575,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2438.0974,-546.9559 2429.764,-540.4133 2432.1985,-550.7246 2438.0974,-546.9559"/>
+</g>
+<!-- 246&#45;&gt;100 -->
+<g id="edge426" class="edge">
+<title>246-&gt;100</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3691.4953,-575.8314C3691.2814,-568.131 3691.0271,-558.9743 3690.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3694.2879,-550.3122 3690.5115,-540.4133 3687.2906,-550.5066 3694.2879,-550.3122"/>
+</g>
+<!-- 247&#45;&gt;102 -->
+<g id="edge430" class="edge">
+<title>247-&gt;102</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4497.4953,-575.8314C4497.2814,-568.131 4497.0271,-558.9743 4496.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4500.2879,-550.3122 4496.5115,-540.4133 4493.2906,-550.5066 4500.2879,-550.3122"/>
+</g>
+<!-- 248&#45;&gt;104 -->
+<g id="edge434" class="edge">
+<title>248-&gt;104</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1159.4953,-575.8314C1159.2814,-568.131 1159.0271,-558.9743 1158.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1162.2879,-550.3122 1158.5115,-540.4133 1155.2906,-550.5066 1162.2879,-550.3122"/>
+</g>
+<!-- 249&#45;&gt;106 -->
+<g id="edge438" class="edge">
+<title>249-&gt;106</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2031.9063,-575.8314C2027.4403,-567.7925 2022.0925,-558.1666 2017.1621,-549.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2020.1456,-547.4551 2012.2296,-540.4133 2014.0265,-550.8546 2020.1456,-547.4551"/>
+</g>
+<!-- 250&#45;&gt;108 -->
+<g id="edge442" class="edge">
+<title>250-&gt;108</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2873.3829,-575.8314C2867.6828,-567.6232 2860.8337,-557.7606 2854.5641,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2857.3658,-546.6306 2848.787,-540.4133 2851.6162,-550.6234 2857.3658,-546.6306"/>
+</g>
+<!-- 251&#45;&gt;110 -->
+<g id="edge446" class="edge">
+<title>251-&gt;110</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1581.4953,-575.8314C1581.2814,-568.131 1581.0271,-558.9743 1580.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1584.2879,-550.3122 1580.5115,-540.4133 1577.2906,-550.5066 1584.2879,-550.3122"/>
+</g>
+<!-- 252&#45;&gt;112 -->
+<g id="edge450" class="edge">
+<title>252-&gt;112</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3269.4953,-575.8314C3269.2814,-568.131 3269.0271,-558.9743 3268.7894,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3272.2879,-550.3122 3268.5115,-540.4133 3265.2906,-550.5066 3272.2879,-550.3122"/>
+</g>
+<!-- 253&#45;&gt;114 -->
+<g id="edge454" class="edge">
+<title>253-&gt;114</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4102.6446,-575.8314C4097.5674,-567.7079 4091.4773,-557.9637 4085.8824,-549.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4088.7763,-547.0383 4080.5083,-540.4133 4082.8403,-550.7483 4088.7763,-547.0383"/>
+</g>
+<!-- 254&#45;&gt;116 -->
+<g id="edge458" class="edge">
+<title>254-&gt;116</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6639.6265,-575.8314C6645.846,-567.5386 6653.3322,-557.557 6660.16,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6662.99,-550.5133 6666.19,-540.4133 6657.39,-546.3133 6662.99,-550.5133"/>
+</g>
+<!-- 255&#45;&gt;118 -->
+<g id="edge462" class="edge">
+<title>255-&gt;118</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4920.9444,-575.8314C4931.0691,-567.0485 4943.3777,-556.3712 4954.3548,-546.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4956.8019,-549.3595 4962.0623,-540.1628 4952.2149,-544.0718 4956.8019,-549.3595"/>
+</g>
+<!-- 256&#45;&gt;120 -->
+<g id="edge466" class="edge">
+<title>256-&gt;120</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6217.3741,-575.8314C6223.4162,-567.6232 6230.6763,-557.7606 6237.3221,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6240.3363,-550.5415 6243.4458,-540.4133 6234.6989,-546.3918 6240.3363,-550.5415"/>
+</g>
+<!-- 257&#45;&gt;122 -->
+<g id="edge470" class="edge">
+<title>257-&gt;122</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5372.3648,-575.8314C5377.9509,-567.6232 5384.663,-557.7606 5390.8072,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5393.736,-550.6496 5396.4687,-540.4133 5387.949,-546.7112 5393.736,-550.6496"/>
+</g>
+<!-- 258&#45;&gt;124 -->
+<g id="edge474" class="edge">
+<title>258-&gt;124</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7483.8788,-575.8314C7490.2136,-567.5386 7497.8384,-557.557 7504.7926,-548.4533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7507.6452,-550.4847 7510.9343,-540.4133 7502.0825,-546.2353 7507.6452,-550.4847"/>
+</g>
+<!-- 259&#45;&gt;126 -->
+<g id="edge478" class="edge">
+<title>259-&gt;126</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5795.3741,-575.8314C5801.4162,-567.6232 5808.6763,-557.7606 5815.3221,-548.7323"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5818.3363,-550.5415 5821.4458,-540.4133 5812.6989,-546.3918 5818.3363,-550.5415"/>
+</g>
+<!-- 260&#45;&gt;128 -->
+<g id="edge482" class="edge">
+<title>260-&gt;128</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7062.8882,-575.8314C7069.753,-567.454 7078.0301,-557.3531 7085.5511,-548.1749"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7088.2803,-550.3665 7091.9114,-540.4133 7082.8659,-545.9297 7088.2803,-550.3665"/>
+</g>
+<!-- 261&#45;&gt;130 -->
+<g id="edge486" class="edge">
+<title>261-&gt;130</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7908.4022,-575.8314C7916.0415,-567.3694 7925.2683,-557.1489 7933.6207,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7936.2738,-550.1813 7940.3769,-540.4133 7931.0779,-545.4906 7936.2738,-550.1813"/>
+</g>
+<!-- 262&#45;&gt;132 -->
+<g id="edge490" class="edge">
+<title>262-&gt;132</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8330.4022,-575.8314C8338.0415,-567.3694 8347.2683,-557.1489 8355.6207,-547.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8358.2738,-550.1813 8362.3769,-540.4133 8353.0779,-545.4906 8358.2738,-550.1813"/>
+</g>
+<!-- 263&#45;&gt;134 -->
+<g id="edge494" class="edge">
+<title>263-&gt;134</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8756.6921,-575.8314C8766.6948,-567.0485 8778.855,-556.3712 8789.6999,-546.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8792.1094,-549.3909 8797.3146,-540.1628 8787.4908,-544.1308 8792.1094,-549.3909"/>
+</g>
+<!-- 264 -->
+<g id="node265" class="node">
+<title>264</title>
+<path fill="none" stroke="#d86656" stroke-width="2" d="M4568.6299,-900C4568.6299,-900 4515.3701,-900 4515.3701,-900 4509.3701,-900 4503.3701,-894 4503.3701,-888 4503.3701,-888 4503.3701,-876 4503.3701,-876 4503.3701,-870 4509.3701,-864 4515.3701,-864 4515.3701,-864 4568.6299,-864 4568.6299,-864 4574.6299,-864 4580.6299,-870 4580.6299,-876 4580.6299,-876 4580.6299,-888 4580.6299,-888 4580.6299,-894 4574.6299,-900 4568.6299,-900"/>
+<text text-anchor="middle" x="4542" y="-879" font-family="sans" font-size="10.00" fill="#000000">grepGffFeature</text>
+</g>
+<!-- 264&#45;&gt;157 -->
+<g id="edge519" class="edge">
+<title>264-&gt;157</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2932,-866.1916C4500.1847,-865.3205 4497.0624,-864.5699 4494,-864 4280.8724,-824.3363 808.5439,-838.2644 592,-828 538.9861,-825.4871 478.6345,-820.0437 436.2771,-815.7971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="436.483,-812.3001 426.1809,-814.7734 435.7768,-819.2644 436.483,-812.3001"/>
+</g>
+<!-- 264&#45;&gt;158 -->
+<g id="edge520" class="edge">
+<title>264-&gt;158</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2924,-866.1954C4500.1841,-865.3235 4497.0621,-864.5717 4494,-864 4304.1038,-828.5489 1209.9744,-836.8465 1017,-828 960.0972,-825.3914 895.1383,-819.7845 850.4483,-815.517"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="850.6773,-812.0229 840.3873,-814.5462 850.0049,-818.9906 850.6773,-812.0229"/>
+</g>
+<!-- 264&#45;&gt;159 -->
+<g id="edge521" class="edge">
+<title>264-&gt;159</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2869,-866.2251C4500.1798,-865.3463 4497.0596,-864.5849 4494,-864 4287.2613,-824.4784 2810.1812,-839.2568 2600,-828 2549.1053,-825.2742 2491.2425,-819.957 2450.174,-815.8053"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2450.4131,-812.3116 2440.1092,-814.7772 2449.7017,-819.2753 2450.4131,-812.3116"/>
+</g>
+<!-- 264&#45;&gt;160 -->
+<g id="edge522" class="edge">
+<title>264-&gt;160</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2525,-866.3934C4500.1533,-865.4763 4497.0442,-864.6602 4494,-864 4264.9982,-814.3388 4201.6596,-845.6416 3968,-828 3912.2583,-823.7914 3848.5437,-818.4715 3804.4544,-814.7097"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3804.5052,-811.2014 3794.2433,-813.8364 3803.9086,-818.1759 3804.5052,-811.2014"/>
+</g>
+<!-- 264&#45;&gt;161 -->
+<g id="edge523" class="edge">
+<title>264-&gt;161</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4541.4953,-863.8314C4541.2814,-856.131 4541.0271,-846.9743 4540.7894,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4544.2879,-838.3122 4540.5115,-828.4133 4537.2906,-838.5066 4544.2879,-838.3122"/>
+</g>
+<!-- 264&#45;&gt;162 -->
+<g id="edge524" class="edge">
+<title>264-&gt;162</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2915,-866.2003C4500.1834,-865.3272 4497.0617,-864.5738 4494,-864 4159.7953,-801.3645 1773.6005,-844.9553 1434,-828 1383.0958,-825.4585 1325.2341,-820.1192 1284.1685,-815.9123"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1284.4119,-812.4189 1274.1044,-814.8696 1283.6904,-819.3816 1284.4119,-812.4189"/>
+</g>
+<!-- 264&#45;&gt;163 -->
+<g id="edge525" class="edge">
+<title>264-&gt;163</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2891,-866.2133C4500.1815,-865.3373 4497.0606,-864.5796 4494,-864 4241.6765,-816.2123 2439.481,-840.9738 2183,-828 2129.9943,-825.3188 2069.6416,-819.8978 2027.2818,-815.7022"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2027.4838,-812.205 2017.1849,-814.6916 2026.7866,-819.1702 2027.4838,-812.205"/>
+</g>
+<!-- 264&#45;&gt;164 -->
+<g id="edge526" class="edge">
+<title>264-&gt;164</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2821,-866.2496C4500.1761,-865.3653 4497.0575,-864.5959 4494,-864 4194.2026,-805.5708 3425.1601,-841.0285 3120,-828 3032.6166,-824.2692 2931.2227,-817.8436 2870.416,-813.7639"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2870.4937,-810.2613 2860.2808,-813.0804 2870.0226,-817.2455 2870.4937,-810.2613"/>
+</g>
+<!-- 264&#45;&gt;165 -->
+<g id="edge527" class="edge">
+<title>264-&gt;165</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2907,-866.205C4500.1827,-865.3308 4497.0613,-864.5759 4494,-864 4195.1062,-807.7676 2059.909,-855.3076 1757,-828 1739.8319,-826.4523 1721.2658,-823.7111 1704.4946,-820.8275"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1704.7701,-817.3219 1694.3127,-819.023 1703.5485,-824.2144 1704.7701,-817.3219"/>
+</g>
+<!-- 264&#45;&gt;166 -->
+<g id="edge528" class="edge">
+<title>264-&gt;166</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.2743,-866.2891C4500.1701,-865.3958 4497.054,-864.6136 4494,-864 4286.2229,-822.2569 3752.5128,-841.2727 3541,-828 3489.885,-824.7925 3431.735,-819.533 3390.4565,-815.5254"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3390.6334,-812.0261 3380.34,-814.5356 3389.9516,-818.9929 3390.6334,-812.0261"/>
+</g>
+<!-- 264&#45;&gt;167 -->
+<g id="edge529" class="edge">
+<title>264-&gt;167</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4503.168,-866.7401C4500.088,-865.7441 4497.0064,-864.8153 4494,-864 4404.7666,-839.8021 4298.1568,-824.1374 4235.2087,-816.208"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4235.4671,-812.7133 4225.1122,-814.9555 4234.6052,-819.66 4235.4671,-812.7133"/>
+</g>
+<!-- 264&#45;&gt;168 -->
+<g id="edge530" class="edge">
+<title>264-&gt;168</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.764,-880.7219C4673.5473,-877.6771 4915.7349,-869.8159 5118,-864 5727.2915,-846.4805 5880.4363,-862.5455 6489,-828 6540.5459,-825.074 6599.1883,-819.7549 6640.6869,-815.6549"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6641.25,-819.1162 6650.8533,-814.641 6640.5553,-812.1508 6641.25,-819.1162"/>
+</g>
+<!-- 264&#45;&gt;169 -->
+<g id="edge531" class="edge">
+<title>264-&gt;169</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.9531,-876.1079C4665.6598,-863.2952 4866.781,-832.8735 4963.8034,-818.1978"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4964.3391,-821.6567 4973.7032,-816.7004 4963.2921,-814.7354 4964.3391,-821.6567"/>
+</g>
+<!-- 264&#45;&gt;170 -->
+<g id="edge532" class="edge">
+<title>264-&gt;170</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7469,-880.728C4802.7369,-873.4261 5908.544,-836.8571 6060,-828 6116.8655,-824.6745 6181.8301,-819.1795 6226.5317,-815.134"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6226.9545,-818.6101 6236.5955,-814.2168 6226.319,-811.639 6226.9545,-818.6101"/>
+</g>
+<!-- 264&#45;&gt;171 -->
+<g id="edge533" class="edge">
+<title>264-&gt;171</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.6537,-879.1768C4685.6858,-871.4635 4985.1561,-849.1933 5234,-828 5281.5778,-823.9479 5335.6444,-818.9241 5374.7592,-815.2145"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5375.2479,-818.6839 5384.8718,-814.2531 5374.5854,-811.7153 5375.2479,-818.6839"/>
+</g>
+<!-- 264&#45;&gt;172 -->
+<g id="edge534" class="edge">
+<title>264-&gt;172</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7605,-880.5881C4673.5361,-877.2524 4915.7083,-868.8044 5118,-864 6102.2969,-840.6229 6349.7413,-878.8841 7333,-828 7384.5599,-825.3318 7443.2005,-819.9809 7484.695,-815.8035"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7485.266,-819.2635 7494.8602,-814.769 7484.5573,-812.2995 7485.266,-819.2635"/>
+</g>
+<!-- 264&#45;&gt;173 -->
+<g id="edge535" class="edge">
+<title>264-&gt;173</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.8576,-880.5791C4722.5148,-875.2944 5224.5671,-855.6454 5638,-828 5691.9911,-824.3897 5753.5785,-819.0526 5796.5934,-815.1271"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5796.9289,-818.6111 5806.5672,-814.2118 5796.2892,-811.6404 5796.9289,-818.6111"/>
+</g>
+<!-- 264&#45;&gt;174 -->
+<g id="edge536" class="edge">
+<title>264-&gt;174</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7618,-880.6403C4673.5402,-877.4182 4915.7181,-869.1992 5118,-864 5911.6769,-843.6004 6111.1437,-869.4489 6904,-828 6958.0379,-825.175 7019.6187,-819.7287 7062.6194,-815.5635"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7062.9778,-819.0453 7072.5896,-814.5885 7062.2964,-812.0785 7062.9778,-819.0453"/>
+</g>
+<!-- 264&#45;&gt;175 -->
+<g id="edge537" class="edge">
+<title>264-&gt;175</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7597,-880.5533C4673.5336,-877.142 4915.7022,-868.5414 5118,-864 6289.814,-837.6937 6584.3794,-887.0542 7755,-828 7806.5633,-825.3988 7865.2035,-820.0396 7906.6969,-815.8421"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7907.27,-819.3018 7916.8619,-814.8023 7906.5577,-812.3382 7907.27,-819.3018"/>
+</g>
+<!-- 264&#45;&gt;176 -->
+<g id="edge538" class="edge">
+<title>264-&gt;176</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7591,-880.5285C4673.5319,-877.0631 4915.6981,-868.3537 5118,-864 6474.2248,-834.813 6815.0269,-893.1578 8170,-828 8224.0493,-825.4009 8285.6285,-819.9231 8328.6257,-815.6891"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8328.9909,-819.1701 8338.5951,-814.6969 8328.2976,-812.2045 8328.9909,-819.1701"/>
+</g>
+<!-- 264&#45;&gt;177 -->
+<g id="edge539" class="edge">
+<title>264-&gt;177</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4580.7587,-880.509C4673.5306,-877.0014 4915.695,-868.2067 5118,-864 5891.4297,-847.9176 7826.3221,-865.6974 8599,-828 8650.5676,-825.4841 8709.2072,-820.1144 8750.6994,-815.8913"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8751.2751,-819.3506 8760.8641,-814.8447 8750.5581,-812.3874 8751.2751,-819.3506"/>
+</g>
+<!-- 265&#45;&gt;178 -->
+<g id="edge541" class="edge">
+<title>265-&gt;178</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M231.925,-791.8314C228.3898,-783.8771 224.164,-774.369 220.2544,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="223.4435,-764.1299 216.1837,-756.4133 217.0468,-766.9729 223.4435,-764.1299"/>
+</g>
+<!-- 265&#45;&gt;179 -->
+<g id="edge543" class="edge">
+<title>265-&gt;179</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M258.6733,-791.8314C267.5249,-783.219 278.2486,-772.7851 287.8895,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="290.6061,-765.645 295.3326,-756.1628 285.7246,-760.6279 290.6061,-765.645"/>
+</g>
+<!-- 266 -->
+<g id="node267" class="node">
+<title>266</title>
+<path fill="none" stroke="#568ad8" stroke-width="2" stroke-dasharray="5,2" d="M4454.322,-1044C4454.322,-1044 4423.678,-1044 4423.678,-1044 4417.678,-1044 4411.678,-1038 4411.678,-1032 4411.678,-1032 4411.678,-1020 4411.678,-1020 4411.678,-1014 4417.678,-1008 4423.678,-1008 4423.678,-1008 4454.322,-1008 4454.322,-1008 4460.322,-1008 4466.322,-1014 4466.322,-1020 4466.322,-1020 4466.322,-1032 4466.322,-1032 4466.322,-1038 4460.322,-1044 4454.322,-1044"/>
+<text text-anchor="middle" x="4439" y="-1023" font-family="sans" font-size="10.00" fill="#000000">filterBam</text>
+</g>
+<!-- 266&#45;&gt;182 -->
+<g id="edge544" class="edge">
+<title>266-&gt;182</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.6731,-1025.751C4110.5297,-1022.9868 1406.4582,-997.653 602,-972 484.6912,-968.2592 346.1544,-960.4141 279.5972,-956.4312"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="279.7397,-952.9336 269.5474,-955.8264 279.3191,-959.9209 279.7397,-952.9336"/>
+</g>
+<!-- 266&#45;&gt;185 -->
+<g id="edge549" class="edge">
+<title>266-&gt;185</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.7422,-1025.8192C4176.7288,-1024.2071 2467.9839,-1011.4267 1082,-972 934.0451,-967.7912 758.2878,-959.6857 680.922,-955.9602"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="680.8289,-952.4517 670.6715,-955.4645 680.4907,-959.4436 680.8289,-952.4517"/>
+</g>
+<!-- 266&#45;&gt;188 -->
+<g id="edge554" class="edge">
+<title>266-&gt;188</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.815,-1025.3702C4246.8287,-1021.5091 3362.8333,-1000.2677 2642,-972 2521.1833,-967.2621 2378.3834,-959.8417 2310.1789,-956.1857"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2310.0614,-952.6744 2299.8878,-955.6322 2309.6854,-959.6643 2310.0614,-952.6744"/>
+</g>
+<!-- 266&#45;&gt;191 -->
+<g id="edge559" class="edge">
+<title>266-&gt;191</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.5999,-1023.5216C4293.0363,-1012.7972 3823.8416,-970.3575 3683.109,-957.628"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3683.0653,-954.1098 3672.7907,-956.6946 3682.4347,-961.0813 3683.0653,-954.1098"/>
+</g>
+<!-- 266&#45;&gt;194 -->
+<g id="edge564" class="edge">
+<title>266-&gt;194</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4439,-1007.8314C4439,-1000.131 4439,-990.9743 4439,-982.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4442.5001,-982.4132 4439,-972.4133 4435.5001,-982.4133 4442.5001,-982.4132"/>
+</g>
+<!-- 266&#45;&gt;197 -->
+<g id="edge569" class="edge">
+<title>266-&gt;197</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.5233,-1025.846C4191.3041,-1024.5405 2690.3325,-1014.3147 1472,-972 1359.0694,-968.0777 1225.8458,-960.4107 1160.7866,-956.4693"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1160.7644,-952.9616 1150.57,-955.847 1160.3387,-959.9486 1160.7644,-952.9616"/>
+</g>
+<!-- 266&#45;&gt;200 -->
+<g id="edge574" class="edge">
+<title>266-&gt;200</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.5657,-1025.5491C4225.2205,-1022.4406 3125.801,-1003.3779 2231,-972 2101.4696,-967.4578 1948.0881,-959.792 1876.9394,-956.1049"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1876.8151,-952.5938 1866.6467,-955.5695 1876.4513,-959.5843 1876.8151,-952.5938"/>
+</g>
+<!-- 266&#45;&gt;203 -->
+<g id="edge579" class="edge">
+<title>266-&gt;203</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.7233,-1024.8835C4210.6334,-1016.6524 2959.0328,-965.4215 2719.5753,-955.6199"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2719.3939,-952.1096 2709.2591,-955.1976 2719.1076,-959.1038 2719.3939,-952.1096"/>
+</g>
+<!-- 266&#45;&gt;206 -->
+<g id="edge584" class="edge">
+<title>266-&gt;206</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.6649,-1025.8772C4205.7846,-1024.8622 2877.0827,-1016.7335 1798,-972 1709.1248,-968.3157 1604.9902,-961.0831 1549.5173,-956.9967"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1549.6467,-953.4968 1539.4153,-956.2476 1549.129,-960.4776 1549.6467,-953.4968"/>
+</g>
+<!-- 266&#45;&gt;209 -->
+<g id="edge589" class="edge">
+<title>266-&gt;209</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.563,-1024.3781C4252.397,-1014.9693 3448.2469,-967.4333 3260.3182,-956.3242"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3260.5179,-952.83 3250.3288,-955.7337 3260.1048,-959.8178 3260.5179,-952.83"/>
+</g>
+<!-- 266&#45;&gt;212 -->
+<g id="edge594" class="edge">
+<title>266-&gt;212</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4411.7152,-1020.6471C4347.4591,-1008.041 4186.3983,-976.4433 4111.4755,-961.7445"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4111.981,-958.277 4101.4942,-959.7863 4110.6334,-965.1461 4111.981,-958.277"/>
+</g>
+<!-- 266&#45;&gt;215 -->
+<g id="edge599" class="edge">
+<title>266-&gt;215</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.2105,-1025.4677C4641.2175,-1022.0015 5626.4358,-1001.8443 6429,-972 6553.6266,-967.3656 6701.0869,-959.8082 6770.335,-956.1367"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6770.5677,-959.6293 6780.3676,-955.6029 6770.1957,-952.6392 6770.5677,-959.6293"/>
+</g>
+<!-- 266&#45;&gt;218 -->
+<g id="edge604" class="edge">
+<title>266-&gt;218</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.3232,-1023.1775C4574.0387,-1012.0505 4969.5766,-971.1915 5096.5093,-958.0794"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5096.9779,-961.5497 5106.5653,-957.0406 5096.2585,-954.5867 5096.9779,-961.5497"/>
+</g>
+<!-- 266&#45;&gt;221 -->
+<g id="edge609" class="edge">
+<title>266-&gt;221</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.3741,-1025.2184C4620.1798,-1020.7952 5392.3951,-998.1699 6023,-972 6142.5097,-967.0404 6283.7778,-959.7222 6351.2514,-956.1373"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6351.6326,-959.6221 6361.4322,-955.595 6351.2602,-952.632 6351.6326,-959.6221"/>
+</g>
+<!-- 266&#45;&gt;224 -->
+<g id="edge614" class="edge">
+<title>266-&gt;224</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.2033,-1024.2559C4616.373,-1014.6279 5343.7242,-967.9945 5522.3317,-956.5433"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5522.5877,-960.0342 5532.3433,-955.9014 5522.1398,-953.0485 5522.5877,-960.0342"/>
+</g>
+<!-- 266&#45;&gt;227 -->
+<g id="edge619" class="edge">
+<title>266-&gt;227</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.272,-1025.7721C4680.2934,-1023.9233 6112.2218,-1010.4579 7275,-972 7399.971,-967.8667 7547.8101,-960.0731 7617.2346,-956.2417"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7617.5017,-959.7324 7627.2926,-955.684 7617.1141,-952.7431 7617.5017,-959.7324"/>
+</g>
+<!-- 266&#45;&gt;230 -->
+<g id="edge624" class="edge">
+<title>266-&gt;230</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.4497,-1024.7297C4594.6838,-1018.7942 5147.6036,-993.1892 5601,-972 5726.2293,-966.1475 5874.4879,-959.1642 5944.116,-955.8813"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5944.3796,-959.3729 5954.2037,-955.4057 5944.0499,-952.3807 5944.3796,-959.3729"/>
+</g>
+<!-- 266&#45;&gt;233 -->
+<g id="edge629" class="edge">
+<title>266-&gt;233</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.375,-1025.635C4661.9662,-1022.9753 5867.5861,-1005.7252 6848,-972 6975.2444,-967.6229 7125.8484,-959.9112 7196.1406,-956.1645"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7196.5183,-959.6494 7206.3169,-955.6199 7196.1441,-952.6594 7196.5183,-959.6494"/>
+</g>
+<!-- 266&#45;&gt;236 -->
+<g id="edge634" class="edge">
+<title>266-&gt;236</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.1715,-1025.8689C4696.9618,-1024.6899 6352.8476,-1014.9359 7696,-972 7820.3226,-968.0258 7967.385,-960.1572 8036.444,-956.2751"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8036.6625,-959.7684 8046.4491,-955.7098 8036.2675,-952.7795 8036.6625,-959.7684"/>
+</g>
+<!-- 266&#45;&gt;239 -->
+<g id="edge639" class="edge">
+<title>266-&gt;239</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.4638,-1025.9311C4714.4086,-1025.2406 6592.6564,-1018.5731 8115,-972 8241.9329,-968.1167 8392.1409,-960.1704 8462.2467,-956.2666"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8462.6073,-959.752 8472.396,-955.6984 8462.216,-952.7629 8462.6073,-959.752"/>
+</g>
+<!-- 266&#45;&gt;242 -->
+<g id="edge644" class="edge">
+<title>266-&gt;242</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4466.2483,-1025.7702C4778.1791,-1023.1202 7679.1665,-997.9702 8541,-972 8665.9826,-968.2338 8813.8163,-960.2671 8883.237,-956.3187"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8883.5106,-959.8088 8893.2945,-955.7435 8883.1109,-952.8202 8883.5106,-959.8088"/>
+</g>
+<!-- 267&#45;&gt;183 -->
+<g id="edge546" class="edge">
+<title>267-&gt;183</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M656.9157,-791.8314C652.9385,-783.8771 648.1845,-774.369 643.7861,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="646.8093,-763.7923 639.2066,-756.4133 640.5483,-766.9228 646.8093,-763.7923"/>
+</g>
+<!-- 267&#45;&gt;184 -->
+<g id="edge548" class="edge">
+<title>267-&gt;184</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M683.664,-791.8314C691.9732,-783.2848 702.0264,-772.9443 711.0918,-763.6198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="713.6369,-766.023 718.0982,-756.4133 708.6179,-761.1435 713.6369,-766.023"/>
+</g>
+<!-- 268&#45;&gt;186 -->
+<g id="edge551" class="edge">
+<title>268-&gt;186</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2276.178,-791.8314C2285.3588,-783.1337 2296.5006,-772.5783 2306.4776,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2308.9757,-765.5811 2313.8281,-756.1628 2304.1615,-760.4995 2308.9757,-765.5811"/>
+</g>
+<!-- 268&#45;&gt;187 -->
+<g id="edge553" class="edge">
+<title>268-&gt;187</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2249.4297,-791.8314C2246.1507,-783.9617 2242.238,-774.5712 2238.6055,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2241.7492,-764.2979 2234.6722,-756.4133 2235.2876,-766.9902 2241.7492,-764.2979"/>
+</g>
+<!-- 269&#45;&gt;189 -->
+<g id="edge556" class="edge">
+<title>269-&gt;189</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3635.4397,-791.8314C3645.3205,-783.0485 3657.3324,-772.3712 3668.045,-762.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3670.418,-765.4224 3675.5668,-756.1628 3665.7674,-760.1906 3670.418,-765.4224"/>
+</g>
+<!-- 269&#45;&gt;190 -->
+<g id="edge558" class="edge">
+<title>269-&gt;190</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3608.6914,-791.8314C3605.9883,-784.0463 3602.7684,-774.7729 3599.769,-766.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3602.98,-764.7119 3596.3935,-756.4133 3596.3673,-767.0081 3602.98,-764.7119"/>
+</g>
+<!-- 270&#45;&gt;192 -->
+<g id="edge561" class="edge">
+<title>270-&gt;192</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4417.5422,-791.8314C4419.4884,-784.0463 4421.8068,-774.7729 4423.9663,-766.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4427.3668,-766.9636 4426.3967,-756.4133 4420.5758,-765.2658 4427.3668,-766.9636"/>
+</g>
+<!-- 270&#45;&gt;193 -->
+<g id="edge563" class="edge">
+<title>270-&gt;193</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4444.2904,-791.8314C4460.2977,-782.5368 4479.9586,-771.1208 4497.0494,-761.1971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4498.8292,-764.211 4505.7196,-756.1628 4495.3142,-758.1575 4498.8292,-764.211"/>
+</g>
+<!-- 271&#45;&gt;195 -->
+<g id="edge566" class="edge">
+<title>271-&gt;195</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1110.178,-791.8314C1119.3588,-783.1337 1130.5006,-772.5783 1140.4776,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1142.9757,-765.5811 1147.8281,-756.1628 1138.1615,-760.4995 1142.9757,-765.5811"/>
+</g>
+<!-- 271&#45;&gt;196 -->
+<g id="edge568" class="edge">
+<title>271-&gt;196</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1083.4297,-791.8314C1080.1507,-783.9617 1076.238,-774.5712 1072.6055,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1075.7492,-764.2979 1068.6722,-756.4133 1069.2876,-766.9902 1075.7492,-764.2979"/>
+</g>
+<!-- 272&#45;&gt;198 -->
+<g id="edge571" class="edge">
+<title>272-&gt;198</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1822.925,-791.8314C1819.3898,-783.8771 1815.164,-774.369 1811.2544,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1814.4435,-764.1299 1807.1837,-756.4133 1808.0468,-766.9729 1814.4435,-764.1299"/>
+</g>
+<!-- 272&#45;&gt;199 -->
+<g id="edge573" class="edge">
+<title>272-&gt;199</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1849.6733,-791.8314C1858.5249,-783.219 1869.2486,-772.7851 1878.8895,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1881.6061,-765.645 1886.3326,-756.1628 1876.7246,-760.6279 1881.6061,-765.645"/>
+</g>
+<!-- 273&#45;&gt;201 -->
+<g id="edge576" class="edge">
+<title>273-&gt;201</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2666.1774,-791.8314C2662.7891,-783.9617 2658.7459,-774.5712 2654.9924,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2658.0973,-764.214 2650.9279,-756.4133 2651.6679,-766.9822 2658.0973,-764.214"/>
+</g>
+<!-- 273&#45;&gt;202 -->
+<g id="edge578" class="edge">
+<title>273-&gt;202</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2692.9257,-791.8314C2701.9857,-783.1337 2712.9809,-772.5783 2722.8265,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2725.2904,-765.613 2730.0804,-756.1628 2720.4426,-760.5633 2725.2904,-765.613"/>
+</g>
+<!-- 274&#45;&gt;204 -->
+<g id="edge581" class="edge">
+<title>274-&gt;204</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1528.4397,-791.8314C1538.3205,-783.0485 1550.3324,-772.3712 1561.045,-762.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1563.418,-765.4224 1568.5668,-756.1628 1558.7674,-760.1906 1563.418,-765.4224"/>
+</g>
+<!-- 274&#45;&gt;205 -->
+<g id="edge583" class="edge">
+<title>274-&gt;205</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1501.6914,-791.8314C1498.9883,-784.0463 1495.7684,-774.7729 1492.769,-766.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1495.98,-764.7119 1489.3935,-756.4133 1489.3673,-767.0081 1495.98,-764.7119"/>
+</g>
+<!-- 275&#45;&gt;207 -->
+<g id="edge586" class="edge">
+<title>275-&gt;207</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3185.925,-791.8314C3182.3898,-783.8771 3178.164,-774.369 3174.2544,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3177.4435,-764.1299 3170.1837,-756.4133 3171.0468,-766.9729 3177.4435,-764.1299"/>
+</g>
+<!-- 275&#45;&gt;208 -->
+<g id="edge588" class="edge">
+<title>275-&gt;208</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3212.6733,-791.8314C3221.5249,-783.219 3232.2486,-772.7851 3241.8895,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3244.6061,-765.645 3249.3326,-756.1628 3239.7246,-760.6279 3244.6061,-765.645"/>
+</g>
+<!-- 276&#45;&gt;210 -->
+<g id="edge591" class="edge">
+<title>276-&gt;210</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4061.178,-791.8314C4070.3588,-783.1337 4081.5006,-772.5783 4091.4776,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4093.9757,-765.5811 4098.8281,-756.1628 4089.1615,-760.4995 4093.9757,-765.5811"/>
+</g>
+<!-- 276&#45;&gt;211 -->
+<g id="edge593" class="edge">
+<title>276-&gt;211</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4034.4297,-791.8314C4031.1507,-783.9617 4027.238,-774.5712 4023.6055,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4026.7492,-764.2979 4019.6722,-756.4133 4020.2876,-766.9902 4026.7492,-764.2979"/>
+</g>
+<!-- 277&#45;&gt;213 -->
+<g id="edge596" class="edge">
+<title>277-&gt;213</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6811.579,-791.8314C6802.8471,-783.219 6792.2683,-772.7851 6782.7577,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6784.9925,-760.6931 6775.4151,-756.1628 6780.077,-765.6769 6784.9925,-760.6931"/>
+</g>
+<!-- 277&#45;&gt;214 -->
+<g id="edge598" class="edge">
+<title>277-&gt;214</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6838.3273,-791.8314C6841.973,-783.8771 6846.3309,-774.369 6850.3627,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6853.5757,-766.9622 6854.5606,-756.4133 6847.2123,-764.0456 6853.5757,-766.9622"/>
+</g>
+<!-- 278&#45;&gt;216 -->
+<g id="edge601" class="edge">
+<title>278-&gt;216</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5139.8126,-791.8314C5130.1486,-783.1337 5118.4204,-772.5783 5107.9184,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5109.9553,-760.251 5100.1809,-756.1628 5105.2725,-765.454 5109.9553,-760.251"/>
+</g>
+<!-- 278&#45;&gt;217 -->
+<g id="edge603" class="edge">
+<title>278-&gt;217</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5166.5609,-791.8314C5169.4027,-783.9617 5172.7937,-774.5712 5175.9419,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5179.2462,-767.0076 5179.3508,-756.4133 5172.6623,-764.63 5179.2462,-767.0076"/>
+</g>
+<!-- 279&#45;&gt;219 -->
+<g id="edge606" class="edge">
+<title>279-&gt;219</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6423.075,-791.8314C6426.6102,-783.8771 6430.836,-774.369 6434.7456,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6437.9532,-766.9729 6438.8163,-756.4133 6431.5565,-764.1299 6437.9532,-766.9729"/>
+</g>
+<!-- 279&#45;&gt;220 -->
+<g id="edge608" class="edge">
+<title>279-&gt;220</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6396.3267,-791.8314C6387.4751,-783.219 6376.7514,-772.7851 6367.1105,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6369.2754,-760.6279 6359.6674,-756.1628 6364.3939,-765.645 6369.2754,-760.6279"/>
+</g>
+<!-- 280&#45;&gt;222 -->
+<g id="edge611" class="edge">
+<title>280-&gt;222</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5545.579,-791.8314C5536.8471,-783.219 5526.2683,-772.7851 5516.7577,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5518.9925,-760.6931 5509.4151,-756.1628 5514.077,-765.6769 5518.9925,-760.6931"/>
+</g>
+<!-- 280&#45;&gt;223 -->
+<g id="edge613" class="edge">
+<title>280-&gt;223</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5572.3273,-791.8314C5575.973,-783.8771 5580.3309,-774.369 5584.3627,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5587.5757,-766.9622 5588.5606,-756.4133 5581.2123,-764.0456 5587.5757,-766.9622"/>
+</g>
+<!-- 281&#45;&gt;225 -->
+<g id="edge616" class="edge">
+<title>281-&gt;225</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7689.075,-791.8314C7692.6102,-783.8771 7696.836,-774.369 7700.7456,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7703.9532,-766.9729 7704.8163,-756.4133 7697.5565,-764.1299 7703.9532,-766.9729"/>
+</g>
+<!-- 281&#45;&gt;226 -->
+<g id="edge618" class="edge">
+<title>281-&gt;226</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7662.3267,-791.8314C7653.4751,-783.219 7642.7514,-772.7851 7633.1105,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7635.2754,-760.6279 7625.6674,-756.1628 7630.3939,-765.645 7635.2754,-760.6279"/>
+</g>
+<!-- 282&#45;&gt;228 -->
+<g id="edge621" class="edge">
+<title>282-&gt;228</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5995.8413,-791.8314C6000.1957,-783.7925 6005.4098,-774.1666 6010.2169,-765.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6013.3408,-766.8732 6015.0261,-756.4133 6007.1857,-763.5392 6013.3408,-766.8732"/>
+</g>
+<!-- 282&#45;&gt;229 -->
+<g id="edge623" class="edge">
+<title>282-&gt;229</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5969.0931,-791.8314C5961.2187,-783.3694 5951.708,-773.1489 5943.0987,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5945.5092,-761.3497 5936.1346,-756.4133 5940.3847,-766.1183 5945.5092,-761.3497"/>
+</g>
+<!-- 283&#45;&gt;231 -->
+<g id="edge626" class="edge">
+<title>283-&gt;231</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7238.8126,-791.8314C7229.1486,-783.1337 7217.4204,-772.5783 7206.9184,-763.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7208.9553,-760.251 7199.1809,-756.1628 7204.2725,-765.454 7208.9553,-760.251"/>
+</g>
+<!-- 283&#45;&gt;232 -->
+<g id="edge628" class="edge">
+<title>283-&gt;232</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7265.5609,-791.8314C7268.4027,-783.9617 7271.7937,-774.5712 7274.9419,-765.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7278.2462,-767.0076 7278.3508,-756.4133 7271.6623,-764.63 7278.2462,-767.0076"/>
+</g>
+<!-- 284&#45;&gt;234 -->
+<g id="edge631" class="edge">
+<title>284-&gt;234</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8105.8413,-791.8314C8110.1957,-783.7925 8115.4098,-774.1666 8120.2169,-765.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8123.3408,-766.8732 8125.0261,-756.4133 8117.1857,-763.5392 8123.3408,-766.8732"/>
+</g>
+<!-- 284&#45;&gt;235 -->
+<g id="edge633" class="edge">
+<title>284-&gt;235</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8079.0931,-791.8314C8071.2187,-783.3694 8061.708,-773.1489 8053.0987,-763.8971"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8055.5092,-761.3497 8046.1346,-756.4133 8050.3847,-766.1183 8055.5092,-761.3497"/>
+</g>
+<!-- 285&#45;&gt;237 -->
+<g id="edge636" class="edge">
+<title>285-&gt;237</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8533.075,-791.8314C8536.6102,-783.8771 8540.836,-774.369 8544.7456,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8547.9532,-766.9729 8548.8163,-756.4133 8541.5565,-764.1299 8547.9532,-766.9729"/>
+</g>
+<!-- 285&#45;&gt;238 -->
+<g id="edge638" class="edge">
+<title>285-&gt;238</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8506.3267,-791.8314C8497.4751,-783.219 8486.7514,-772.7851 8477.1105,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8479.2754,-760.6279 8469.6674,-756.1628 8474.3939,-765.645 8479.2754,-760.6279"/>
+</g>
+<!-- 286&#45;&gt;240 -->
+<g id="edge641" class="edge">
+<title>286-&gt;240</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8955.075,-791.8314C8958.6102,-783.8771 8962.836,-774.369 8966.7456,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8969.9532,-766.9729 8970.8163,-756.4133 8963.5565,-764.1299 8969.9532,-766.9729"/>
+</g>
+<!-- 286&#45;&gt;241 -->
+<g id="edge643" class="edge">
+<title>286-&gt;241</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8928.3267,-791.8314C8919.4751,-783.219 8908.7514,-772.7851 8899.1105,-763.4048"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8901.2754,-760.6279 8891.6674,-756.1628 8896.3939,-765.645 8901.2754,-760.6279"/>
+</g>
+<!-- 287&#45;&gt;265 -->
+<g id="edge708" class="edge">
+<title>287-&gt;265</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M267.6633,-863.8314C263.5757,-855.8771 258.6896,-846.369 254.1691,-837.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="257.1461,-835.7078 249.4624,-828.4133 250.9201,-838.9074 257.1461,-835.7078"/>
+</g>
+<!-- 288&#45;&gt;267 -->
+<g id="edge710" class="edge">
+<title>288-&gt;267</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M674.9719,-863.8314C673.6885,-856.131 672.1624,-846.9743 670.7361,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="674.1653,-837.7018 669.0689,-828.4133 667.2606,-838.8526 674.1653,-837.7018"/>
+</g>
+<!-- 289&#45;&gt;268 -->
+<g id="edge712" class="edge">
+<title>289-&gt;268</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2239.0562,-863.8314C2241.6512,-856.0463 2244.7424,-846.7729 2247.6218,-838.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2251.0203,-839.0069 2250.8622,-828.4133 2244.3795,-836.7933 2251.0203,-839.0069"/>
+</g>
+<!-- 290&#45;&gt;269 -->
+<g id="edge714" class="edge">
+<title>290-&gt;269</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3608.2711,-863.8314C3609.2336,-856.131 3610.3782,-846.9743 3611.4479,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3614.9309,-838.7702 3612.6983,-828.4133 3607.9849,-837.9019 3614.9309,-838.7702"/>
+</g>
+<!-- 291&#45;&gt;270 -->
+<g id="edge716" class="edge">
+<title>291-&gt;270</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4432.4391,-863.8314C4429.5973,-855.9617 4426.2063,-846.5712 4423.0581,-837.8533"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4426.3377,-836.63 4419.6492,-828.4133 4419.7538,-839.0076 4426.3377,-836.63"/>
+</g>
+<!-- 292&#45;&gt;271 -->
+<g id="edge718" class="edge">
+<title>292-&gt;271</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1085.7664,-863.8314C1086.515,-856.131 1087.4053,-846.9743 1088.2373,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1091.7256,-838.7051 1089.2098,-828.4133 1084.7585,-838.0276 1091.7256,-838.7051"/>
+</g>
+<!-- 293&#45;&gt;272 -->
+<g id="edge720" class="edge">
+<title>293-&gt;272</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1863.1493,-863.8314C1858.2977,-855.7079 1852.4783,-845.9637 1847.132,-837.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1850.1292,-835.2041 1841.9968,-828.4133 1844.1194,-838.7933 1850.1292,-835.2041"/>
+</g>
+<!-- 294&#45;&gt;273 -->
+<g id="edge722" class="edge">
+<title>294-&gt;273</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M2706.1493,-863.8314C2701.2977,-855.7079 2695.4783,-845.9637 2690.132,-837.0118"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="2693.1292,-835.2041 2684.9968,-828.4133 2687.1194,-838.7933 2693.1292,-835.2041"/>
+</g>
+<!-- 295&#45;&gt;274 -->
+<g id="edge724" class="edge">
+<title>295-&gt;274</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M1537.1587,-863.8314C1532.8043,-855.7925 1527.5902,-846.1666 1522.7831,-837.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="1525.8143,-835.5392 1517.9739,-828.4133 1519.6592,-838.8732 1525.8143,-835.5392"/>
+</g>
+<!-- 296&#45;&gt;275 -->
+<g id="edge726" class="edge">
+<title>296-&gt;275</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M3186.5234,-863.8314C3187.5929,-856.131 3188.8647,-846.9743 3190.0532,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="3193.5336,-838.7997 3191.4426,-828.4133 3186.6001,-837.8367 3193.5336,-838.7997"/>
+</g>
+<!-- 297&#45;&gt;276 -->
+<g id="edge728" class="edge">
+<title>297-&gt;276</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M4036.7664,-863.8314C4037.515,-856.131 4038.4053,-846.9743 4039.2373,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="4042.7256,-838.7051 4040.2098,-828.4133 4035.7585,-838.0276 4042.7256,-838.7051"/>
+</g>
+<!-- 298&#45;&gt;277 -->
+<g id="edge730" class="edge">
+<title>298-&gt;277</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6842.7102,-863.8314C6840.892,-856.131 6838.7301,-846.9743 6836.7095,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6840.0519,-837.3414 6834.3476,-828.4133 6833.2392,-838.95 6840.0519,-837.3414"/>
+</g>
+<!-- 299&#45;&gt;278 -->
+<g id="edge732" class="edge">
+<title>299-&gt;278</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5169.7196,-863.8314C5168.3292,-856.131 5166.6759,-846.9743 5165.1308,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5168.5458,-837.6322 5163.3246,-828.4133 5161.6572,-838.8761 5168.5458,-837.6322"/>
+</g>
+<!-- 300&#45;&gt;279 -->
+<g id="edge734" class="edge">
+<title>300-&gt;279</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M6424.7196,-863.8314C6423.3292,-856.131 6421.6759,-846.9743 6420.1308,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="6423.5458,-837.6322 6418.3246,-828.4133 6416.6572,-838.8761 6423.5458,-837.6322"/>
+</g>
+<!-- 301&#45;&gt;280 -->
+<g id="edge736" class="edge">
+<title>301-&gt;280</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5534.8413,-863.8314C5539.1957,-855.7925 5544.4098,-846.1666 5549.2169,-837.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5552.3408,-838.8732 5554.0261,-828.4133 5546.1857,-835.5392 5552.3408,-838.8732"/>
+</g>
+<!-- 302&#45;&gt;281 -->
+<g id="edge738" class="edge">
+<title>302-&gt;281</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7690.7196,-863.8314C7689.3292,-856.131 7687.6759,-846.9743 7686.1308,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7689.5458,-837.6322 7684.3246,-828.4133 7682.6572,-838.8761 7689.5458,-837.6322"/>
+</g>
+<!-- 303&#45;&gt;282 -->
+<g id="edge740" class="edge">
+<title>303-&gt;282</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M5956.8413,-863.8314C5961.1957,-855.7925 5966.4098,-846.1666 5971.2169,-837.2918"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="5974.3408,-838.8732 5976.0261,-828.4133 5968.1857,-835.5392 5974.3408,-838.8732"/>
+</g>
+<!-- 304&#45;&gt;283 -->
+<g id="edge742" class="edge">
+<title>304-&gt;283</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M7269.4672,-863.8314C7267.9699,-856.131 7266.1895,-846.9743 7264.5255,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="7267.9248,-837.5614 7262.5804,-828.4133 7261.0535,-838.8975 7267.9248,-837.5614"/>
+</g>
+<!-- 305&#45;&gt;284 -->
+<g id="edge744" class="edge">
+<title>305-&gt;284</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8108.7102,-863.8314C8106.892,-856.131 8104.7301,-846.9743 8102.7095,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8106.0519,-837.3414 8100.3476,-828.4133 8099.2392,-838.95 8106.0519,-837.3414"/>
+</g>
+<!-- 306&#45;&gt;285 -->
+<g id="edge746" class="edge">
+<title>306-&gt;285</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8535.4672,-863.8314C8533.9699,-856.131 8532.1895,-846.9743 8530.5255,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8533.9248,-837.5614 8528.5804,-828.4133 8527.0535,-838.8975 8533.9248,-837.5614"/>
+</g>
+<!-- 307&#45;&gt;286 -->
+<g id="edge748" class="edge">
+<title>307-&gt;286</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M8956.7196,-863.8314C8955.3292,-856.131 8953.6759,-846.9743 8952.1308,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="8955.5458,-837.6322 8950.3246,-828.4133 8948.6572,-838.8761 8955.5458,-837.6322"/>
+</g>
+</g>
+</svg>
\ No newline at end of file
diff --git a/report/rulegraph.dot b/report/rulegraph.dot
new file mode 100644
index 0000000..b9a1c91
--- /dev/null
+++ b/report/rulegraph.dot
@@ -0,0 +1,83 @@
+digraph snakemake_dag {
+    graph[bgcolor=white, margin=0];
+    node[shape=box, style=rounded, fontname=sans,                 fontsize=10, penwidth=2];
+    edge[penwidth=2, color=grey];
+	0[label = "all", color = "0.21 0.6 0.85", style="rounded"];
+	1[label = "renameGeneIds", color = "0.60 0.6 0.85", style="rounded"];
+	2[label = "concatAllChromResults", color = "0.16 0.6 0.85", style="rounded"];
+	3[label = "generateFastaSequencesHC", color = "0.44 0.6 0.85", style="rounded"];
+	4[label = "validateCdsHC", color = "0.37 0.6 0.85", style="rounded"];
+	5[label = "generateFastaSequencesLC", color = "0.34 0.6 0.85", style="rounded"];
+	6[label = "validateCdsLC", color = "0.23 0.6 0.85", style="rounded"];
+	7[label = "concatAnchoringSummary", color = "0.39 0.6 0.85", style="rounded"];
+	8[label = "concatblatSummary", color = "0.53 0.6 0.85", style="rounded"];
+	9[label = "createDiagrams", color = "0.18 0.6 0.85", style="rounded"];
+	10[label = "mergeFinalGff3", color = "0.46 0.6 0.85", style="rounded"];
+	11[label = "saveGmapWG", color = "0.48 0.6 0.85", style="rounded"];
+	12[label = "checkMissing", color = "0.25 0.6 0.85", style="rounded"];
+	13[label = "mapHomologousRegions", color = "0.30 0.6 0.85", style="rounded"];
+	14[label = "gtCleanBlatGff", color = "0.11 0.6 0.85", style="rounded"];
+	15[label = "recalcGmapRescue", color = "0.05 0.6 0.85", style="rounded"];
+	16[label = "gmapRescue", color = "0.32 0.6 0.85", style="rounded"];
+	17[label = "splitGffPerChrom", color = "0.07 0.6 0.85", style="rounded"];
+	18[label = "upstreamClosest", color = "0.62 0.6 0.85", style="rounded"];
+	19[label = "downstreamClosest", color = "0.28 0.6 0.85", style="rounded"];
+	20[label = "indexQuery", color = "0.14 0.6 0.85", style="rounded"];
+	21[label = "indexTarget", color = "0.02 0.6 0.85", style="rounded"];
+	22[label = "bam2bed", color = "0.41 0.6 0.85", style="rounded"];
+	23[label = "recalcBlatMapped", color = "0.55 0.6 0.85", style="rounded"];
+	24[label = "grepGffFeature", color = "0.64 0.6 0.85", style="rounded"];
+	25[label = "keepMappedOnSameChrom", color = "0.00 0.6 0.85", style="rounded"];
+	26[label = "filterBam", color = "0.51 0.6 0.85", style="rounded"];
+	27[label = "selectMappedISBP", color = "0.57 0.6 0.85", style="rounded"];
+	7 -> 0
+	8 -> 0
+	1 -> 0
+	2 -> 0
+	3 -> 0
+	5 -> 0
+	9 -> 0
+	4 -> 0
+	6 -> 0
+	2 -> 1
+	11 -> 2
+	10 -> 2
+	12 -> 2
+	13 -> 2
+	1 -> 3
+	3 -> 4
+	1 -> 5
+	5 -> 6
+	13 -> 7
+	13 -> 8
+	11 -> 10
+	15 -> 10
+	14 -> 10
+	13 -> 10
+	16 -> 11
+	13 -> 11
+	10 -> 12
+	17 -> 12
+	21 -> 13
+	22 -> 13
+	19 -> 13
+	20 -> 13
+	18 -> 13
+	23 -> 14
+	13 -> 14
+	16 -> 15
+	13 -> 15
+	13 -> 16
+	24 -> 17
+	25 -> 18
+	17 -> 18
+	25 -> 19
+	17 -> 19
+	26 -> 22
+	21 -> 23
+	13 -> 23
+	20 -> 23
+	27 -> 25
+	22 -> 25
+	22 -> 27
+}            
diff --git a/report/rulegraph.svg b/report/rulegraph.svg
new file mode 100644
index 0000000..d077f20
--- /dev/null
+++ b/report/rulegraph.svg
@@ -0,0 +1,479 @@
+<?xml version="1.0" encoding="UTF-8" standalone="no"?>
+<!DOCTYPE svg PUBLIC "-//W3C//DTD SVG 1.1//EN" "http://www.w3.org/Graphics/SVG/1.1/DTD/svg11.dtd">
+<!-- Generated by graphviz version 2.40.1 (20161225.0304)
+ -->
+<!-- Title: snakemake_dag Pages: 1 -->
+<svg width="630pt" height="1052pt" viewBox="0.00 0.00 629.71 1052.00" xmlns="http://www.w3.org/2000/svg" xmlns:xlink="http://www.w3.org/1999/xlink">
+<g id="graph0" class="graph" transform="scale(1 1) rotate(0) translate(4 1048)">
+<title>snakemake_dag</title>
+<polygon fill="#ffffff" stroke="transparent" points="-4,4 -4,-1048 625.7059,-1048 625.7059,4 -4,4"/>
+<!-- 0 -->
+<g id="node1" class="node">
+<title>0</title>
+<path fill="none" stroke="#b6d856" stroke-width="2" d="M388.3374,-36C388.3374,-36 358.3374,-36 358.3374,-36 352.3374,-36 346.3374,-30 346.3374,-24 346.3374,-24 346.3374,-12 346.3374,-12 346.3374,-6 352.3374,0 358.3374,0 358.3374,0 388.3374,0 388.3374,0 394.3374,0 400.3374,-6 400.3374,-12 400.3374,-12 400.3374,-24 400.3374,-24 400.3374,-30 394.3374,-36 388.3374,-36"/>
+<text text-anchor="middle" x="373.3374" y="-15" font-family="sans" font-size="10.00" fill="#000000">all</text>
+</g>
+<!-- 1 -->
+<g id="node2" class="node">
+<title>1</title>
+<path fill="none" stroke="#568ad8" stroke-width="2" d="M267.5778,-252C267.5778,-252 213.0969,-252 213.0969,-252 207.0969,-252 201.0969,-246 201.0969,-240 201.0969,-240 201.0969,-228 201.0969,-228 201.0969,-222 207.0969,-216 213.0969,-216 213.0969,-216 267.5778,-216 267.5778,-216 273.5778,-216 279.5778,-222 279.5778,-228 279.5778,-228 279.5778,-240 279.5778,-240 279.5778,-246 273.5778,-252 267.5778,-252"/>
+<text text-anchor="middle" x="240.3374" y="-231" font-family="sans" font-size="10.00" fill="#000000">renameGeneIds</text>
+</g>
+<!-- 1&#45;&gt;0 -->
+<g id="edge3" class="edge">
+<title>1-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M203.5355,-215.8574C189.8777,-207.0627 175.8841,-195.0935 168.3374,-180 146.3475,-136.0202 157.0196,-106.2116 192.3374,-72 212.8662,-52.1141 289.3598,-34.2723 336.0844,-24.9111"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="337.0004,-28.2981 346.1378,-22.9354 335.6506,-21.4294 337.0004,-28.2981"/>
+</g>
+<!-- 3 -->
+<g id="node4" class="node">
+<title>3</title>
+<path fill="none" stroke="#56d8a9" stroke-width="2" d="M292.8984,-180C292.8984,-180 189.7763,-180 189.7763,-180 183.7763,-180 177.7763,-174 177.7763,-168 177.7763,-168 177.7763,-156 177.7763,-156 177.7763,-150 183.7763,-144 189.7763,-144 189.7763,-144 292.8984,-144 292.8984,-144 298.8984,-144 304.8984,-150 304.8984,-156 304.8984,-156 304.8984,-168 304.8984,-168 304.8984,-174 298.8984,-180 292.8984,-180"/>
+<text text-anchor="middle" x="241.3374" y="-159" font-family="sans" font-size="10.00" fill="#000000">generateFastaSequencesHC</text>
+</g>
+<!-- 1&#45;&gt;3 -->
+<g id="edge15" class="edge">
+<title>1-&gt;3</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M240.5897,-215.8314C240.6967,-208.131 240.8238,-198.9743 240.9427,-190.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="244.4423,-190.4609 241.0816,-180.4133 237.443,-190.3637 244.4423,-190.4609"/>
+</g>
+<!-- 5 -->
+<g id="node6" class="node">
+<title>5</title>
+<path fill="none" stroke="#56d85b" stroke-width="2" d="M437.2884,-180C437.2884,-180 335.3864,-180 335.3864,-180 329.3864,-180 323.3864,-174 323.3864,-168 323.3864,-168 323.3864,-156 323.3864,-156 323.3864,-150 329.3864,-144 335.3864,-144 335.3864,-144 437.2884,-144 437.2884,-144 443.2884,-144 449.2884,-150 449.2884,-156 449.2884,-156 449.2884,-168 449.2884,-168 449.2884,-174 443.2884,-180 437.2884,-180"/>
+<text text-anchor="middle" x="386.3374" y="-159" font-family="sans" font-size="10.00" fill="#000000">generateFastaSequencesLC</text>
+</g>
+<!-- 1&#45;&gt;5 -->
+<g id="edge17" class="edge">
+<title>1-&gt;5</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M277.1793,-215.8314C296.4456,-206.3302 320.2073,-194.6121 340.6365,-184.5374"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="342.3396,-187.6 349.7603,-180.038 339.2436,-181.3219 342.3396,-187.6"/>
+</g>
+<!-- 2 -->
+<g id="node3" class="node">
+<title>2</title>
+<path fill="none" stroke="#d8d356" stroke-width="2" d="M282.4314,-324C282.4314,-324 194.2433,-324 194.2433,-324 188.2433,-324 182.2433,-318 182.2433,-312 182.2433,-312 182.2433,-300 182.2433,-300 182.2433,-294 188.2433,-288 194.2433,-288 194.2433,-288 282.4314,-288 282.4314,-288 288.4314,-288 294.4314,-294 294.4314,-300 294.4314,-300 294.4314,-312 294.4314,-312 294.4314,-318 288.4314,-324 282.4314,-324"/>
+<text text-anchor="middle" x="238.3374" y="-303" font-family="sans" font-size="10.00" fill="#000000">concatAllChromResults</text>
+</g>
+<!-- 2&#45;&gt;0 -->
+<g id="edge4" class="edge">
+<title>2-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M221.1471,-287.7808C212.0349,-277.6582 200.9726,-264.5952 192.3374,-252 146.391,-184.9836 107.3908,-133.6355 160.3374,-72 182.9902,-45.6297 281.3462,-29.4375 336.1334,-22.2967"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="336.6702,-25.7568 346.1515,-21.0286 335.7911,-18.8122 336.6702,-25.7568"/>
+</g>
+<!-- 2&#45;&gt;1 -->
+<g id="edge10" class="edge">
+<title>2-&gt;1</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M238.842,-287.8314C239.0559,-280.131 239.3103,-270.9743 239.548,-262.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="243.0468,-262.5066 239.8259,-252.4133 236.0495,-262.3122 243.0468,-262.5066"/>
+</g>
+<!-- 3&#45;&gt;0 -->
+<g id="edge5" class="edge">
+<title>3-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M258.0553,-143.7623C281.264,-118.4436 323.3624,-72.5182 349.756,-43.7251"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="352.578,-45.8262 356.7552,-36.0896 347.4179,-41.0961 352.578,-45.8262"/>
+</g>
+<!-- 4 -->
+<g id="node5" class="node">
+<title>4</title>
+<path fill="none" stroke="#56d873" stroke-width="2" d="M266.9374,-108C266.9374,-108 213.7373,-108 213.7373,-108 207.7373,-108 201.7373,-102 201.7373,-96 201.7373,-96 201.7373,-84 201.7373,-84 201.7373,-78 207.7373,-72 213.7373,-72 213.7373,-72 266.9374,-72 266.9374,-72 272.9374,-72 278.9374,-78 278.9374,-84 278.9374,-84 278.9374,-96 278.9374,-96 278.9374,-102 272.9374,-108 266.9374,-108"/>
+<text text-anchor="middle" x="240.3374" y="-87" font-family="sans" font-size="10.00" fill="#000000">validateCdsHC</text>
+</g>
+<!-- 3&#45;&gt;4 -->
+<g id="edge16" class="edge">
+<title>3-&gt;4</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M241.085,-143.8314C240.9781,-136.131 240.8509,-126.9743 240.732,-118.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="244.2317,-118.3637 240.5931,-108.4133 237.2324,-118.4609 244.2317,-118.3637"/>
+</g>
+<!-- 4&#45;&gt;0 -->
+<g id="edge8" class="edge">
+<title>4-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M273.8989,-71.8314C293.1643,-61.402 317.3641,-48.3013 337.0666,-37.6353"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="338.9238,-40.6099 346.0516,-32.7712 335.5913,-34.454 338.9238,-40.6099"/>
+</g>
+<!-- 5&#45;&gt;0 -->
+<g id="edge6" class="edge">
+<title>5-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M401.4514,-143.7768C408.6922,-133.8586 416.5897,-120.9858 420.3374,-108 424.7738,-92.6274 425.9453,-86.985 420.3374,-72 416.442,-61.5911 409.5333,-51.8652 402.1917,-43.6152"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="404.5388,-41.0048 395.1045,-36.1835 399.473,-45.8358 404.5388,-41.0048"/>
+</g>
+<!-- 6 -->
+<g id="node7" class="node">
+<title>6</title>
+<path fill="none" stroke="#a7d856" stroke-width="2" d="M399.3274,-108C399.3274,-108 347.3474,-108 347.3474,-108 341.3474,-108 335.3474,-102 335.3474,-96 335.3474,-96 335.3474,-84 335.3474,-84 335.3474,-78 341.3474,-72 347.3474,-72 347.3474,-72 399.3274,-72 399.3274,-72 405.3274,-72 411.3274,-78 411.3274,-84 411.3274,-84 411.3274,-96 411.3274,-96 411.3274,-102 405.3274,-108 399.3274,-108"/>
+<text text-anchor="middle" x="373.3374" y="-87" font-family="sans" font-size="10.00" fill="#000000">validateCdsLC</text>
+</g>
+<!-- 5&#45;&gt;6 -->
+<g id="edge18" class="edge">
+<title>5-&gt;6</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M383.0569,-143.8314C381.6666,-136.131 380.0133,-126.9743 378.4681,-118.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="381.8832,-117.6322 376.662,-108.4133 374.9946,-118.8761 381.8832,-117.6322"/>
+</g>
+<!-- 6&#45;&gt;0 -->
+<g id="edge9" class="edge">
+<title>6-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M373.3374,-71.8314C373.3374,-64.131 373.3374,-54.9743 373.3374,-46.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="376.8375,-46.4132 373.3374,-36.4133 369.8375,-46.4133 376.8375,-46.4132"/>
+</g>
+<!-- 7 -->
+<g id="node8" class="node">
+<title>7</title>
+<path fill="none" stroke="#56d882" stroke-width="2" d="M524.0846,-468C524.0846,-468 424.5901,-468 424.5901,-468 418.5901,-468 412.5901,-462 412.5901,-456 412.5901,-456 412.5901,-444 412.5901,-444 412.5901,-438 418.5901,-432 424.5901,-432 424.5901,-432 524.0846,-432 524.0846,-432 530.0846,-432 536.0846,-438 536.0846,-444 536.0846,-444 536.0846,-456 536.0846,-456 536.0846,-462 530.0846,-468 524.0846,-468"/>
+<text text-anchor="middle" x="474.3374" y="-447" font-family="sans" font-size="10.00" fill="#000000">concatAnchoringSummary</text>
+</g>
+<!-- 7&#45;&gt;0 -->
+<g id="edge1" class="edge">
+<title>7-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M474.959,-431.8172C475.8377,-404.504 477.3374,-351.2598 477.3374,-306 477.3374,-306 477.3374,-306 477.3374,-162 477.3374,-112.6014 436.6181,-68.6421 406.1377,-42.6562"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="408.1841,-39.8068 398.248,-36.1293 403.7221,-45.2004 408.1841,-39.8068"/>
+</g>
+<!-- 8 -->
+<g id="node9" class="node">
+<title>8</title>
+<path fill="none" stroke="#56c1d8" stroke-width="2" d="M596.3154,-396C596.3154,-396 524.3594,-396 524.3594,-396 518.3594,-396 512.3594,-390 512.3594,-384 512.3594,-384 512.3594,-372 512.3594,-372 512.3594,-366 518.3594,-360 524.3594,-360 524.3594,-360 596.3154,-360 596.3154,-360 602.3154,-360 608.3154,-366 608.3154,-372 608.3154,-372 608.3154,-384 608.3154,-384 608.3154,-390 602.3154,-396 596.3154,-396"/>
+<text text-anchor="middle" x="560.3374" y="-375" font-family="sans" font-size="10.00" fill="#000000">concatblatSummary</text>
+</g>
+<!-- 8&#45;&gt;0 -->
+<g id="edge2" class="edge">
+<title>8-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M550.794,-359.9269C537.5847,-333.1844 515.3374,-281.1461 515.3374,-234 515.3374,-234 515.3374,-234 515.3374,-162 515.3374,-120.6022 518.0417,-103.6332 491.3374,-72 470.6813,-47.5315 436.588,-33.5874 410.3457,-26.0238"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="410.9258,-22.5555 400.36,-23.3393 409.1085,-29.3155 410.9258,-22.5555"/>
+</g>
+<!-- 9 -->
+<g id="node10" class="node">
+<title>9</title>
+<path fill="none" stroke="#ced856" stroke-width="2" d="M609.5748,-108C609.5748,-108 555.0999,-108 555.0999,-108 549.0999,-108 543.0999,-102 543.0999,-96 543.0999,-96 543.0999,-84 543.0999,-84 543.0999,-78 549.0999,-72 555.0999,-72 555.0999,-72 609.5748,-72 609.5748,-72 615.5748,-72 621.5748,-78 621.5748,-84 621.5748,-84 621.5748,-96 621.5748,-96 621.5748,-102 615.5748,-108 609.5748,-108"/>
+<text text-anchor="middle" x="582.3374" y="-87" font-family="sans" font-size="10.00" fill="#000000">createDiagrams</text>
+</g>
+<!-- 9&#45;&gt;0 -->
+<g id="edge7" class="edge">
+<title>9-&gt;0</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M543.0261,-76.4574C504.8177,-63.2947 447.2506,-43.4629 409.9776,-30.6225"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="411.0944,-27.3054 400.4997,-27.3574 408.8144,-33.9237 411.0944,-27.3054"/>
+</g>
+<!-- 10 -->
+<g id="node11" class="node">
+<title>10</title>
+<path fill="none" stroke="#56d8b9" stroke-width="2" d="M282.7575,-468C282.7575,-468 225.9173,-468 225.9173,-468 219.9173,-468 213.9173,-462 213.9173,-456 213.9173,-456 213.9173,-444 213.9173,-444 213.9173,-438 219.9173,-432 225.9173,-432 225.9173,-432 282.7575,-432 282.7575,-432 288.7575,-432 294.7575,-438 294.7575,-444 294.7575,-444 294.7575,-456 294.7575,-456 294.7575,-462 288.7575,-468 282.7575,-468"/>
+<text text-anchor="middle" x="254.3374" y="-447" font-family="sans" font-size="10.00" fill="#000000">mergeFinalGff3</text>
+</g>
+<!-- 10&#45;&gt;2 -->
+<g id="edge12" class="edge">
+<title>10-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M265.352,-431.889C275.044,-413.5838 286.4462,-384.5701 278.3374,-360 275.0466,-350.0288 269.1258,-340.3944 262.8309,-332.0924"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="265.5093,-329.8384 256.4949,-324.2714 260.0702,-334.2448 265.5093,-329.8384"/>
+</g>
+<!-- 12 -->
+<g id="node13" class="node">
+<title>12</title>
+<path fill="none" stroke="#97d856" stroke-width="2" d="M256.8808,-396C256.8808,-396 209.7939,-396 209.7939,-396 203.7939,-396 197.7939,-390 197.7939,-384 197.7939,-384 197.7939,-372 197.7939,-372 197.7939,-366 203.7939,-360 209.7939,-360 209.7939,-360 256.8808,-360 256.8808,-360 262.8808,-360 268.8808,-366 268.8808,-372 268.8808,-372 268.8808,-384 268.8808,-384 268.8808,-390 262.8808,-396 256.8808,-396"/>
+<text text-anchor="middle" x="233.3374" y="-375" font-family="sans" font-size="10.00" fill="#000000">checkMissing</text>
+</g>
+<!-- 10&#45;&gt;12 -->
+<g id="edge27" class="edge">
+<title>10-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M249.0382,-431.8314C246.7675,-424.0463 244.0628,-414.7729 241.5433,-406.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="244.868,-405.0332 238.7079,-396.4133 238.148,-406.9933 244.868,-405.0332"/>
+</g>
+<!-- 11 -->
+<g id="node12" class="node">
+<title>11</title>
+<path fill="none" stroke="#56d8c9" stroke-width="2" d="M194.6995,-540C194.6995,-540 143.9752,-540 143.9752,-540 137.9752,-540 131.9752,-534 131.9752,-528 131.9752,-528 131.9752,-516 131.9752,-516 131.9752,-510 137.9752,-504 143.9752,-504 143.9752,-504 194.6995,-504 194.6995,-504 200.6995,-504 206.6995,-510 206.6995,-516 206.6995,-516 206.6995,-528 206.6995,-528 206.6995,-534 200.6995,-540 194.6995,-540"/>
+<text text-anchor="middle" x="169.3374" y="-519" font-family="sans" font-size="10.00" fill="#000000">saveGmapWG</text>
+</g>
+<!-- 11&#45;&gt;2 -->
+<g id="edge11" class="edge">
+<title>11-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M167.917,-503.7682C166.2519,-472.7094 166.1139,-408.2212 188.3374,-360 193.1687,-349.5168 200.8171,-339.7075 208.6926,-331.402"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="211.2912,-333.7539 215.9147,-324.2212 206.3556,-328.79 211.2912,-333.7539"/>
+</g>
+<!-- 11&#45;&gt;10 -->
+<g id="edge21" class="edge">
+<title>11-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M190.7864,-503.8314C201.1551,-495.0485 213.7603,-484.3712 225.0019,-474.8489"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="227.5269,-477.297 232.8951,-468.1628 223.0024,-471.9556 227.5269,-477.297"/>
+</g>
+<!-- 12&#45;&gt;2 -->
+<g id="edge13" class="edge">
+<title>12-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M234.5991,-359.8314C235.1338,-352.131 235.7697,-342.9743 236.364,-334.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="239.8574,-334.6317 237.0587,-324.4133 232.8742,-334.1467 239.8574,-334.6317"/>
+</g>
+<!-- 13 -->
+<g id="node14" class="node">
+<title>13</title>
+<path fill="none" stroke="#70d856" stroke-width="2" d="M295.9979,-684C295.9979,-684 202.6769,-684 202.6769,-684 196.6769,-684 190.6769,-678 190.6769,-672 190.6769,-672 190.6769,-660 190.6769,-660 190.6769,-654 196.6769,-648 202.6769,-648 202.6769,-648 295.9979,-648 295.9979,-648 301.9979,-648 307.9979,-654 307.9979,-660 307.9979,-660 307.9979,-672 307.9979,-672 307.9979,-678 301.9979,-684 295.9979,-684"/>
+<text text-anchor="middle" x="249.3374" y="-663" font-family="sans" font-size="10.00" fill="#000000">mapHomologousRegions</text>
+</g>
+<!-- 13&#45;&gt;2 -->
+<g id="edge14" class="edge">
+<title>13-&gt;2</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M284.807,-647.889C324.8052,-624.6418 384.3374,-580.2561 384.3374,-522 384.3374,-522 384.3374,-522 384.3374,-450 384.3374,-394.1609 329.534,-352.6912 287.0801,-328.9435"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="288.6917,-325.8359 278.2325,-324.1461 285.3551,-331.9896 288.6917,-325.8359"/>
+</g>
+<!-- 13&#45;&gt;7 -->
+<g id="edge19" class="edge">
+<title>13-&gt;7</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M308.3282,-655.8008C338.2581,-648.0662 373.4452,-634.725 398.3374,-612 438.3261,-575.4927 459.0922,-513.6028 468.2743,-477.8159"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="471.6916,-478.5753 470.6622,-468.0306 464.8912,-476.9157 471.6916,-478.5753"/>
+</g>
+<!-- 13&#45;&gt;8 -->
+<g id="edge20" class="edge">
+<title>13-&gt;8</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M308.0344,-656.9996C344.4017,-649.3563 390.7876,-635.707 426.3374,-612 495.4123,-565.9361 510.886,-543.5403 545.3374,-468 554.2387,-448.4824 557.92,-424.4292 559.4132,-406.1007"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="562.9105,-406.253 560.0624,-396.0482 555.9251,-405.8018 562.9105,-406.253"/>
+</g>
+<!-- 13&#45;&gt;10 -->
+<g id="edge24" class="edge">
+<title>13-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M273.0672,-647.9289C284.2446,-638.3331 296.9358,-625.7014 305.3374,-612 322.8285,-583.4752 322.3942,-573.0934 327.3374,-540 329.701,-524.1756 334.54,-518.2871 327.3374,-504 321.2299,-491.8853 310.9786,-481.8131 300.0598,-473.7793"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="301.8707,-470.7779 291.6376,-468.0331 297.9255,-476.5603 301.8707,-470.7779"/>
+</g>
+<!-- 13&#45;&gt;11 -->
+<g id="edge26" class="edge">
+<title>13-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M231.0006,-647.7372C221.782,-637.8082 210.9767,-624.9377 203.3374,-612 191.7828,-592.4318 182.9065,-568.2423 177.1253,-549.8708"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="180.4051,-548.6251 174.1584,-540.0677 173.7052,-550.6528 180.4051,-548.6251"/>
+</g>
+<!-- 14 -->
+<g id="node15" class="node">
+<title>14</title>
+<path fill="none" stroke="#d8ac56" stroke-width="2" d="M101.9862,-540C101.9862,-540 48.6886,-540 48.6886,-540 42.6886,-540 36.6886,-534 36.6886,-528 36.6886,-528 36.6886,-516 36.6886,-516 36.6886,-510 42.6886,-504 48.6886,-504 48.6886,-504 101.9862,-504 101.9862,-504 107.9862,-504 113.9862,-510 113.9862,-516 113.9862,-516 113.9862,-528 113.9862,-528 113.9862,-534 107.9862,-540 101.9862,-540"/>
+<text text-anchor="middle" x="75.3374" y="-519" font-family="sans" font-size="10.00" fill="#000000">gtCleanBlatGff</text>
+</g>
+<!-- 13&#45;&gt;14 -->
+<g id="edge35" class="edge">
+<title>13-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M226.9949,-647.8032C214.1921,-637.3551 197.8357,-623.9717 183.3374,-612 156.8031,-590.0899 126.7381,-565.0153 105.0795,-546.9073"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="107.1313,-544.0605 97.2151,-540.3295 102.6402,-549.43 107.1313,-544.0605"/>
+</g>
+<!-- 15 -->
+<g id="node16" class="node">
+<title>15</title>
+<path fill="none" stroke="#d87d56" stroke-width="2" d="M306.0135,-540C306.0135,-540 236.6612,-540 236.6612,-540 230.6612,-540 224.6612,-534 224.6612,-528 224.6612,-528 224.6612,-516 224.6612,-516 224.6612,-510 230.6612,-504 236.6612,-504 236.6612,-504 306.0135,-504 306.0135,-504 312.0135,-504 318.0135,-510 318.0135,-516 318.0135,-516 318.0135,-528 318.0135,-528 318.0135,-534 312.0135,-540 306.0135,-540"/>
+<text text-anchor="middle" x="271.3374" y="-519" font-family="sans" font-size="10.00" fill="#000000">recalcGmapRescue</text>
+</g>
+<!-- 13&#45;&gt;15 -->
+<g id="edge37" class="edge">
+<title>13-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M267.4949,-647.7286C275.8863,-637.9911 284.9496,-625.2949 289.3374,-612 296.0791,-591.5723 290.7048,-567.6612 284.1182,-549.6214"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="287.346,-548.266 280.4036,-540.2627 280.8397,-550.8485 287.346,-548.266"/>
+</g>
+<!-- 16 -->
+<g id="node17" class="node">
+<title>16</title>
+<path fill="none" stroke="#61d856" stroke-width="2" d="M267.9304,-612C267.9304,-612 224.7443,-612 224.7443,-612 218.7443,-612 212.7443,-606 212.7443,-600 212.7443,-600 212.7443,-588 212.7443,-588 212.7443,-582 218.7443,-576 224.7443,-576 224.7443,-576 267.9304,-576 267.9304,-576 273.9304,-576 279.9304,-582 279.9304,-588 279.9304,-588 279.9304,-600 279.9304,-600 279.9304,-606 273.9304,-612 267.9304,-612"/>
+<text text-anchor="middle" x="246.3374" y="-591" font-family="sans" font-size="10.00" fill="#000000">gmapRescue</text>
+</g>
+<!-- 13&#45;&gt;16 -->
+<g id="edge38" class="edge">
+<title>13-&gt;16</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M248.5803,-647.8314C248.2595,-640.131 247.878,-630.9743 247.5214,-622.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="251.0179,-622.2589 247.1046,-612.4133 244.024,-622.5503 251.0179,-622.2589"/>
+</g>
+<!-- 23 -->
+<g id="node24" class="node">
+<title>23</title>
+<path fill="none" stroke="#56b1d8" stroke-width="2" d="M106.1349,-612C106.1349,-612 40.5399,-612 40.5399,-612 34.5399,-612 28.5399,-606 28.5399,-600 28.5399,-600 28.5399,-588 28.5399,-588 28.5399,-582 34.5399,-576 40.5399,-576 40.5399,-576 106.1349,-576 106.1349,-576 112.1349,-576 118.1349,-582 118.1349,-588 118.1349,-588 118.1349,-600 118.1349,-600 118.1349,-606 112.1349,-612 106.1349,-612"/>
+<text text-anchor="middle" x="73.3374" y="-591" font-family="sans" font-size="10.00" fill="#000000">recalcBlatMapped</text>
+</g>
+<!-- 13&#45;&gt;23 -->
+<g id="edge46" class="edge">
+<title>13-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M204.9251,-647.8314C181.1769,-638.1162 151.7627,-626.0831 126.771,-615.8592"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="128.0109,-612.585 117.4302,-612.038 125.3605,-619.0638 128.0109,-612.585"/>
+</g>
+<!-- 14&#45;&gt;10 -->
+<g id="edge23" class="edge">
+<title>14-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M114.1777,-506.3771C140.6907,-495.7126 176.0476,-481.4909 204.616,-469.9997"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="206.0501,-473.1954 214.0216,-466.2164 203.4378,-466.7011 206.0501,-473.1954"/>
+</g>
+<!-- 15&#45;&gt;10 -->
+<g id="edge22" class="edge">
+<title>15-&gt;10</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M267.0475,-503.8314C265.2294,-496.131 263.0674,-486.9743 261.0468,-478.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="264.3893,-477.3414 258.6849,-468.4133 257.5766,-478.95 264.3893,-477.3414"/>
+</g>
+<!-- 16&#45;&gt;11 -->
+<g id="edge25" class="edge">
+<title>16-&gt;11</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M226.907,-575.8314C217.6054,-567.1337 206.317,-556.5783 196.2088,-547.1265"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="198.4563,-544.4363 188.7615,-540.1628 193.6753,-549.5493 198.4563,-544.4363"/>
+</g>
+<!-- 16&#45;&gt;15 -->
+<g id="edge36" class="edge">
+<title>16-&gt;15</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M252.6459,-575.8314C255.349,-568.0463 258.569,-558.7729 261.5684,-550.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="264.97,-551.0081 264.9439,-540.4133 258.3573,-548.7119 264.97,-551.0081"/>
+</g>
+<!-- 17 -->
+<g id="node18" class="node">
+<title>17</title>
+<path fill="none" stroke="#d88d56" stroke-width="2" d="M243.5446,-828C243.5446,-828 179.1301,-828 179.1301,-828 173.1301,-828 167.1301,-822 167.1301,-816 167.1301,-816 167.1301,-804 167.1301,-804 167.1301,-798 173.1301,-792 179.1301,-792 179.1301,-792 243.5446,-792 243.5446,-792 249.5446,-792 255.5446,-798 255.5446,-804 255.5446,-804 255.5446,-816 255.5446,-816 255.5446,-822 249.5446,-828 243.5446,-828"/>
+<text text-anchor="middle" x="211.3374" y="-807" font-family="sans" font-size="10.00" fill="#000000">splitGffPerChrom</text>
+</g>
+<!-- 17&#45;&gt;12 -->
+<g id="edge28" class="edge">
+<title>17-&gt;12</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M166.8446,-802.3493C118.0863,-793.095 44.1426,-776.2158 24.3374,-756 -4.6334,-726.4285 .3374,-707.3978 .3374,-666 .3374,-666 .3374,-666 .3374,-522 .3374,-434.8166 119.8414,-398.6521 187.6802,-385.1463"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="188.526,-388.5483 197.696,-383.2416 187.2182,-381.6715 188.526,-388.5483"/>
+</g>
+<!-- 18 -->
+<g id="node19" class="node">
+<title>18</title>
+<path fill="none" stroke="#567bd8" stroke-width="2" d="M379.4354,-756C379.4354,-756 321.2393,-756 321.2393,-756 315.2393,-756 309.2393,-750 309.2393,-744 309.2393,-744 309.2393,-732 309.2393,-732 309.2393,-726 315.2393,-720 321.2393,-720 321.2393,-720 379.4354,-720 379.4354,-720 385.4354,-720 391.4354,-726 391.4354,-732 391.4354,-732 391.4354,-744 391.4354,-744 391.4354,-750 385.4354,-756 379.4354,-756"/>
+<text text-anchor="middle" x="350.3374" y="-735" font-family="sans" font-size="10.00" fill="#000000">upstreamClosest</text>
+</g>
+<!-- 17&#45;&gt;18 -->
+<g id="edge41" class="edge">
+<title>17-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M246.4129,-791.8314C264.6034,-782.4089 287.0032,-770.8062 306.3433,-760.7883"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="308.0033,-763.8701 315.273,-756.1628 304.7837,-757.6545 308.0033,-763.8701"/>
+</g>
+<!-- 19 -->
+<g id="node20" class="node">
+<title>19</title>
+<path fill="none" stroke="#80d856" stroke-width="2" d="M279.6549,-756C279.6549,-756 209.0198,-756 209.0198,-756 203.0198,-756 197.0198,-750 197.0198,-744 197.0198,-744 197.0198,-732 197.0198,-732 197.0198,-726 203.0198,-720 209.0198,-720 209.0198,-720 279.6549,-720 279.6549,-720 285.6549,-720 291.6549,-726 291.6549,-732 291.6549,-732 291.6549,-744 291.6549,-744 291.6549,-750 285.6549,-756 279.6549,-756"/>
+<text text-anchor="middle" x="244.3374" y="-735" font-family="sans" font-size="10.00" fill="#000000">downstreamClosest</text>
+</g>
+<!-- 17&#45;&gt;19 -->
+<g id="edge43" class="edge">
+<title>17-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M219.6647,-791.8314C223.3104,-783.8771 227.6682,-774.369 231.7001,-765.5723"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="234.9131,-766.9622 235.8979,-756.4133 228.5496,-764.0456 234.9131,-766.9622"/>
+</g>
+<!-- 18&#45;&gt;13 -->
+<g id="edge33" class="edge">
+<title>18-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M324.8508,-719.8314C312.1715,-710.7927 296.6778,-699.7476 283.0318,-690.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="284.9902,-687.1176 274.8158,-684.1628 280.9269,-692.8176 284.9902,-687.1176"/>
+</g>
+<!-- 19&#45;&gt;13 -->
+<g id="edge31" class="edge">
+<title>19-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M245.5991,-719.8314C246.1338,-712.131 246.7697,-702.9743 247.364,-694.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="250.8574,-694.6317 248.0587,-684.4133 243.8742,-694.1467 250.8574,-694.6317"/>
+</g>
+<!-- 20 -->
+<g id="node21" class="node">
+<title>20</title>
+<path fill="none" stroke="#d8c356" stroke-width="2" d="M167.0427,-756C167.0427,-756 127.632,-756 127.632,-756 121.632,-756 115.632,-750 115.632,-744 115.632,-744 115.632,-732 115.632,-732 115.632,-726 121.632,-720 127.632,-720 127.632,-720 167.0427,-720 167.0427,-720 173.0427,-720 179.0427,-726 179.0427,-732 179.0427,-732 179.0427,-744 179.0427,-744 179.0427,-750 173.0427,-756 167.0427,-756"/>
+<text text-anchor="middle" x="147.3374" y="-735" font-family="sans" font-size="10.00" fill="#000000">indexQuery</text>
+</g>
+<!-- 20&#45;&gt;13 -->
+<g id="edge32" class="edge">
+<title>20-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M173.0763,-719.8314C185.8811,-710.7927 201.5282,-699.7476 215.3093,-690.0198"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="217.4554,-692.7891 223.6067,-684.1628 213.4186,-687.0703 217.4554,-692.7891"/>
+</g>
+<!-- 20&#45;&gt;23 -->
+<g id="edge47" class="edge">
+<title>20-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M137.9652,-719.7623C125.1766,-694.8764 102.1574,-650.0822 87.3236,-621.2165"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="90.3172,-619.3842 82.6334,-612.0896 84.0911,-622.5837 90.3172,-619.3842"/>
+</g>
+<!-- 21 -->
+<g id="node22" class="node">
+<title>21</title>
+<path fill="none" stroke="#d86656" stroke-width="2" d="M85.6511,-756C85.6511,-756 45.0236,-756 45.0236,-756 39.0236,-756 33.0236,-750 33.0236,-744 33.0236,-744 33.0236,-732 33.0236,-732 33.0236,-726 39.0236,-720 45.0236,-720 45.0236,-720 85.6511,-720 85.6511,-720 91.6511,-720 97.6511,-726 97.6511,-732 97.6511,-732 97.6511,-744 97.6511,-744 97.6511,-750 91.6511,-756 85.6511,-756"/>
+<text text-anchor="middle" x="65.3374" y="-735" font-family="sans" font-size="10.00" fill="#000000">indexTarget</text>
+</g>
+<!-- 21&#45;&gt;13 -->
+<g id="edge29" class="edge">
+<title>21-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M97.4982,-723.6898C100.4779,-722.4217 103.4582,-721.1747 106.3374,-720 133.572,-708.8884 164.0302,-697.2759 189.815,-687.6791"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="191.2932,-690.8639 199.4521,-684.105 188.859,-684.3008 191.2932,-690.8639"/>
+</g>
+<!-- 21&#45;&gt;23 -->
+<g id="edge45" class="edge">
+<title>21-&gt;23</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M66.3506,-719.7623C67.7151,-695.201 70.1569,-651.2474 71.7621,-622.3541"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="75.2722,-622.2684 72.3324,-612.0896 68.283,-621.88 75.2722,-622.2684"/>
+</g>
+<!-- 22 -->
+<g id="node23" class="node">
+<title>22</title>
+<path fill="none" stroke="#56d892" stroke-width="2" d="M372.3374,-972C372.3374,-972 342.3374,-972 342.3374,-972 336.3374,-972 330.3374,-966 330.3374,-960 330.3374,-960 330.3374,-948 330.3374,-948 330.3374,-942 336.3374,-936 342.3374,-936 342.3374,-936 372.3374,-936 372.3374,-936 378.3374,-936 384.3374,-942 384.3374,-948 384.3374,-948 384.3374,-960 384.3374,-960 384.3374,-966 378.3374,-972 372.3374,-972"/>
+<text text-anchor="middle" x="357.3374" y="-951" font-family="sans" font-size="10.00" fill="#000000">bam2bed</text>
+</g>
+<!-- 22&#45;&gt;13 -->
+<g id="edge30" class="edge">
+<title>22-&gt;13</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M383.5936,-935.8151C394.6796,-926.5285 406.3832,-914.1902 412.3374,-900 443.3594,-826.0671 451.7589,-781.5164 400.3374,-720 389.0756,-706.5274 352.2508,-693.2211 317.7889,-683.1881"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="318.7308,-679.8173 308.1547,-680.4477 316.8156,-686.5502 318.7308,-679.8173"/>
+</g>
+<!-- 25 -->
+<g id="node26" class="node">
+<title>25</title>
+<path fill="none" stroke="#d85656" stroke-width="2" d="M391.1944,-828C391.1944,-828 285.4803,-828 285.4803,-828 279.4803,-828 273.4803,-822 273.4803,-816 273.4803,-816 273.4803,-804 273.4803,-804 273.4803,-798 279.4803,-792 285.4803,-792 285.4803,-792 391.1944,-792 391.1944,-792 397.1944,-792 403.1944,-798 403.1944,-804 403.1944,-804 403.1944,-816 403.1944,-816 403.1944,-822 397.1944,-828 391.1944,-828"/>
+<text text-anchor="middle" x="338.3374" y="-807" font-family="sans" font-size="10.00" fill="#000000">keepMappedOnSameChrom</text>
+</g>
+<!-- 22&#45;&gt;25 -->
+<g id="edge49" class="edge">
+<title>22-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M331.0811,-935.8151C319.9951,-926.5285 308.2916,-914.1902 302.3374,-900 296.1467,-885.2462 297.7008,-879.3135 302.3374,-864 305.2938,-854.2355 310.6626,-844.6229 316.3673,-836.2762"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="319.2788,-838.2239 322.3469,-828.0831 313.6245,-834.0973 319.2788,-838.2239"/>
+</g>
+<!-- 27 -->
+<g id="node28" class="node">
+<title>27</title>
+<path fill="none" stroke="#56a2d8" stroke-width="2" d="M391.485,-900C391.485,-900 323.1897,-900 323.1897,-900 317.1897,-900 311.1897,-894 311.1897,-888 311.1897,-888 311.1897,-876 311.1897,-876 311.1897,-870 317.1897,-864 323.1897,-864 323.1897,-864 391.485,-864 391.485,-864 397.485,-864 403.485,-870 403.485,-876 403.485,-876 403.485,-888 403.485,-888 403.485,-894 397.485,-900 391.485,-900"/>
+<text text-anchor="middle" x="357.3374" y="-879" font-family="sans" font-size="10.00" fill="#000000">selectMappedISBP</text>
+</g>
+<!-- 22&#45;&gt;27 -->
+<g id="edge50" class="edge">
+<title>22-&gt;27</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M357.3374,-935.8314C357.3374,-928.131 357.3374,-918.9743 357.3374,-910.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="360.8375,-910.4132 357.3374,-900.4133 353.8375,-910.4133 360.8375,-910.4132"/>
+</g>
+<!-- 23&#45;&gt;14 -->
+<g id="edge34" class="edge">
+<title>23-&gt;14</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M73.842,-575.8314C74.0559,-568.131 74.3103,-558.9743 74.548,-550.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="78.0468,-550.5066 74.8259,-540.4133 71.0495,-550.3122 78.0468,-550.5066"/>
+</g>
+<!-- 24 -->
+<g id="node25" class="node">
+<title>24</title>
+<path fill="none" stroke="#566bd8" stroke-width="2" d="M237.9672,-900C237.9672,-900 184.7075,-900 184.7075,-900 178.7075,-900 172.7075,-894 172.7075,-888 172.7075,-888 172.7075,-876 172.7075,-876 172.7075,-870 178.7075,-864 184.7075,-864 184.7075,-864 237.9672,-864 237.9672,-864 243.9672,-864 249.9672,-870 249.9672,-876 249.9672,-876 249.9672,-888 249.9672,-888 249.9672,-894 243.9672,-900 237.9672,-900"/>
+<text text-anchor="middle" x="211.3374" y="-879" font-family="sans" font-size="10.00" fill="#000000">grepGffFeature</text>
+</g>
+<!-- 24&#45;&gt;17 -->
+<g id="edge39" class="edge">
+<title>24-&gt;17</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M211.3374,-863.8314C211.3374,-856.131 211.3374,-846.9743 211.3374,-838.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="214.8375,-838.4132 211.3374,-828.4133 207.8375,-838.4133 214.8375,-838.4132"/>
+</g>
+<!-- 25&#45;&gt;18 -->
+<g id="edge40" class="edge">
+<title>25-&gt;18</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M341.3655,-791.8314C342.6489,-784.131 344.175,-774.9743 345.6013,-766.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="349.0768,-766.8526 347.2685,-756.4133 342.172,-765.7018 349.0768,-766.8526"/>
+</g>
+<!-- 25&#45;&gt;19 -->
+<g id="edge42" class="edge">
+<title>25-&gt;19</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M314.6172,-791.8314C302.928,-782.8779 288.6686,-771.9558 276.0565,-762.2955"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="278.117,-759.4651 268.0499,-756.1628 273.8605,-765.0222 278.117,-759.4651"/>
+</g>
+<!-- 26 -->
+<g id="node27" class="node">
+<title>26</title>
+<path fill="none" stroke="#56d0d8" stroke-width="2" d="M372.6593,-1044C372.6593,-1044 342.0154,-1044 342.0154,-1044 336.0154,-1044 330.0154,-1038 330.0154,-1032 330.0154,-1032 330.0154,-1020 330.0154,-1020 330.0154,-1014 336.0154,-1008 342.0154,-1008 342.0154,-1008 372.6593,-1008 372.6593,-1008 378.6593,-1008 384.6593,-1014 384.6593,-1020 384.6593,-1020 384.6593,-1032 384.6593,-1032 384.6593,-1038 378.6593,-1044 372.6593,-1044"/>
+<text text-anchor="middle" x="357.3374" y="-1023" font-family="sans" font-size="10.00" fill="#000000">filterBam</text>
+</g>
+<!-- 26&#45;&gt;22 -->
+<g id="edge44" class="edge">
+<title>26-&gt;22</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M357.3374,-1007.8314C357.3374,-1000.131 357.3374,-990.9743 357.3374,-982.4166"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="360.8375,-982.4132 357.3374,-972.4133 353.8375,-982.4133 360.8375,-982.4132"/>
+</g>
+<!-- 27&#45;&gt;25 -->
+<g id="edge48" class="edge">
+<title>27-&gt;25</title>
+<path fill="none" stroke="#c0c0c0" stroke-width="2" d="M352.5429,-863.8314C350.4885,-856.0463 348.0413,-846.7729 345.7618,-838.1347"/>
+<polygon fill="#c0c0c0" stroke="#c0c0c0" stroke-width="2" points="349.1322,-837.1892 343.1964,-828.4133 342.3639,-838.9753 349.1322,-837.1892"/>
+</g>
+</g>
+</svg>
\ No newline at end of file
-- 
GitLab


From d0b0bfd3ad652e8c95766feb6a6068513836bccf Mon Sep 17 00:00:00 2001
From: Helene Rimbert <helene.rimbert@inra.fr>
Date: Wed, 5 Jul 2023 15:36:47 +0200
Subject: [PATCH 9/9] UPDATE: add ne gmap management in Readme description

---
 README.md | 7 +++++++
 1 file changed, 7 insertions(+)

diff --git a/README.md b/README.md
index 544c532..6852a2e 100644
--- a/README.md
+++ b/README.md
@@ -81,6 +81,8 @@ Here, we only need the fasta of the new genome assembly
 | Parameter in `config.yaml` | format |description |Example |  
 |----------------------------|--------|------------|--------|  
 |**targetFasta**|FASTA|fasta file of the target genome assembly on which we transfert the annotation|targetFasta: 'data/CS_pesudo_v2.1.fa'|
+|**targetGmapIndex**|PATH|Name of the GMAP index directory. This will be used with the `-d` option of `gmapl`|targetGmapIndex: 'ensembl_Triticum_aestivum_julius_2022-9-16'|
+|**targetGmapIndexPath**|PATH|Full path to the directory in which the GMAPindex is found. This will be used with the `-D` option of `gmapl`|targetGmapIndexPath: '/home/data/triticum_aestivum/julius/gmapdb/all/'|
 
 * Output parameters/settings
 
@@ -136,6 +138,11 @@ refChrom: ['chr1A', 'chr1B', 'chr1D', 'chr2A', 'chr2B', 'chr2D', 'chr3A', 'chr3B
 
 ##### TARGET related files/parameters (refseqv2.1)
 targetFasta: 'data/CS_pesudo_v2.1.fa'
+#GMAP index of the genome for -d option
+targetGmapIndex: 'ensembl_Triticum_aestivum_julius_2022-9-16'
+#GMAP index: path to the gmapindex directory, for -D option
+targetGmapIndexPath: '/home/herimbert/gdec/shared/triticum_aestivum/julius/current/gmapdb/all/'
+
 
 ##### ISBP/markers related config and parameters
 # BAM file of markers/ISBPs mapped on the target genome (REFSEQ v2.1)
-- 
GitLab