Differences

This shows you the differences between two versions of the page.

Link to this comparison view

Both sides previous revision Previous revision
Next revision
Previous revision
research [2020/02/28 13:41]
tischulz Updated links
research [2024/05/16 15:01] (current)
arempel
Line 3: Line 3:
 The primary material analyzed by genome informatics are genomic sequences. Beyond the acquisition and basic analysis of these data, the next challenge is to extract the higher-level information encoded in them, which poses the need for sound mathematical models, efficient algorithms, and user-friendly software. The primary material analyzed by genome informatics are genomic sequences. Beyond the acquisition and basic analysis of these data, the next challenge is to extract the higher-level information encoded in them, which poses the need for sound mathematical models, efficient algorithms, and user-friendly software.
  
-Research in the Genome Informatics group spans a broad spectrum in this exciting field, from the low level of DNA sequence comparison up to the higher levels of comparative genomics, ​metagenomics ​and phylogenetics.+Research in the Genome Informatics group spans a broad spectrum in this exciting field, from the low level of DNA sequence comparison up to the higher levels of comparative genomics, and making better infrastructures.
  
-==== Efficient Comparison of DNA Sequences ====+==== Efficient Comparison of DNA Sequences ​(aka team kmers) ​====
  
-A fundamental task in biological sequence analysis ​is the comparison ​of two DNA stringswith the aim of finding regions that match each other exactly or approximately.+=== Improving search engines for DNA sequences ​ === 
 +The amount of publicly available sequencing data is growing faster than computational power. Searching for a sequence ​of interest among datasets is a fundamental need; howeverno method scales to the dozens ​of petabytes of data already available today. Thus, new computational methods are required to perform a search against datasets.
  
-=== Comparative Assembly Tools ===+Queries on large-scale datasets are usually done by indexing all k-mers (words of length k) from sequences. These k-mers are then typically indexed in an Approximate membership query (AMQ) data structure. The proportion of shared k-mers between the indexed datasets and the AMQ then gives an overview of the presence of the query in a dataset. 
 +To index a set of sequences, AMQ data structures typically require less space than the original set. However, AMQ data structures suffer from a non-null false positive rate, which biases downstream analysis.  ​
  
-{{:​comparative_assembly.png?​nolink |}}Currentlywe are using our index-based matching algorithm [[http://​bibiserv.techfak.uni-bielefeld.de/​swift|SWIFT]] ​as a basic component of the recently developed [[https://​bibiserv.cebitec.uni-bielefeld.de/​cgcat|r2cat]] ​and [[https://​bibiserv.cebitec.uni-bielefeld.de/​cgcat|treecat]] methods. These are employed in the context of whole genome sequencing for closing the gaps that remain between the contigs after a standard assembly of shotgun reads\\+AMQ data structures can be generalized for additionally recording the abundance of indexed elementsthey are then called "​counting AMQ" data structuresThe abundance information is crucial for many biological applications such as transcriptomics or metagenomicsHowever, counting AMQs data structures suffer from false positives ​and overestimated calls
  
-=== Detection of Repeated Regions === 
  
-{{:​deBruijn.png?​nolink |deBruijn|}}Genomes often contain several repetitive regions that do not encode any proteins, which may result in the development of genetic disorders. ​We have investigated ​the problem ​of identifying families of repetitive sequences in genomes that are only partially sequenced. Our approach is based on de Bruijn graphs, whose highly regular structure results in several appealing combinatorial properties.\\+We propose strategies to reduce ​the false positive rate and overestimation rate of both AMQ and counting AMQ data structures.
  
-=== Pangenome ​Search ​and Storage ​===+=== Fast Heuristic Local Alignment ​Search ​in Pangenome Graphs  ​=== 
 +<WRAP left>​{{research:​plastalignment.png?​300,​nolink}}</​WRAP>​ The advent of High Throughput Sequencing raises a major concern about storage and indexing of data produced by these technologies. Large-scale sequencing projects generate an unprecedented volume of genomic sequences ranging from tens to several thousands of genomes per species. These collections contain highly similar and redundant sequences, also known as pangenomes.  
 +Pangenomes are oftentimes represented by graphical data structures such as //colored de Bruijn graphs// (CDBGs) in which vertices represent colored //k//-mers, words of length //k// associated with the genomes in which they occur. CDBGs may also be compacted by merging vertices of unique non-branching paths.  
 +Representing pangenomes as compacted CDBGs is beneficial, but it requires modifications of methods to query the data. We study the problem of finding high scoring local alignments between a query sequence and a compacted CDBG that are likely to represent sequence homology. Our work is in line with the popular [[https://​doi.org/​10.1016/​S0022-2836(05)80360-2|BLAST algorithm]]. Our method is published in [[https://​doi.org/​10.1093/​bioinformatics/​btab077|Bioinformatics]]. An implementation and further documentation are available [[https://​github.com/​tischulz1/​plast|here]]. ​
  
 +=== Sequence-Based Pangenomic Core Detection ===
 +{{:​pangenome.png?​nolink&​300 |}} One of the most basic kinds of analysis to be performed on a pan genome is the detection of its core, i.e., the information shared among all members. Pangenomic core detection is classically done on the gene level and many tools focus exclusively on core detection in prokaryotes.
 +We are working on a new method for sequence-based pangenomic core detection. Our model generalizes from a strict core definition allowing us to flexibly determine suitable core properties depending on the research question and the data set under consideration. We propose an algorithm based on a CDBG that runs in linear time with respect to the number of //k//-mers in the graph. An implementation of our method is called [[https://​gitlab.ub.uni-bielefeld.de/​gi/​corer|Corer]]. Due to the usage of a CDBG, it works alignment-free,​ is provided with a small memory footprint, and accepts as input assembled genomes as well as sequencing reads. Corer has been presented as RECOMB-seq in 2022 and a manuscript is published in [[https://​doi.org/​10.1016/​j.isci.2022.104413|iScience]].
  
-{{:​pangenome.png?​nolink&​300 |}}The advent of High Throughput Sequencing (HTS) technologies raises a major concern about storage and indexing of data produced by these technologies. In particular, large-scale sequencing projects generate an unprecedented volume of genomic sequences ranging from tens to several thousands of genomes per species. These collections contain highly similar and redundant sequences, also known as pan-genomes.\\+=== Pangenome Openness ===
  
-In the first and second year of this projectan alignment-free and reference-free data structure for indexing ​pan-genome has been developedA pan-genome is represented as a //colored de Bruijn graph// ​in which vertices represent colored //k//-merswords of length //k// associated with the identity ​of the strains in which they occurFor storing and traversing such graph, we proposed the Bloom Filter Trie (BFT), a trie that compresses ​and indexes strings of fixed-length //k// and their colorsThe BFT is based on the //burst trie// and integrates Bloom filters to navigate ​in the trie and accelerate ​the graph traversal. +<WRAP left>​{{research:​pangrowth_richness.jpg?​300,​nolink}}</​WRAP>​ The field of pangenomics emerged from the study of bacterial genomesinitially 
-The specificity of our work compared to existing pan-genome tools resides in four main characteristics:​ +defining the pangenome as the comprehensive set of genes within ​species 
-  * It is reference-free as good quality reference genomes are available only for a small fraction of species, +Early research discovered substantial differences ​in pangenome sizes across 
-  * it is alignment-free as sequence alignment methods are computationally expensive+speciesintroducing ​the concept ​of pangenome opennessThis concept reflects ​a 
-  * assembled and unassembled genomes are considered as input, and +species'​ capacity for colonizing new environments ​and its genetic diversity 
-  * the data structure is fully incremental and can be updated with new data. +Given the rapid increase ​in genomic data and the time-consuming steps required 
- +by traditional gene-based methods ​-- such as annotationgene homology 
-Experimental results prove better performance compared to another state-of-the-art data structure. An API written in C is provided ​to access all functionalities of the the data structure as well as colored de Bruijn graph operations such that methods can be designed on top of the BFT. The BFT source code and documentation are available [[https://github.com/GuillaumeHolley/BloomFilterTrie|here]]. +identification, and the need for fully assembled genomes ​-- we propesd an 
-The data structure was presented at the 15th International Workshop on Algorithms in Bioinformatics in AtlantaUSA. An extended version of the paper was published in the journal Algorithms for Molecular Biology in 2016.\\ +alternative ​to estimate pangenome openness with the use of //k//-mersshort DNA 
- +sequences of fixed length. ​We developed ​tool called [[https://gitlab.ub.uni-bielefeld.de/​gi/​pangrowth|Pangrowth]], which 
-Pan-genomes are also ideal for compression. However, HTS-specific compression tools, developed to counter the massive growth of sequencing data and reduce storage costs, are not designed to process them. These methods can only compress genomes individually such that the compression ratio of a pan-genome does not improve with newly compressed genomes. During the third year of this project, a new alignment-free and reference-free compression method has been developed. It addresses the problem of pan-genome compression by encoding the sequences of a pan-genome as a guided de Bruijn graph. The novelty of this method is its ability to incrementally update archives with new genome sequences without full decompression of the archive. This method can compress both single-end and paired-end read sequences of any length ​using all symbols of the IUPAC nucleotide codeOn large //Paeruginosa//​ dataset, this method outperforms all other tested tools with a 30 % compression ratio improvement in single-end mode compared to the best performing state-of-the-art HTS-specific compression method in our experiments.\\ +efficiently estimates this openness.
- +
-=== Detection of the Core Genome === +
- +
-We are working on developing methods for the functional analysis of a pan-genomeIn order to store a pan-genomewe use the Bloom Filter Trie (BFT), in which a pan-genome is represented as a colored de Bruijn graph (C-DBG). ​ +
-The first step is the identification of the core genome. Matching sequences can be interrupted by SNPs or other structural variations, resulting in branching nodes and additional paths in the graph. Therefore, we first introduce a formal definition of a core genome in a C-DBG. +
- +
-For a set of input genomes, we consider the core as being composed of sequences shared by at least a required number of genomes, called the quorum. In order to model variations and include them in the core genome, we introduce the concept of a core bubble. A distance is used to limit the maximal distance allowed between two core paths, where a core path is a path containing only core nodes. Besides bubbles, we introduce the defi nition of connected and disconnected core paths in order to cover the remaining cases. Currently, we are developing an algorithm for detecting a core genome in a given C-DBG+
  
 ==== Computational Comparative Genomics ==== ==== Computational Comparative Genomics ====
 +=== Comparative Pangenomics ===
 +<WRAP left>​{{bpandpangenome.png?​300,​nolink}}</​WRAP>​ Genome rearrangements have been studied extensively in theoretical works of Comparative Genomics. These results however, have only been applied on a limited scale to real genomes. The continuing progress of sequencing projects and technology made more and more high quality genomes available and enabled even Pangenomic analyses, that is, analyses that include all availailable genomes of a species. Pangenomics and theoretical Rearrangement Studies utilize remarkably similar graph data structures. Given the abundance of theoretical results in Comparative Genomics, ​ it is likely that many of these results can be applied in Pangenomics. Conversely, the abundance of practical results in the construction of Pangenome graphs can likely contribute to these theoretical results seeing more real world applications.
  
-The goal of comparative genomics is to compare ​genomes, ​not any more at the level of DNA sequencebut rather at the higher level of gene content and gene order.+=== Orthology Inference via Large-scale Rearrangements === 
 +<WRAP left>​{{research:​ff-relationalgraph.png?​300,​nolink}}</​WRAP>​ Computing distances based on large-scale rearrangements between two family-annotated genomes ({{https://​pub.uni-bielefeld.de/​record/​2946303|Bohnenkämper et al., 2021}}) was converted into a method that takes genome rearrangements into consideration for inferring gene orthologies ​of two genomes ​({{https://​pub.uni-bielefeld.de/​record/​2954832|RubertMartinez & Braga, 2021}}). For a set of //k// genomes, the inference ​of pairwise ​gene orthologies is the core of OrthoFFGC, a tool for inferring ​gene families across the //k// input genomes ({{https://​pub.uni-bielefeld.de/​record/​2959611|Rubert,​ Doerr & Braga, 2021}}; {{https://​pub.uni-bielefeld.de/​record/​2983338|Rubert & Braga, 2023}}; {{https://​gitlab.ub.uni-bielefeld.de/​gi/​ffgc|OrthoFFGC-website}}).
  
-=== Genome Rearrangements ​===+=== Sequence-based Phylogenomics ​=== 
 +{{research:​weakly.png?​nolink |SANS|}}Comparative genomics often involves the reconstruction of phylogenies. The ever-increasing number of available genomes, many of which are published in an unfinished state or lack sufficient annotation, poses challenges to traditional phylogenetic inference methods that rely on the comparison of marker sequences. 
 +Whole-genome approaches have emerged as a solution to these challenges, but as these approaches are based on pairwise comparisons between genomes, their runtime increases quadratically with the number of input sequences, making them unsuitable in large-scale scenarios.
  
-{{:splash_unimog.jpg?nolink |UniMoG|}}Our motivation is to devise a quantitative measure for the distance between two genomes, which can in turn be used in phylogenetic studiesA reasonable distance measure is the minimum number of rearrangement operations that transform one genome into anotherIn this contextwe formally defined the Double-Cut-and-Join (DCJdistance that includes all classical ​genome ​rearrangement operations, also for circular chromosomes. Based on thiswe have developed the first linear-time algorithm for computing the so-called Hannenhalli-Pevzner distance between two multichromosomal linear ​genomes. ​This algorithm was recently implemented in the software [[http://bibiserv.techfak.uni-bielefeld.de/dcj/welcome.html|UniMoG]] along with the most efficient algorithms for the genome rearrangement models that employ only DCJ operations, only restricted DCJ operations, only translocations or only inversions. After the DCJ-indel model, we are currently studying ​the inversion-indel model\\ +SANS ({{https://gitlab.ub.uni-bielefeld.de/​gi/​sans|tool-website}}; {{https://​doi.org/10.1093/​bioinformatics/​btab444|Rempel and Wittler2021}}; {{https://​doi.org/​10.1186/​s13015-020-00164-3|Wittler, 2020}}is a whole-genome ​basedalignmentand reference-free approach that does not rely on a pairwise comparison of genomes. ​ 
 +In a pangenomic approach, evolutionary relationships are determined based on the similarity of the whole sequences. Sequence segments (//k//-mers) shared by a subset of genomes ​are interpreted as a phylogenetic split indicating ​the closeness of these genomes and their separation from the other genomes.
  
-=== Gene family assignment-free comparative genomics === 
- 
-{{:​new_model_graph.png?​nolink |Family free|}}Virtually all algorithmic methods in genome-scale comparative genomics rely on gene family information. While the concept of gene families is well established from a biological point of view, in practice gene families are often predicted by clustering methods. Their outcome is prone to contain errors which deteriorate subsequent analyses. 
- 
-We promote the idea that genome-scale comparative genomics studies can be performed without prior gene family assignment. Instead of predicting homologies between genes, we propose direct use of similarity values because such information not only allows to make more substantiated choices in resolving gene order in subsequent analyses, but can sometimes better reflect the biological reality. In support of our case, we recently presented new approaches to calculate two rearrangement distances: the number of conserved adjacencies,​ which is a similarity measure related to the breakpoint distance, and the Double Cut and Join distance (DCJ), without the use of gene families. 
- 
-=== Detection of Gene Clusters === 
- 
-{{:​zellen.png?​nolink |Zellen|}}Gene clusters are sets of genetic markers that maintain close physical proximities to each other in several genomes. These genetic markers often embody protein coding genes that are functionally and/or regulatorily associated.\\ Traditional methods take into account one-dimensional distances in the genomic sequence to determine physical proximities. They do not consider any spatial information regarding the structure of the chromatid in the cell and therefore might miss spatial gene clusters within the genome. However, spatial structure and function seem to be correlated in many cases.\\ Nowadays, it is possible to gain three-dimensional information about the chromatid in the cell (e.g. by Hi-C experiments).\\ We try to include this Hi-C data to improve the gene cluster model in a spatial manner which - on the other hand - seems to raise the computational complexity. The aim is to develop a polynomial algorithm that is able to find all common spatial gene clusters between two genomes. 
  
 === Evolution of Gene Clusters === === Evolution of Gene Clusters ===
 +{{:​ancestor_reconstruction.png?​nolink |Acestor-Reconstruction|}}We integrate the concept of conserved gene clusters into the framework of phylogenetics. Here, the focus is not any more on the discovery of new gene clusters, but on their evolution. Given the topology of a phylogenetic tree and the gene orders of the leaf nodes, our methods reconstruct ancestral gene orders at the internal nodes under different evolutionary (rearrangement) models (see [[http://​bibiserv.techfak.uni-bielefeld.de/​rococo|Rococo]],​ [[https://​github.com/​pedrofeijao/​RINGO|RINGO]],​ [[https://​github.com/​nluhmann/​PhySca|PhySca]]).\\
 +In addition, the development of ancient DNA (aDNA) sequencing led us to the problem of integrating this additional data in the reconstruction of ancestral genomes, aiming to scaffold fragmented aDNA assemblies and to improve the global reconstruction of all ancestors in the phylogeny.
  
-{{:​ancestor_reconstruction.png?​nolink |Acestor-Reconstruction|}}We aim at the integration of the concept of gene clusters into the framework of phylogenetics. Here, the focus is not any more on the discovery of new gene clusters, but on their evolution. Given the topology of a phylogenetic tree and the gene orders of the leaf nodes, we studied the reconstruction of parsimonious ancestral gene orders at the internal nodes under different evolutionary (rearrangement) models (see [[http://​bibiserv.techfak.uni-bielefeld.de/​rococo|Rococo]],​ [[https://​github.com/​pedrofeijao/​RINGO|RINGO]],​ [[https://​github.com/​nluhmann/​PhySca|PhySca]]).\\ +==== Infrastructure ​====
-In addition, the recent development of ancient DNA (aDNA) sequencing led us to the problem of integrating this additional data in the reconstruction of ancestral genomes, aiming to scaffold fragmented aDNA assemblies and to improve the global reconstruction of all ancestors in the phylogeny. +
- +
-=== Protein domain sets ==+
- +
-{{:​research:​clustersample.png?​200 |}}Protein domains are described as a basic structural, evolutionary and functional units of proteins (Holm and Sander, 1994). An individual domain is an independent folding unit in a polypeptide. Although there are disordered protein regions(they lack of a stable secondary or terciary structure), domains are considered the functional building blocks of proteins which can even recombine to create new functional proteins. In prokaryotes,​ the protein repertoire has aproximately 66% of multidomain proteins, while in eukaryotes is up to 80%. Since domains are strongly related to the protein function itself, finding the domain sets between different species in various scenarios might give us insight on the gene clusters involved in diverse cellular processes. ​    +
- +
- +
-==== High Throughput Sequencing ==== +
- +
-Next-Generation Sequencing not only allows to sequence the "​average"​ genome of an organism using relatively little money and time, but it also supports the investigation of the genomes of single individuals. These data are the basis for new approaches in scientific and clinical research.\\  +
- +
-=== High-throughput analysis of T-cell and B-cell receptor repertoire data === +
-{{:​research:​immunosubs.jpg?​400 |}} +
-Highly variable cell surface receptors of B cells and T cells are, as part of the human immune system, responsible for fending of everyday molecular threats to human life, for example pathogenous infective agents. +
-Single nucleotide variation in the sequence of individual receptor molecules create a variable pool, the receptor repertoire, able to encounter the vast molecular variability of microbial pathogenic attack. Loss of variation in the receptor pool is thought to result in increasing susceptibility to severe infections possibly leading to death.  +
- +
-Analysis of the immune receptor repertoire for clinical and scientific research gains new insight into the unique and adaptive immune system. Function during health, infection, cancer, and autoimmune diseases project only small areas of target research.  +
-Historically,​ techniques to analyze immune repertoires were limited by the amount of circulating lymphocyte cells in blood (~10^6) and only the advent of high-throughtput sequencing (HTS) techniques made comprehensive analysis of this unique system feasible. Still the huge data sets resulting from nowadays technologies pose challenges to analysis by being prone to error at frequencies similar to the small quantities of rare receptor variants. We developed one of the first tools, [[http://​bibiserv.cebitec.uni-bielefeld.de/​tcrprofiler|TCRProfiler]],​ that is able to analyze HTS immune receptor data sets on single or multi-CPU systems. The tool aims to improve sequencing error correction and preparatory errors like PCR-induced single nucleotide substitution errors and produces comprehensive results in form of statistical compilation and visualization.\\  +
- +
-=== Structural Variations === +
- +
-{{:​sv.png?​nolink |Structural_Variations|}}Structural variations in human genomes, such as insertions, deletions, or rearrangements,​ play an important role in cancer development. Next-Generation Sequencing (NGS) technologies have been central in providing ways to detect such variations, e.g. by paired-end mapping.  +
-Many tools exists to efficiently and accurately call variations from a given NGS sample with respect to a reference genome, and straight-forward approaches became accepted to compare a call set to entries in variant databases or to other call sets. We focus on the precision work: +
-(1) By modeling a mixture of several cell-lines, we want to detect and unravel **overlapping** variations. Our deletion detection tool [[http://​bibiserv.techfak.uni-bielefeld.de/​agglodel|AggloIndel]] is specifically designed to cluster short-read paired-end data into possibly overlapping predictions. +
-(2) We address the combined problem of inaccurately predicted breakpoints and repeat-induced **ambiguities**. Given a reference sequence ''​...ACTGCTGCA...'',​ both deleting the first ''​CTG''​ at or deleting the last ''​TGC''​ results in exactly the same sequence ''​...ACTGCA...''​ and should thus be considered //​equivalent//​ although not even overlapping. Our tool [[https://​bitbucket.org/​readdi/​readdi|REDDY]] allows an error-tolerant and repeat-aware comparison of different sets of deletions or insertions, considering duplicates within one set as well. +
-==== Computational Metagenomics ==== +
- +
-{{:​mgx.png?​nolink |MGX|}}Metagenomics studies microbial communities in their natural environment. The MGX project aims at the design and implementation of a novel analysis platform for metagenomics data, which will provide the necessary infrastructure to cope with the large amounts of sequence data and offer easy mechanisms for the inclusion of novel algorithms into the platform. Upon release, the platform will feature analysis capabilities employing state-of-the-art methods and high-quality result visualizations,​ thereby enabling researchers to easily obtain answers to their scientific questions.\\  +
- +
-=== Metatranscriptomics === +
- +
-{{:​metatranscriptomics.png?​nolink |metranscriptomics|}}Metatranscriptomics is a relatively new field of research in microbiology and gives the opportunity to study communities of microorganisms using the RNA of all microorganism present in an environment. In contrast to metagenomics the focus does not lie on the potential of the community, but on their actual activity. So the sequence reads must be analyzed based on function and taxonomy. In this exciting field, our research is directed at the analysis, visualization and the comparison of metatranscriptomes.\\  +
- +
-=== Chimera Prediction in Amplicon Sequencing Data ===+
  
-{{:​chimera_diagonal_forward.png?​nolink |chimera|}}Amplicon sequencing is often used to analyze the composition of a +=== SANS-ambages ===
-bacterial community, using e.g. the 16S rRNA marker gene. Prior to sequencing,​ +
-the DNA is amplified via PCR where chimeras can arise. These are +
-artificial, single-stranded DNA sequences formed by cross hybridization of +
-different DNA +
-sequences during the amplification process. When not removed from the data, +
-chimeras can have a +
-falsifying influence on the consecutive analysis.\\ +
-We developed ChimP, a method that identifies chimeras and the sequences +
-they arose from in a set of NGS amplicon reads. +
-Our algorithm identifies a chimera by aligning a query sequence to a +
-multiple alignment of similar sequences with the Jumping Alignment +
-algorithm. If the alignment of a putative chimeric query ‘jumps’ between the +
-rows of the +
-multiple alignment and a specific score threshold is reached, the query is marked +
-as chimeric.+
  
-==== Metabolomics & Mass Spectrometry ====+{{research:​sans.png?​nolink |SANS-ambages| }}We maintain a software tool for alignment-free,​ whole-genome based phylogenomics implementing the SANS approach (see above: "​Sequence-based Phylogenomics"​). The current version "SANS ambages"​ (**a**bundance-filter,​ **m**ulti-threading and **b**ootstrapping 
 +on **a**mino-acid or **ge**nomic **s**equences) provides several new features: 
 +besides processing DNA sequences (whole genomes or assemblies),​ SANS ambages can also work on amino acid level taking protein 
 +sequences (translated or untranslated) as input. Further, the ability to process read data has been enhanced by the option to filter out low-abundant sequence segments. Multiple input sequences can be processed in parallel, and bootstrapping allows to augment the output with confidence values. 
 +SANS is hosted as a [[https://​www.denbi.de|de.NBI]] service and can easily be obtained from our [[https://​gitlab.ub.uni-bielefeld.de/​gi/​sans|Gitlab]] repository.
  
-{{:​unaligned-tics.png?​nolink |unaligned-tics|}}\\ {{:​aligned-tics.png?​nolink |aligned-tics|}}Modern analytical methods, such as GC-MS or LC-MS, produce high-dimensional data whose manual comparison is impossible. Our [[http://​bibiserv.techfak.uni-bielefeld.de/​chroma/​|ChromA]] software allows to align multiple experiments using a dynamic time warping procedure in conjunction with a-priori chemical knowledge.+=== SOCKS & PanBench ===
  
-{{:Mastermix_boundary.png?nolink |Mastermix_boundary|}}Moreoverwe have developed ​the web-based [[https://meltdb.cebitec.uni-bielefeld.de|MeltDB]] platform that provides a complete solution ​for the analysis ​and integration ​of metabolomics experimental dataMELTDB is coupled to CHROMA ​and other CeBiTec ​tools, ​such as GENDB and EMMA.+<​html>​ 
 +  <p style="​margin-top0.5em; margin-bottom:​ 0.5em;">​ 
 +    A major challenge in computational pangenomics is the memory- and time-efficient analysis of multiple genomes in parallel. Many software tools used in the current research follow the idea of colored <​i>​k</​i>​-mer sets to efficiently index and query a large collection of stringsbut use different strategies when it comes to the implementation. The aim of this project is to evaluate the different solutions and establish a standard interface. 
 +  </​p>​ 
 +  <p style="​margin-top: 0.5em; margin-bottom:​ 0.5em;">​ 
 +    The <span style="​font-weight:​ 500;">​SOCKS</​span>​ interface (<​u>​So</​u>​ftware for <​u>​c</​u>​olored <​u><​i>​k</​i></​u>​-mer sets) defines a common set of core features and standard input and output formats that software tools in computational pangenomics should implement. It aims to enhance the comparability and interoperability of these tools for the benefit of both developers and users. A detailed description of the interface including some examples can be found on the dedicated <a href="https://panbench.eu/​interface/">​project page</​a>​. 
 +  </​p>​ 
 +  <p style="​margin-top: 0.5em; margin-bottom:​ 0.5em;">​ 
 +    <span style="​font-weight:​ 500;">​PanBench</​span>​ (<​u>​Pan</​u>​genomics <​u>​Bench</​u>​mark and Workbench) is an open catalog of software tools for computational pangenomics ​and is an example ​of what such a common interface makes possibleIt allows users and developers to search for tools by different criteria, compare the performance of these tools, and test each tool in a user-friendly <a href="​https://​panbench.eu/​tools/">​web interface</​a>​ before downloading and installing the software on their local machine. 
 +  </​p>​ 
 +<svg style="​appearance:​ auto; display: block; opacity: 1; margin: auto; max-width: 99%; max-height: 16em;" viewBox="​0 0 2214 733" xmlns="​http://​www.w3.org/​2000/​svg"​ xmlns:​xlink="​http://​www.w3.org/​1999/​xlink"​ xml:​space="​preserve"​ overflow="​hidden"><​g transform="​translate(-334 -747)"><​g><​path d="​M603.5 1217.21 663.733 1217.21 663.733 1221.79 603.5 1221.79ZM659.15 1205.75 686.65 1219.5 659.15 1233.25Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M875.5 1215.21 935.733 1215.21 935.733 1219.79 875.5 1219.79ZM931.15 1203.75 958.65 1217.5 931.15 1231.25Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1148.5 1215.21 1210.84 1215.21 1210.84 1219.79 1148.5 1219.79ZM1206.26 1203.75 1233.76 1217.5 1206.26 1231.25Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M2.11369-0.885465 73.8102 170.261 69.5829 172.032-2.11369 0.885465ZM82.6077 161.606 80.5512 192.283 57.2435 172.232Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"​ transform="​matrix(1 0 0 -1 1427.5 1219.78)"/><​path d="​M1700.5 1030.21 1762.84 1030.21 1762.84 1034.79 1700.5 1034.79ZM1758.26 1018.75 1785.76 1032.5 1758.26 1046.25Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1974.5 1030.21 2036.84 1030.21 2036.84 1034.79 1974.5 1034.79ZM2032.26 1018.75 2059.76 1032.5 2032.26 1046.25Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M2252.61 1025.61 2325.59 1199.37 2321.36 1201.14 2248.39 1027.39ZM2334.38 1190.7 2332.35 1221.38 2309.02 1201.35Z"​ fill="#​8B2F3D"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1429.63 1224.65 1501.67 1404.75 1497.41 1406.45 1425.37 1226.35ZM1510.6 1396.24 1508.05 1426.88 1485.07 1406.45Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1700.5 1416.21 1762.84 1416.21 1762.84 1420.79 1700.5 1420.79ZM1758.26 1404.75 1785.76 1418.5 1758.26 1432.25Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1974.5 1416.21 2036.84 1416.21 2036.84 1420.79 1974.5 1420.79ZM2032.26 1404.75 2059.76 1418.5 2032.26 1432.25Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1510.5 1383C1510.5 1373.34 1518.34 1365.5 1528 1365.5L1683 1365.5C1692.66 1365.5 1700.5 1373.34 1700.5 1383L1700.5 1453C1700.5 1462.66 1692.66 1470.5 1683 1470.5L1528 1470.5C1518.34 1470.5 1510.5 1462.66 1510.5 1453Z" stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F7E8D7"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M1784.5 1382C1784.5 1372.34 1792.34 1364.5 1802 1364.5L1957 1364.5C1966.66 1364.5 1974.5 1372.34 1974.5 1382L1974.5 1452C1974.5 1461.66 1966.66 1469.5 1957 1469.5L1802 1469.5C1792.34 1469.5 1784.5 1461.66 1784.5 1452Z" stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F7E8D7"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M1510.5 997.167C1510.5 987.41 1518.41 979.5 1528.17 979.5L1682.83 979.5C1692.59 979.5 1700.5 987.41 1700.5 997.167L1700.5 1067.83C1700.5 1077.59 1692.59 1085.5 1682.83 1085.5L1528.17 1085.5C1518.41 1085.5 1510.5 1077.59 1510.5 1067.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F2D8DC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M1784.5 996.167C1784.5 986.41 1792.41 978.5 1802.17 978.5L1956.83 978.5C1966.59 978.5 1974.5 986.41 1974.5 996.167L1974.5 1066.83C1974.5 1076.59 1966.59 1084.5 1956.83 1084.5L1802.17 1084.5C1792.41 1084.5 1784.5 1076.59 1784.5 1066.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F2D8DC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M2059.5 996.167C2059.5 986.41 2067.41 978.5 2077.17 978.5L2230.83 978.5C2240.59 978.5 2248.5 986.41 2248.5 996.167L2248.5 1066.83C2248.5 1076.59 2240.59 1084.5 2230.83 1084.5L2077.17 1084.5C2067.41 1084.5 2059.5 1076.59 2059.5 1066.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F2D8DC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​1"​ font-family="​LM Sans 10,LM Sans 10_MSFontService,​sans-serif"​ font-style="​normal"​ font-variant="​normal"​ font-weight="​400"​ font-stretch="​normal"​ font-size="​73"​ text-anchor="​start"​ direction="​ltr"​ writing-mode="​lr-tb"​ unicode-bidi="​normal"​ text-decoration="​none"​ transform="​matrix(1 0 0 1 435.312 1240)">​ATG</​text><​path d="​M414.5 1183C414.5 1173.34 422.335 1165.5 432 1165.5L586 1165.5C595.665 1165.5 603.5 1173.34 603.5 1183L603.5 1253C603.5 1262.66 595.665 1270.5 586 1270.5L432 1270.5C422.335 1270.5 414.5 1262.66 414.5 1253Z" stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="​none"​ fill-rule="​evenodd"/><​text fill="#​000000"​ fill-opacity="​1"​ font-family="​LM Sans 10,LM Sans 10_MSFontService,​sans-serif"​ font-style="​normal"​ font-variant="​normal"​ font-weight="​400"​ font-stretch="​normal"​ font-size="​73"​ text-anchor="​start"​ direction="​ltr"​ writing-mode="​lr-tb"​ unicode-bidi="​normal"​ text-decoration="​none"​ transform="​matrix(1 0 0 1 708.005 1242)">​TGT</​text><​path d="​M687.5 1185C687.5 1175.34 695.335 1167.5 705 1167.5L859 1167.5C868.665 1167.5 876.5 1175.34 876.5 1185L876.5 1255C876.5 1264.66 868.665 1272.5 859 1272.5L705 1272.5C695.335 1272.5 687.5 1264.66 687.5 1255Z" stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="​none"​ fill-rule="​evenodd"/><​path d="​M608.5 1226.21 668.733 1226.21 668.733 1230.79 608.5 1230.79ZM664.15 1214.75 691.65 1228.5 664.149 1242.25Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​1"​ font-family="​LM Sans 10,LM Sans 10_MSFontService,​sans-serif"​ font-style="​normal"​ font-variant="​normal"​ font-weight="​400"​ font-stretch="​normal"​ font-size="​73"​ text-anchor="​start"​ direction="​ltr"​ writing-mode="​lr-tb"​ unicode-bidi="​normal"​ text-decoration="​none"​ transform="​matrix(1 0 0 1 978.177 1239)">​GTC</​text><​path d="​M957.5 1181.17C957.5 1171.41 965.41 1163.5 975.167 1163.5L1128.83 1163.5C1138.59 1163.5 1146.5 1171.41 1146.5 1181.17L1146.5 1251.83C1146.5 1261.59 1138.59 1269.5 1128.83 1269.5L975.167 1269.5C965.41 1269.5 957.5 1261.59 957.5 1251.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="​none"​ fill-rule="​evenodd"/><​path d="​M879.5 1223.21 939.733 1223.21 939.733 1227.79 879.5 1227.79ZM935.15 1211.75 962.65 1225.5 935.15 1239.25Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​1"​ font-family="​LM Sans 10,LM Sans 10_MSFontService,​sans-serif"​ font-style="​normal"​ font-variant="​normal"​ font-weight="​400"​ font-stretch="​normal"​ font-size="​73"​ text-anchor="​start"​ direction="​ltr"​ writing-mode="​lr-tb"​ unicode-bidi="​normal"​ text-decoration="​none"​ transform="​matrix(1 0 0 1 1254.67 1239)">​TCA</​text><​path d="​M1233.5 1181.17C1233.5 1171.41 1241.41 1163.5 1251.17 1163.5L1405.83 1163.5C1415.59 1163.5 1423.5 1171.41 1423.5 1181.17L1423.5 1251.83C1423.5 1261.59 1415.59 1269.5 1405.83 1269.5L1251.17 1269.5C1241.41 1269.5 1233.5 1261.59 1233.5 1251.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="​none"​ fill-rule="​evenodd"/><​path d="​M1152.5 1223.21 1214.84 1223.21 1214.84 1227.79 1152.5 1227.79ZM1210.26 1211.75 1237.76 1225.5 1210.26 1239.25Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"/><​path d="​M1602.13 1009.18C1601.62 1011.88 1599.35 1018.09 1597.82 1022.39 1594.1 1032.83 1596.8 1025.17 1593.08 1035.61L1611.18 1035.61 1604.54 1016.84C1602.86 1012.03 1602.35 1010.2 1602.2 1009.18ZM1599.57 1003.92 1606 1003.92 1625.05 1054.59 1618.33 1054.59 1612.79 1039.69 1591.54 1039.69 1585.92 1054.59 1580.52 1054.59ZM1559.82 1003.05C1562.16 1003.05 1564.49 1003.19 1566.76 1003.63 1569.09 1004.07 1571.35 1004.8 1573.54 1005.68L1572.52 1011.66C1570.62 1010.35 1568.58 1009.25 1566.39 1008.6 1564.27 1007.94 1562.01 1007.72 1559.82 1007.72 1555.08 1007.72 1550.77 1010.27 1547.78 1014 1544.42 1018.3 1542.81 1023.78 1542.81 1029.25 1542.81 1034.73 1544.42 1040.13 1547.78 1044.44 1550.77 1048.16 1555.08 1050.72 1559.82 1050.72 1562.3 1050.72 1564.86 1050.64 1567.19 1049.84 1569.68 1049.11 1571.79 1047.72 1573.91 1046.26L1574.35 1051.3C1572.16 1052.61 1569.89 1053.93 1567.41 1054.59 1564.93 1055.32 1562.38 1055.39 1559.82 1055.39 1553.4 1055.39 1547.48 1052.47 1543.18 1047.72 1538.65 1042.69 1536.31 1036.04 1536.31 1029.25 1536.31 1022.47 1538.65 1015.82 1543.18 1010.71 1547.48 1005.97 1553.4 1003.05 1559.82 1003.05Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1536.31"​ y="​1048.85">​CA</​text><​path d="​M1655.5 1003.05C1658.05 1003.05 1660.61 1003.27 1663.09 1003.85 1665.57 1004.51 1667.98 1005.46 1670.24 1006.7L1669.15 1012.68C1667.25 1011.08 1665.13 1009.69 1662.72 1008.89 1660.39 1008.01 1657.98 1007.72 1655.5 1007.72 1650.75 1007.72 1646.45 1010.27 1643.45 1014 1640.09 1018.3 1638.49 1023.78 1638.49 1029.25 1638.49 1034.73 1640.09 1040.13 1643.45 1044.44 1646.45 1048.16 1650.75 1050.72 1655.5 1050.72 1658.78 1050.72 1662.07 1050.21 1665.13 1049.18L1665.13 1037.14 1655.5 1037.14 1655.5 1032.69 1670.83 1032.69 1670.83 1051.81C1666.08 1054.15 1660.83 1055.39 1655.5 1055.39 1649.15 1055.39 1643.16 1052.47 1638.85 1047.72 1634.33 1042.69 1631.99 1036.04 1631.99 1029.25 1631.99 1022.47 1634.33 1015.82 1638.85 1010.71 1643.16 1005.97 1649.15 1003.05 1655.5 1003.05Z"​ stroke="#​BA3F51"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​8B2F3D"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1631.99"​ y="​1048.85">​G</​text><​path d="​M1829.42 1008.13C1828.91 1010.83 1826.64 1017.03 1825.11 1021.34 1821.39 1031.78 1824.09 1024.11 1820.37 1034.55L1838.47 1034.55 1831.83 1015.79C1830.15 1010.97 1829.64 1009.15 1829.49 1008.13ZM1826.86 1002.87 1833.29 1002.87 1852.34 1053.53 1845.62 1053.53 1840.08 1038.64 1818.83 1038.64 1813.21 1053.53 1807.81 1053.53Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​50.662"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1807.81"​ y="​1047.2">​A</​text><​path d="​M1882.79 1002C1885.34 1002 1887.9 1002.21 1890.38 1002.8 1892.86 1003.46 1895.27 1004.4 1897.53 1005.65L1896.44 1011.63C1894.54 1010.03 1892.42 1008.64 1890.02 1007.84 1887.68 1006.96 1885.27 1006.67 1882.79 1006.67 1878.04 1006.67 1873.74 1009.22 1870.74 1012.95 1867.39 1017.25 1865.78 1022.73 1865.78 1028.2 1865.78 1033.68 1867.39 1039.08 1870.74 1043.39 1873.74 1047.11 1878.04 1049.66 1882.79 1049.66 1886.07 1049.66 1889.36 1049.15 1892.42 1048.13L1892.42 1036.09 1882.79 1036.09 1882.79 1031.63 1898.12 1031.63 1898.12 1050.76C1893.37 1053.1 1888.12 1054.34 1882.79 1054.34 1876.44 1054.34 1870.45 1051.42 1866.14 1046.67 1861.62 1041.63 1859.28 1034.99 1859.28 1028.2 1859.28 1021.41 1861.62 1014.77 1866.14 1009.66 1870.45 1004.92 1876.44 1002 1882.79 1002Z" stroke="#​BA3F51"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​8B2F3D"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1859.28"​ y="​1047.79">​G</​text><​path d="​M1931.49 1002C1933.82 1002 1936.16 1002.14 1938.42 1002.58 1940.76 1003.02 1943.02 1003.75 1945.21 1004.62L1944.19 1010.61C1942.29 1009.3 1940.25 1008.2 1938.06 1007.54 1935.94 1006.89 1933.68 1006.67 1931.49 1006.67 1926.74 1006.67 1922.43 1009.22 1919.44 1012.95 1916.08 1017.25 1914.48 1022.73 1914.48 1028.2 1914.48 1033.68 1916.08 1039.08 1919.44 1043.39 1922.43 1047.11 1926.74 1049.66 1931.49 1049.66 1933.97 1049.66 1936.52 1049.59 1938.86 1048.79 1941.34 1048.06 1943.46 1046.67 1945.58 1045.21L1946.01 1050.25C1943.82 1051.56 1941.56 1052.88 1939.08 1053.53 1936.6 1054.26 1934.04 1054.34 1931.49 1054.34 1925.06 1054.34 1919.15 1051.42 1914.84 1046.67 1910.32 1041.63 1907.98 1034.99 1907.98 1028.2 1907.98 1021.41 1910.32 1014.77 1914.84 1009.66 1919.15 1004.92 1925.06 1002 1931.49 1002Z" stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1907.98"​ y="​1047.79">​C</​text><​path d="​M2108.36 1002C2110.91 1002 2113.47 1002.21 2115.95 1002.8 2118.43 1003.46 2120.84 1004.4 2123.11 1005.65L2122.01 1011.63C2120.11 1010.03 2118 1008.64 2115.59 1007.84 2113.25 1006.96 2110.84 1006.67 2108.36 1006.67 2103.61 1006.67 2099.31 1009.22 2096.31 1012.95 2092.96 1017.25 2091.35 1022.73 2091.35 1028.2 2091.35 1033.68 2092.96 1039.08 2096.31 1043.39 2099.31 1047.11 2103.61 1049.66 2108.36 1049.66 2111.64 1049.66 2114.93 1049.15 2118 1048.13L2118 1036.09 2108.36 1036.09 2108.36 1031.63 2123.69 1031.63 2123.69 1050.76C2118.94 1053.1 2113.69 1054.34 2108.36 1054.34 2102.01 1054.34 2096.02 1051.42 2091.72 1046.67 2087.19 1041.63 2084.85 1034.99 2084.85 1028.2 2084.85 1021.41 2087.19 1014.77 2091.72 1009.66 2096.02 1004.92 2102.01 1002 2108.36 1002Z" stroke="#​BA3F51"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​8B2F3D"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2084.85"​ y="​1047.79">​G</​text><​path d="​M2178.34 1003.31 2222.73 1003.31 2222.73 1008.05 2212.94 1008.05C2212.07 1008.05 2211.19 1007.98 2210.31 1007.98L2203.82 1007.98 2203.82 1053.53 2197.32 1053.53 2197.32 1007.98 2190.75 1007.98C2189.88 1007.98 2189 1008.05 2188.12 1008.05L2178.34 1008.05ZM2157.06 1002C2159.39 1002 2161.73 1002.14 2163.99 1002.58 2166.33 1003.02 2168.59 1003.75 2170.78 1004.62L2169.76 1010.61C2167.86 1009.3 2165.82 1008.2 2163.63 1007.54 2161.51 1006.89 2159.25 1006.67 2157.06 1006.67 2152.31 1006.67 2148.01 1009.22 2145.01 1012.95 2141.65 1017.25 2140.05 1022.73 2140.05 1028.2 2140.05 1033.68 2141.65 1039.08 2145.01 1043.39 2148.01 1047.11 2152.31 1049.66 2157.06 1049.66 2159.54 1049.66 2162.09 1049.59 2164.43 1048.79 2166.91 1048.06 2169.03 1046.67 2171.15 1045.21L2171.58 1050.25C2169.39 1051.56 2167.13 1052.88 2164.65 1053.53 2162.17 1054.26 2159.61 1054.34 2157.06 1054.34 2150.63 1054.34 2144.72 1051.42 2140.41 1046.67 2135.89 1041.63 2133.55 1034.99 2133.55 1028.2 2133.55 1021.41 2135.89 1014.77 2140.41 1009.66 2144.72 1004.92 2150.63 1002 2157.06 1002Z" stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2133.55"​ y="​1047.79">​CT</​text><​text fill="#​000000"​ fill-opacity="​1"​ font-family="​LM Sans 10,LM Sans 10_MSFontService,​sans-serif"​ font-style="​normal"​ font-variant="​normal"​ font-weight="​400"​ font-stretch="​normal"​ font-size="​73"​ text-anchor="​start"​ direction="​ltr"​ writing-mode="​lr-tb"​ unicode-bidi="​normal"​ text-decoration="​none"​ transform="​matrix(1 0 0 1 2356 1239)">​CTA</​text><​path d="​M2335.5 1181.17C2335.5 1171.41 2343.41 1163.5 2353.17 1163.5L2506.83 1163.5C2516.59 1163.5 2524.5 1171.41 2524.5 1181.17L2524.5 1251.83C2524.5 1261.59 2516.59 1269.5 2506.83 1269.5L2353.17 1269.5C2343.41 1269.5 2335.5 1261.59 2335.5 1251.83Z"​ stroke="#​BA3F51"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="​none"​ fill-rule="​evenodd"/><​path d="​M2.10868-0.897336 77.5841 176.465 73.3668 178.259-2.10868 0.897336ZM86.3329 167.761 84.4488 198.449 61.0287 178.529Z"​ fill="#​A96A22"​ fill-rule="​nonzero"​ fill-opacity="​1"​ transform="​matrix(1 0 0 -1 2250.5 1420.95)"/><​path d="​M419.5 1191.17C419.5 1181.41 427.41 1173.5 437.167 1173.5L590.833 1173.5C600.59 1173.5 608.5 1181.41 608.5 1191.17L608.5 1261.83C608.5 1271.59 600.59 1279.5 590.833 1279.5L437.167 1279.5C427.41 1279.5 419.5 1271.59 419.5 1261.83Z"​ stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​ECECEC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M458.964 1203.12C458.453 1205.82 456.19 1212.03 454.657 1216.34 450.934 1226.77 453.635 1219.11 449.912 1229.55L468.016 1229.55 461.373 1210.79C459.694 1205.97 459.183 1204.14 459.037 1203.12ZM486.638 1198.3 531.022 1198.3 531.022 1203.05 521.24 1203.05C520.364 1203.05 519.488 1202.98 518.612 1202.98L512.115 1202.98 512.115 1248.53 505.618 1248.53 505.618 1202.98 499.048 1202.98C498.172 1202.98 497.296 1203.05 496.42 1203.05L486.638 1203.05ZM456.409 1197.87 462.833 1197.87 481.886 1248.53 475.17 1248.53 469.622 1233.64 448.379 1233.64 442.758 1248.53 437.356 1248.53ZM562.178 1196.99C564.733 1196.99 567.288 1197.21 569.77 1197.79 572.252 1198.45 574.661 1199.4 576.924 1200.64L575.829 1206.63C573.931 1205.02 571.814 1203.63 569.405 1202.83 567.069 1201.95 564.66 1201.66 562.178 1201.66 557.433 1201.66 553.126 1204.22 550.133 1207.94 546.775 1212.25 545.169 1217.72 545.169 1223.2 545.169 1228.67 546.775 1234.07 550.133 1238.38 553.126 1242.1 557.433 1244.66 562.178 1244.66 565.463 1244.66 568.748 1244.15 571.814 1243.13L571.814 1231.08 562.178 1231.08 562.178 1226.63 577.508 1226.63 577.508 1245.75C572.763 1248.09 567.507 1249.33 562.178 1249.33 555.827 1249.33 549.841 1246.41 545.534 1241.67 541.008 1236.63 538.672 1229.99 538.672 1223.2 538.672 1216.41 541.008 1209.77 545.534 1204.66 549.841 1199.91 555.827 1196.99 562.178 1196.99Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​437.356"​ y="​1242.79">​ATG</​text><​path d="​M691.5 1193.17C691.5 1183.41 699.41 1175.5 709.167 1175.5L863.833 1175.5C873.59 1175.5 881.5 1183.41 881.5 1193.17L881.5 1263.83C881.5 1273.59 873.59 1281.5 863.833 1281.5L709.167 1281.5C699.41 1281.5 691.5 1273.59 691.5 1263.83Z"​ stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​ECECEC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M809.175 1200.26 853.559 1200.26 853.559 1205 843.777 1205C842.901 1205 842.025 1204.93 841.149 1204.93L834.652 1204.93 834.652 1250.48 828.155 1250.48 828.155 1204.93 821.585 1204.93C820.709 1204.93 819.833 1205 818.957 1205L809.175 1205ZM710.633 1200.26 755.018 1200.26 755.018 1205 745.235 1205C744.359 1205 743.484 1204.93 742.607 1204.93L736.11 1204.93 736.11 1250.48 729.613 1250.48 729.613 1204.93 723.044 1204.93C722.167 1204.93 721.292 1205 720.415 1205L710.633 1205ZM786.173 1198.94C788.728 1198.94 791.283 1199.16 793.765 1199.75 796.247 1200.4 798.656 1201.35 800.919 1202.59L799.824 1208.58C797.926 1206.97 795.809 1205.59 793.4 1204.78 791.064 1203.91 788.655 1203.62 786.173 1203.62 781.428 1203.62 777.121 1206.17 774.128 1209.89 770.77 1214.2 769.164 1219.68 769.164 1225.15 769.164 1230.63 770.77 1236.03 774.128 1240.34 777.121 1244.06 781.428 1246.61 786.173 1246.61 789.458 1246.61 792.743 1246.1 795.809 1245.08L795.809 1233.04 786.173 1233.04 786.173 1228.58 801.503 1228.58 801.503 1247.71C796.758 1250.04 791.502 1251.29 786.173 1251.29 779.822 1251.29 773.836 1248.37 769.529 1243.62 765.003 1238.58 762.667 1231.94 762.667 1225.15 762.667 1218.36 765.003 1211.72 769.529 1206.61 773.836 1201.86 779.822 1198.94 786.173 1198.94Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​710.633"​ y="​1244.74">​TGT</​text><​path d="​M961.5 1189.17C961.5 1179.41 969.41 1171.5 979.167 1171.5L1133.83 1171.5C1143.59 1171.5 1151.5 1179.41 1151.5 1189.17L1151.5 1259.83C1151.5 1269.59 1143.59 1277.5 1133.83 1277.5L979.167 1277.5C969.41 1277.5 961.5 1269.59 961.5 1259.83Z"​ stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​ECECEC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M1029.5 1196.93 1073.89 1196.93 1073.89 1201.67 1064.1 1201.67C1063.23 1201.67 1062.35 1201.6 1061.48 1201.6L1054.98 1201.6 1054.98 1247.15 1048.48 1247.15 1048.48 1201.6 1041.91 1201.6C1041.04 1201.6 1040.16 1201.67 1039.29 1201.67L1029.5 1201.67ZM1105.04 1195.61C1107.38 1195.61 1109.71 1195.76 1111.98 1196.2 1114.31 1196.64 1116.58 1197.37 1118.77 1198.24L1117.74 1204.23C1115.85 1202.91 1113.8 1201.82 1111.61 1201.16 1109.5 1200.51 1107.23 1200.29 1105.04 1200.29 1100.3 1200.29 1095.99 1202.84 1093 1206.56 1089.64 1210.87 1088.03 1216.35 1088.03 1221.82 1088.03 1227.3 1089.64 1232.7 1093 1237.01 1095.99 1240.73 1100.3 1243.28 1105.04 1243.28 1107.52 1243.28 1110.08 1243.21 1112.42 1242.41 1114.9 1241.68 1117.01 1240.29 1119.13 1238.83L1119.57 1243.87C1117.38 1245.18 1115.12 1246.5 1112.63 1247.15 1110.15 1247.88 1107.6 1247.96 1105.04 1247.96 1098.62 1247.96 1092.71 1245.04 1088.4 1240.29 1083.87 1235.25 1081.54 1228.61 1081.54 1221.82 1081.54 1215.03 1083.87 1208.39 1088.4 1203.28 1092.71 1198.53 1098.62 1195.61 1105.04 1195.61ZM1006.5 1195.61C1009.06 1195.61 1011.61 1195.83 1014.09 1196.42 1016.58 1197.07 1018.98 1198.02 1021.25 1199.26L1020.15 1205.25C1018.25 1203.64 1016.14 1202.26 1013.73 1201.45 1011.39 1200.58 1008.98 1200.29 1006.5 1200.29 1001.76 1200.29 997.449 1202.84 994.456 1206.56 991.098 1210.87 989.492 1216.35 989.492 1221.82 989.492 1227.3 991.098 1232.7 994.456 1237.01 997.449 1240.73 1001.76 1243.28 1006.5 1243.28 1009.79 1243.28 1013.07 1242.77 1016.14 1241.75L1016.14 1229.71 1006.5 1229.71 1006.5 1225.25 1021.83 1225.25 1021.83 1244.38C1017.09 1246.71 1011.83 1247.96 1006.5 1247.96 1000.15 1247.96 994.164 1245.04 989.857 1240.29 985.331 1235.25 982.995 1228.61 982.995 1221.82 982.995 1215.03 985.331 1208.39 989.857 1203.28 994.164 1198.53 1000.15 1195.61 1006.5 1195.61Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​982.995"​ y="​1241.41">​GTC</​text><​path d="​M1238.5 1189.17C1238.5 1179.41 1246.41 1171.5 1256.17 1171.5L1409.83 1171.5C1419.59 1171.5 1427.5 1179.41 1427.5 1189.17L1427.5 1259.83C1427.5 1269.59 1419.59 1277.5 1409.83 1277.5L1256.17 1277.5C1246.41 1277.5 1238.5 1269.59 1238.5 1259.83Z"​ stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​ECECEC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M1375.15 1201.75C1374.64 1204.45 1372.37 1210.65 1370.84 1214.96 1367.12 1225.4 1369.82 1217.73 1366.09 1228.17L1384.2 1228.17 1377.56 1209.41C1375.88 1204.59 1375.37 1202.77 1375.22 1201.75ZM1257.3 1196.93 1301.68 1196.93 1301.68 1201.67 1291.9 1201.67C1291.03 1201.67 1290.15 1201.6 1289.27 1201.6L1282.78 1201.6 1282.78 1247.15 1276.28 1247.15 1276.28 1201.6 1269.71 1201.6C1268.83 1201.6 1267.96 1201.67 1267.08 1201.67L1257.3 1201.67ZM1372.59 1196.49 1379.02 1196.49 1398.07 1247.15 1391.35 1247.15 1385.8 1232.26 1364.56 1232.26 1358.94 1247.15 1353.54 1247.15ZM1332.84 1195.61C1335.17 1195.61 1337.51 1195.76 1339.77 1196.2 1342.11 1196.64 1344.37 1197.37 1346.56 1198.24L1345.54 1204.23C1343.64 1202.91 1341.6 1201.82 1339.41 1201.16 1337.29 1200.51 1335.03 1200.29 1332.84 1200.29 1328.09 1200.29 1323.79 1202.84 1320.79 1206.56 1317.44 1210.87 1315.83 1216.35 1315.83 1221.82 1315.83 1227.3 1317.44 1232.7 1320.79 1237.01 1323.79 1240.73 1328.09 1243.28 1332.84 1243.28 1335.32 1243.28 1337.88 1243.21 1340.21 1242.41 1342.69 1241.68 1344.81 1240.29 1346.93 1238.83L1347.37 1243.87C1345.18 1245.18 1342.91 1246.5 1340.43 1247.15 1337.95 1247.88 1335.39 1247.96 1332.84 1247.96 1326.41 1247.96 1320.5 1245.04 1316.19 1240.29 1311.67 1235.25 1309.33 1228.61 1309.33 1221.82 1309.33 1215.03 1311.67 1208.39 1316.19 1203.28 1320.5 1198.53 1326.41 1195.61 1332.84 1195.61Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1257.3"​ y="​1241.41">​TCA</​text><​path d="​M1602.13 1394.92C1601.62 1397.62 1599.35 1403.83 1597.82 1408.13 1594.1 1418.57 1596.8 1410.91 1593.08 1421.35L1611.18 1421.35 1604.54 1402.59C1602.86 1397.77 1602.35 1395.94 1602.2 1394.92ZM1599.57 1389.67 1606 1389.67 1625.05 1440.33 1618.33 1440.33 1612.79 1425.44 1591.54 1425.44 1585.92 1440.33 1580.52 1440.33ZM1559.82 1388.79C1562.16 1388.79 1564.49 1388.94 1566.76 1389.37 1569.09 1389.81 1571.35 1390.54 1573.54 1391.42L1572.52 1397.4C1570.62 1396.09 1568.58 1394.99 1566.39 1394.34 1564.27 1393.68 1562.01 1393.46 1559.82 1393.46 1555.08 1393.46 1550.77 1396.02 1547.78 1399.74 1544.42 1404.05 1542.81 1409.52 1542.81 1415 1542.81 1420.47 1544.42 1425.87 1547.78 1430.18 1550.77 1433.9 1555.08 1436.46 1559.82 1436.46 1562.3 1436.46 1564.86 1436.39 1567.19 1435.58 1569.68 1434.85 1571.79 1433.46 1573.91 1432.01L1574.35 1437.04C1572.16 1438.36 1569.89 1439.67 1567.41 1440.33 1564.93 1441.06 1562.38 1441.13 1559.82 1441.13 1553.4 1441.13 1547.48 1438.21 1543.18 1433.46 1538.65 1428.43 1536.31 1421.79 1536.31 1415 1536.31 1408.21 1538.65 1401.56 1543.18 1396.45 1547.48 1391.71 1553.4 1388.79 1559.82 1388.79Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1536.31"​ y="​1434.59">​CA</​text><​path d="​M1655.5 1388.79C1657.83 1388.79 1660.17 1388.94 1662.43 1389.37 1664.77 1389.81 1667.03 1390.54 1669.22 1391.42L1668.2 1397.4C1666.3 1396.09 1664.26 1394.99 1662.07 1394.34 1659.95 1393.68 1657.69 1393.46 1655.5 1393.46 1650.75 1393.46 1646.45 1396.02 1643.45 1399.74 1640.09 1404.05 1638.49 1409.52 1638.49 1415 1638.49 1420.47 1640.09 1425.87 1643.45 1430.18 1646.45 1433.9 1650.75 1436.46 1655.5 1436.46 1657.98 1436.46 1660.53 1436.39 1662.87 1435.58 1665.35 1434.85 1667.47 1433.46 1669.59 1432.01L1670.02 1437.04C1667.83 1438.36 1665.57 1439.67 1663.09 1440.33 1660.61 1441.06 1658.05 1441.13 1655.5 1441.13 1649.07 1441.13 1643.16 1438.21 1638.85 1433.46 1634.33 1428.43 1631.99 1421.79 1631.99 1415 1631.99 1408.21 1634.33 1401.56 1638.85 1396.45 1643.16 1391.71 1649.07 1388.79 1655.5 1388.79Z"​ stroke="#​D78D38"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A96A22"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1631.99"​ y="​1434.59">​C</​text><​path d="​M1829.42 1393.87C1828.91 1396.57 1826.64 1402.78 1825.11 1407.08 1821.39 1417.52 1824.09 1409.86 1820.37 1420.3L1838.47 1420.3 1831.83 1401.53C1830.15 1396.72 1829.64 1394.89 1829.49 1393.87ZM1826.86 1388.61 1833.29 1388.61 1852.34 1439.28 1845.62 1439.28 1840.08 1424.38 1818.83 1424.38 1813.21 1439.28 1807.81 1439.28Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​50.662"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1807.81"​ y="​1432.94">​A</​text><​path d="​M1882.79 1387.74C1885.12 1387.74 1887.46 1387.88 1889.72 1388.32 1892.06 1388.76 1894.32 1389.49 1896.51 1390.36L1895.49 1396.35C1893.59 1395.04 1891.55 1393.94 1889.36 1393.29 1887.24 1392.63 1884.98 1392.41 1882.79 1392.41 1878.04 1392.41 1873.74 1394.96 1870.74 1398.69 1867.39 1402.99 1865.78 1408.47 1865.78 1413.94 1865.78 1419.42 1867.39 1424.82 1870.74 1429.13 1873.74 1432.85 1878.04 1435.41 1882.79 1435.41 1885.27 1435.41 1887.83 1435.33 1890.16 1434.53 1892.64 1433.8 1894.76 1432.41 1896.88 1430.95L1897.32 1435.99C1895.13 1437.3 1892.86 1438.62 1890.38 1439.28 1887.9 1440.01 1885.34 1440.08 1882.79 1440.08 1876.36 1440.08 1870.45 1437.16 1866.14 1432.41 1861.62 1427.38 1859.28 1420.73 1859.28 1413.94 1859.28 1407.16 1861.62 1400.51 1866.14 1395.4 1870.45 1390.66 1876.36 1387.74 1882.79 1387.74Z"​ stroke="#​D78D38"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A96A22"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1859.28"​ y="​1433.54">​C</​text><​path d="​M1929.77 1387.74C1932.1 1387.74 1934.44 1387.88 1936.7 1388.32 1939.04 1388.76 1941.3 1389.49 1943.49 1390.36L1942.47 1396.35C1940.57 1395.04 1938.53 1393.94 1936.34 1393.29 1934.22 1392.63 1931.96 1392.41 1929.77 1392.41 1925.02 1392.41 1920.72 1394.96 1917.72 1398.69 1914.36 1402.99 1912.76 1408.47 1912.76 1413.94 1912.76 1419.42 1914.36 1424.82 1917.72 1429.13 1920.72 1432.85 1925.02 1435.41 1929.77 1435.41 1932.25 1435.41 1934.8 1435.33 1937.14 1434.53 1939.62 1433.8 1941.74 1432.41 1943.86 1430.95L1944.29 1435.99C1942.1 1437.3 1939.84 1438.62 1937.36 1439.28 1934.88 1440.01 1932.32 1440.08 1929.77 1440.08 1923.34 1440.08 1917.43 1437.16 1913.12 1432.41 1908.6 1427.38 1906.26 1420.73 1906.26 1413.94 1906.26 1407.16 1908.6 1400.51 1913.12 1395.4 1917.43 1390.66 1923.34 1387.74 1929.77 1387.74Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1906.26"​ y="​1433.54">​C</​text><​path d="​M2339.5 1190C2339.5 1180.34 2347.34 1172.5 2357 1172.5L2512 1172.5C2521.66 1172.5 2529.5 1180.34 2529.5 1190L2529.5 1260C2529.5 1269.67 2521.66 1277.5 2512 1277.5L2357 1277.5C2347.34 1277.5 2339.5 1269.67 2339.5 1260Z" stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​ECECEC"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M2480.99 1201.8C2480.48 1204.5 2478.22 1210.71 2476.68 1215.01 2472.96 1225.45 2475.66 1217.79 2471.94 1228.23L2490.04 1228.23 2483.4 1209.46C2481.72 1204.65 2481.21 1202.82 2481.06 1201.8ZM2410.12 1196.98 2454.51 1196.98 2454.51 1201.73 2444.73 1201.73C2443.85 1201.73 2442.97 1201.65 2442.1 1201.65L2435.6 1201.65 2435.6 1247.21 2429.1 1247.21 2429.1 1201.65 2422.53 1201.65C2421.66 1201.65 2420.78 1201.73 2419.91 1201.73L2410.12 1201.73ZM2478.44 1196.54 2484.86 1196.54 2503.91 1247.21 2497.2 1247.21 2491.65 1232.31 2470.41 1232.31 2464.79 1247.21 2459.38 1247.21ZM2388.84 1195.67C2391.18 1195.67 2393.51 1195.81 2395.78 1196.25 2398.11 1196.69 2400.37 1197.42 2402.56 1198.3L2401.54 1204.28C2399.64 1202.97 2397.6 1201.87 2395.41 1201.22 2393.29 1200.56 2391.03 1200.34 2388.84 1200.34 2384.1 1200.34 2379.79 1202.89 2376.8 1206.62 2373.44 1210.92 2371.83 1216.4 2371.83 1221.87 2371.83 1227.35 2373.44 1232.75 2376.8 1237.06 2379.79 1240.78 2384.1 1243.34 2388.84 1243.34 2391.32 1243.34 2393.88 1243.26 2396.21 1242.46 2398.7 1241.73 2400.81 1240.34 2402.93 1238.88L2403.37 1243.92C2401.18 1245.23 2398.91 1246.55 2396.43 1247.21 2393.95 1247.94 2391.4 1248.01 2388.84 1248.01 2382.42 1248.01 2376.5 1245.09 2372.2 1240.34 2367.67 1235.31 2365.33 1228.66 2365.33 1221.87 2365.33 1215.09 2367.67 1208.44 2372.2 1203.33 2376.5 1198.59 2382.42 1195.67 2388.84 1195.67Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2365.33"​ y="​1241.47">​CTA</​text><​path d="​M602.294 805.615C598.133 805.615 594.264 809.265 593.096 814.813L611.127 814.813C610.178 808.097 606.09 805.615 602.294 805.615ZM508.139 805.615C503.394 805.615 497.846 809.192 497.846 818.025 497.846 826.858 503.102 830.946 508.139 830.946 513.541 830.946 518.505 826.639 518.505 818.025 518.505 809.411 513.249 805.615 508.139 805.615ZM436.722 805.615C432.561 805.615 428.692 809.265 427.524 814.813L445.555 814.813C444.606 808.097 440.518 805.615 436.722 805.615ZM548.456 801.6C550.792 801.6 555.902 802.038 557.8 807.586 560.501 803.644 564.297 801.6 568.677 801.6 577.51 801.6 578.678 808.17 578.678 813.061L578.678 834.815 572.984 834.815 572.984 813.572C572.984 810.798 572.619 806.053 565.83 806.053 560.428 806.053 558.457 811.966 558.457 816.93L558.457 834.815 552.763 834.815 552.763 813.572C552.763 810.798 552.398 806.053 545.609 806.053 540.207 806.053 538.236 811.966 538.236 816.93L538.236 834.815 532.542 834.815 532.542 801.965 537.798 801.965 537.798 807.221C539.769 804.593 543.2 801.6 548.456 801.6ZM473.904 801.6C482.81 801.6 483.905 808.243 483.905 813.061L483.905 834.815 478.211 834.815 478.211 813.572C478.211 811.236 478.138 806.053 471.13 806.053 465.582 806.053 463.757 812.112 463.757 816.93L463.757 834.815 458.063 834.815 458.063 801.965 463.319 801.965 463.319 807.148C463.757 806.564 467.334 801.6 473.904 801.6ZM602.294 801.162C604.922 801.162 609.375 801.965 612.368 806.491 615.215 810.871 615.288 816.346 615.288 818.828L592.731 818.828C592.95 825.982 597.622 831.165 603.462 831.165 605.141 831.165 609.959 830.873 614.558 827.077L614.996 831.822C612.149 833.866 607.988 835.618 603.389 835.618 594.629 835.618 587.621 827.953 587.621 818.317 587.621 808.9 594.191 801.162 602.294 801.162ZM508.212 801.162C516.899 801.162 524.199 808.973 524.199 818.755 524.199 828.245 516.899 835.618 508.139 835.618 499.598 835.618 492.152 828.391 492.152 818.755 492.152 809.192 499.233 801.162 508.212 801.162ZM436.722 801.162C439.35 801.162 443.803 801.965 446.796 806.491 449.643 810.871 449.716 816.346 449.716 818.828L427.159 818.828C427.378 825.982 432.05 831.165 437.89 831.165 439.569 831.165 444.387 830.873 448.986 827.077L449.424 831.822C446.577 833.866 442.416 835.618 437.817 835.618 429.057 835.618 422.049 827.953 422.049 818.317 422.049 808.9 428.619 801.162 436.722 801.162ZM666.01 789.409C665.499 792.11 663.236 798.315 661.703 802.622 657.98 813.061 660.681 805.396 656.958 815.835L675.062 815.835 668.419 797.074C666.74 792.256 666.229 790.431 666.083 789.409ZM663.455 784.153 669.879 784.153 688.932 834.815 682.216 834.815 676.668 819.923 655.425 819.923 649.804 834.815 644.402 834.815ZM399.12 783.277C401.675 783.277 404.23 783.496 406.712 784.08 409.194 784.737 411.603 785.686 413.866 786.927L412.771 792.913C410.873 791.307 408.756 789.92 406.347 789.117 404.011 788.241 401.602 787.949 399.12 787.949 394.375 787.949 390.068 790.504 387.075 794.227 383.717 798.534 382.111 804.009 382.111 809.484 382.111 814.959 383.717 820.361 387.075 824.668 390.068 828.391 394.375 830.946 399.12 830.946 402.405 830.946 405.69 830.435 408.756 829.413L408.756 817.368 399.12 817.368 399.12 812.915 414.45 812.915 414.45 832.041C409.705 834.377 404.449 835.618 399.12 835.618 392.769 835.618 386.783 832.698 382.476 827.953 377.95 822.916 375.614 816.273 375.614 809.484 375.614 802.695 377.95 796.052 382.476 790.942 386.783 786.197 392.769 783.277 399.12 783.277Z"​ stroke="#​BA3F51"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​8B2F3D"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​375.614"​ y="​829.075">​Genome A</​text><​path d="​M638.51 864.433C637.999 867.134 635.736 873.339 634.203 877.646 630.48 888.085 633.181 880.42 629.458 890.859L647.562 890.859 640.919 872.098C639.24 867.28 638.729 865.455 638.583 864.433ZM394.448 864.433C393.937 867.134 391.674 873.339 390.141 877.646 386.418 888.085 389.119 880.42 385.396 890.859L403.5 890.859 396.857 872.098C395.178 867.28 394.667 865.455 394.521 864.433ZM520.663 859.615 565.047 859.615 565.047 864.36 555.265 864.36C554.389 864.36 553.513 864.287 552.637 864.287L546.14 864.287 546.14 909.839 539.643 909.839 539.643 864.287 533.073 864.287C532.197 864.287 531.321 864.36 530.445 864.36L520.663 864.36ZM422.122 859.615 466.506 859.615 466.506 864.36 456.724 864.36C455.848 864.36 454.972 864.287 454.096 864.287L447.599 864.287 447.599 909.839 441.102 909.839 441.102 864.287 434.532 864.287C433.656 864.287 432.78 864.36 431.904 864.36L422.122 864.36ZM635.955 859.177 642.379 859.177 661.432 909.839 654.716 909.839 649.168 894.947 627.925 894.947 622.304 909.839 616.902 909.839ZM391.893 859.177 398.317 859.177 417.37 909.839 410.654 909.839 405.106 894.947 383.863 894.947 378.242 909.839 372.84 909.839ZM596.203 858.301C598.539 858.301 600.875 858.447 603.138 858.885 605.474 859.323 607.737 860.053 609.927 860.929L608.905 866.915C607.007 865.601 604.963 864.506 602.773 863.849 600.656 863.192 598.393 862.973 596.203 862.973 591.458 862.973 587.151 865.528 584.158 869.251 580.8 873.558 579.194 879.033 579.194 884.508 579.194 889.983 580.8 895.385 584.158 899.692 587.151 903.415 591.458 905.97 596.203 905.97 598.685 905.97 601.24 905.897 603.576 905.094 606.058 904.364 608.175 902.977 610.292 901.517L610.73 906.554C608.54 907.868 606.277 909.182 603.795 909.839 601.313 910.569 598.758 910.642 596.203 910.642 589.779 910.642 583.866 907.722 579.559 902.977 575.033 897.94 572.697 891.297 572.697 884.508 572.697 877.719 575.033 871.076 579.559 865.966 583.866 861.221 589.779 858.301 596.203 858.301ZM497.661 858.301C500.216 858.301 502.771 858.52 505.253 859.104 507.735 859.761 510.144 860.71 512.407 861.951L511.312 867.937C509.414 866.331 507.297 864.944 504.888 864.141 502.552 863.265 500.143 862.973 497.661 862.973 492.916 862.973 488.609 865.528 485.616 869.251 482.258 873.558 480.652 879.033 480.652 884.508 480.652 889.983 482.258 895.385 485.616 899.692 488.609 903.415 492.916 905.97 497.661 905.97 500.946 905.97 504.231 905.459 507.297 904.437L507.297 892.392 497.661 892.392 497.661 887.939 512.991 887.939 512.991 907.065C508.246 909.401 502.99 910.642 497.661 910.642 491.31 910.642 485.324 907.722 481.017 902.977 476.491 897.94 474.155 891.297 474.155 884.508 474.155 877.719 476.491 871.076 481.017 865.966 485.324 861.221 491.31 858.301 497.661 858.301Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​372.84"​ y="​904.1">​ATGTCA</​text><​path d="​M691.88 858.301C694.435 858.301 696.99 858.52 699.472 859.104 701.954 859.761 704.363 860.71 706.626 861.951L705.531 867.937C703.633 866.331 701.516 864.944 699.107 864.141 696.771 863.265 694.362 862.973 691.88 862.973 687.135 862.973 682.828 865.528 679.835 869.251 676.477 873.558 674.871 879.033 674.871 884.508 674.871 889.983 676.477 895.385 679.835 899.692 682.828 903.415 687.135 905.97 691.88 905.97 695.165 905.97 698.45 905.459 701.516 904.437L701.516 892.392 691.88 892.392 691.88 887.939 707.21 887.939 707.21 907.065C702.465 909.401 697.209 910.642 691.88 910.642 685.529 910.642 679.543 907.722 675.236 902.977 670.71 897.94 668.374 891.297 668.374 884.508 668.374 877.719 670.71 871.076 675.236 865.966 679.543 861.221 685.529 858.301 691.88 858.301Z"​ stroke="#​BA3F51"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​8B2F3D"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​668.374"​ y="​904.1">​G</​text><​path d="​M832.729 864.433C832.218 867.134 829.955 873.339 828.422 877.646 824.699 888.085 827.4 880.42 823.677 890.859L841.781 890.859 835.138 872.098C833.459 867.28 832.948 865.455 832.802 864.433ZM761.861 859.615 806.245 859.615 806.245 864.36 796.463 864.36C795.587 864.36 794.711 864.287 793.835 864.287L787.338 864.287 787.338 909.839 780.841 909.839 780.841 864.287 774.271 864.287C773.395 864.287 772.519 864.36 771.643 864.36L761.861 864.36ZM830.174 859.177 836.598 859.177 855.651 909.839 848.935 909.839 843.387 894.947 822.144 894.947 816.523 909.839 811.121 909.839ZM740.578 858.301C742.914 858.301 745.25 858.447 747.513 858.885 749.849 859.323 752.112 860.053 754.302 860.929L753.28 866.915C751.382 865.601 749.338 864.506 747.148 863.849 745.031 863.192 742.768 862.973 740.578 862.973 735.833 862.973 731.526 865.528 728.533 869.251 725.175 873.558 723.569 879.033 723.569 884.508 723.569 889.983 725.175 895.385 728.533 899.692 731.526 903.415 735.833 905.97 740.578 905.97 743.06 905.97 745.615 905.897 747.951 905.094 750.433 904.364 752.55 902.977 754.667 901.517L755.105 906.554C752.915 907.868 750.652 909.182 748.17 909.839 745.688 910.569 743.133 910.642 740.578 910.642 734.154 910.642 728.241 907.722 723.934 902.977 719.408 897.94 717.072 891.297 717.072 884.508 717.072 877.719 719.408 871.076 723.934 865.966 728.241 861.221 734.154 858.301 740.578 858.301Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​717.072"​ y="​904.1">​CTA</​text><​path d="​M2419.12 849.149C2415.99 849.295 2404.16 849.806 2404.16 854.916 2404.16 857.982 2407.44 859.661 2410.95 859.661 2411.75 859.661 2414.53 859.588 2416.64 858.274 2419.12 856.887 2419.12 855.062 2419.12 853.675ZM2122.79 839.221 2122.79 859.223 2133.96 859.223C2141.84 859.223 2148.27 854.989 2148.27 849.514 2148.27 843.674 2141.11 839.221 2133.37 839.221ZM2449.9 834.768C2446.76 834.768 2443.91 836.447 2442.16 839.002L2442.16 853.675C2442.16 854.989 2442.16 855.135 2442.89 856.23 2444.35 858.201 2446.32 859.661 2449.17 859.661 2454.65 859.661 2459.83 854.551 2459.83 847.032 2459.83 840.316 2455.45 834.768 2449.9 834.768ZM2069.58 834.111C2065.42 834.111 2061.55 837.761 2060.39 843.309L2078.42 843.309C2077.47 836.593 2073.38 834.111 2069.58 834.111ZM2247.08 830.899 2252.56 830.899 2252.56 867.618C2252.56 874.48 2248.03 878.276 2243.43 878.276 2241.54 878.276 2238.18 877.838 2234.67 875.794L2236.21 871.341C2237.81 872.874 2239.57 873.604 2241.61 873.604 2242.92 873.604 2247.08 873.239 2247.08 868.348ZM2227.28 830.899 2232.76 830.899 2232.76 863.311 2227.28 863.311ZM2189.47 830.899 2195.16 830.899 2195.16 855.062C2195.16 858.201 2195.67 860.099 2200.86 860.099 2205.53 860.099 2209.62 857.544 2209.62 852.069L2209.62 830.899 2215.31 830.899 2215.31 863.311 2209.83 863.311 2209.83 859.807C2206.26 862.946 2201.07 864.114 2197.21 864.114 2191.15 864.114 2189.47 860.61 2189.47 855.354ZM2453.92 830.096C2460.92 830.096 2465.52 838.272 2465.52 847.032 2465.52 856.96 2459.1 864.114 2452.02 864.114 2447.64 864.114 2444.43 862.07 2442.16 859.953L2442.16 877.473 2436.47 877.473 2436.47 830.899 2441.94 830.899 2441.94 834.476C2445.3 831.629 2449.54 830.096 2453.92 830.096ZM2393.62 830.096 2393.62 834.987C2386.47 835.133 2381.21 840.389 2381.21 847.689L2381.21 863.311 2375.74 863.311 2375.74 830.461 2380.85 830.461 2380.85 837.104C2383.11 833.746 2387.13 830.169 2393.62 830.096ZM2280.36 830.096C2289.27 830.096 2290.36 836.739 2290.36 841.557L2290.36 863.311 2284.67 863.311 2284.67 842.068C2284.67 839.732 2284.59 834.549 2277.59 834.549 2272.04 834.549 2270.21 840.608 2270.21 845.426L2270.21 863.311 2264.52 863.311 2264.52 830.461 2269.78 830.461 2269.78 835.644C2270.21 835.06 2273.79 830.096 2280.36 830.096ZM2182.22 830.096 2182.22 834.987C2175.06 835.133 2169.81 840.389 2169.81 847.689L2169.81 863.311 2164.33 863.311 2164.33 830.461 2169.44 830.461 2169.44 837.104C2171.71 833.746 2175.72 830.169 2182.22 830.096ZM2412.77 829.658C2419.49 829.658 2424.82 834.768 2424.82 842.214L2424.82 863.311 2419.34 863.311 2419.34 860.683C2415.11 863.968 2408.25 864.114 2407.23 864.114 2400.87 864.114 2398.9 858.201 2398.9 855.062 2398.9 848.638 2408.17 845.572 2419.12 845.426L2419.12 842.287C2419.12 836.885 2416.2 833.965 2412.77 833.965 2409.2 833.965 2405.55 834.914 2401.75 837.615L2401.31 832.797C2404.74 830.826 2408.03 829.658 2412.77 829.658ZM2069.58 829.658C2072.21 829.658 2076.67 830.461 2079.66 834.987 2082.51 839.367 2082.58 844.842 2082.58 847.324L2060.02 847.324C2060.24 854.478 2064.91 859.661 2070.75 859.661 2072.43 859.661 2077.25 859.369 2081.85 855.573L2082.29 860.318C2079.44 862.362 2075.28 864.114 2070.68 864.114 2061.92 864.114 2054.91 856.449 2054.91 846.813 2054.91 837.396 2061.48 829.658 2069.58 829.658ZM2122.79 816.737 2122.79 834.768 2131.26 834.768C2141.33 834.768 2146.51 829.804 2146.51 825.424 2146.51 820.606 2140.09 816.737 2131.99 816.737ZM2012.93 816.737 2012.93 859.223 2024.1 859.223C2034.32 859.223 2041.92 850.828 2041.92 838.418 2041.92 825.57 2034.32 816.737 2024.1 816.737ZM2246.06 815.496 2252.56 815.496 2252.56 821.993 2246.06 821.993ZM2226.84 815.496 2233.34 815.496 2233.34 821.993 2226.84 821.993ZM2474.21 812.649 2479.68 812.649 2479.68 835.352C2482.02 832.359 2485.52 830.096 2490.05 830.096 2498.95 830.096 2500.05 836.739 2500.05 841.557L2500.05 863.311 2494.36 863.311 2494.36 842.068C2494.36 839.732 2494.28 834.549 2487.27 834.549 2481.73 834.549 2479.9 840.608 2479.9 845.426L2479.9 863.311 2474.21 863.311ZM2116.73 812.649 2134.03 812.649C2144.4 812.649 2152.21 818.635 2152.21 825.351 2152.21 830.899 2146.73 835.133 2140.09 836.812 2147.83 838.053 2154.18 843.236 2154.18 849.587 2154.18 856.741 2146.51 863.311 2136 863.311L2116.73 863.311ZM2006.66 812.649 2025.78 812.649C2038.34 812.649 2048.19 824.256 2048.19 838.418 2048.19 852.215 2038.27 863.311 2025.86 863.311L2006.66 863.311ZM2349.38 811.773C2351.93 811.773 2354.49 811.992 2356.97 812.576 2359.45 813.233 2361.86 814.182 2364.12 815.423L2363.03 821.409C2361.13 819.803 2359.01 818.416 2356.61 817.613 2354.27 816.737 2351.86 816.445 2349.38 816.445 2344.63 816.445 2340.33 819 2337.33 822.723 2333.98 827.03 2332.37 832.505 2332.37 837.98 2332.37 843.455 2333.98 848.857 2337.33 853.164 2340.33 856.887 2344.63 859.442 2349.38 859.442 2352.66 859.442 2355.95 858.931 2359.01 857.909L2359.01 845.864 2349.38 845.864 2349.38 841.411 2364.71 841.411 2364.71 860.537C2359.96 862.873 2354.71 864.114 2349.38 864.114 2343.03 864.114 2337.04 861.194 2332.73 856.449 2328.21 851.412 2325.87 844.769 2325.87 837.98 2325.87 831.191 2328.21 824.548 2332.73 819.438 2337.04 814.693 2343.03 811.773 2349.38 811.773Z"​ stroke="#​7F7F7F"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​595959"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​66.5031"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2006.66"​ y="​869.963">​De Bruijn Graph</​text><​path d="​M655.498 998.775 655.498 1018.78 666.667 1018.78C674.551 1018.78 680.975 1014.54 680.975 1009.07 680.975 1003.23 673.821 998.775 666.083 998.775ZM602.294 993.665C598.133 993.665 594.264 997.315 593.096 1002.86L611.127 1002.86C610.178 996.147 606.09 993.665 602.294 993.665ZM508.139 993.665C503.394 993.665 497.846 997.242 497.846 1006.08 497.846 1014.91 503.102 1019 508.139 1019 513.541 1019 518.505 1014.69 518.505 1006.08 518.505 997.461 513.249 993.665 508.139 993.665ZM436.721 993.665C432.56 993.665 428.691 997.315 427.523 1002.86L445.554 1002.86C444.605 996.147 440.517 993.665 436.721 993.665ZM548.456 989.65C550.792 989.65 555.902 990.088 557.8 995.636 560.501 991.694 564.297 989.65 568.677 989.65 577.51 989.65 578.678 996.22 578.678 1001.11L578.678 1022.87 572.984 1022.87 572.984 1001.62C572.984 998.848 572.619 994.103 565.83 994.103 560.428 994.103 558.457 1000.02 558.457 1004.98L558.457 1022.87 552.763 1022.87 552.763 1001.62C552.763 998.848 552.398 994.103 545.609 994.103 540.207 994.103 538.236 1000.02 538.236 1004.98L538.236 1022.87 532.542 1022.87 532.542 990.015 537.798 990.015 537.798 995.271C539.769 992.643 543.2 989.65 548.456 989.65ZM473.903 989.65C482.809 989.65 483.904 996.293 483.904 1001.11L483.904 1022.87 478.21 1022.87 478.21 1001.62C478.21 999.286 478.137 994.103 471.129 994.103 465.581 994.103 463.756 1000.16 463.756 1004.98L463.756 1022.87 458.062 1022.87 458.062 990.015 463.318 990.015 463.318 995.198C463.756 994.614 467.333 989.65 473.903 989.65ZM602.294 989.212C604.922 989.212 609.375 990.015 612.368 994.541 615.215 998.921 615.288 1004.4 615.288 1006.88L592.731 1006.88C592.95 1014.03 597.622 1019.22 603.462 1019.22 605.141 1019.22 609.959 1018.92 614.558 1015.13L614.996 1019.87C612.149 1021.92 607.988 1023.67 603.389 1023.67 594.629 1023.67 587.621 1016 587.621 1006.37 587.621 996.95 594.191 989.212 602.294 989.212ZM508.212 989.212C516.899 989.212 524.199 997.023 524.199 1006.81 524.199 1016.3 516.899 1023.67 508.139 1023.67 499.598 1023.67 492.152 1016.44 492.152 1006.81 492.152 997.242 499.233 989.212 508.212 989.212ZM436.721 989.212C439.349 989.212 443.802 990.015 446.795 994.541 449.642 998.921 449.715 1004.4 449.715 1006.88L427.158 1006.88C427.377 1014.03 432.049 1019.22 437.889 1019.22 439.568 1019.22 444.386 1018.92 448.985 1015.13L449.423 1019.87C446.576 1021.92 442.415 1023.67 437.816 1023.67 429.056 1023.67 422.048 1016 422.048 1006.37 422.048 996.95 428.618 989.212 436.721 989.212ZM655.498 976.291 655.498 994.322 663.966 994.322C674.04 994.322 679.223 989.358 679.223 984.978 679.223 980.16 672.799 976.291 664.696 976.291ZM649.439 972.203 666.74 972.203C677.106 972.203 684.917 978.189 684.917 984.905 684.917 990.453 679.442 994.687 672.799 996.366 680.537 997.607 686.888 1002.79 686.888 1009.14 686.888 1016.3 679.223 1022.87 668.711 1022.87L649.439 1022.87ZM399.119 971.327C401.674 971.327 404.229 971.546 406.711 972.13 409.193 972.787 411.602 973.736 413.865 974.977L412.77 980.963C410.872 979.357 408.755 977.97 406.346 977.167 404.01 976.291 401.601 975.999 399.119 975.999 394.374 975.999 390.067 978.554 387.074 982.277 383.716 986.584 382.11 992.059 382.11 997.534 382.11 1003.01 383.716 1008.41 387.074 1012.72 390.067 1016.44 394.374 1019 399.119 1019 402.404 1019 405.689 1018.49 408.755 1017.46L408.755 1005.42 399.119 1005.42 399.119 1000.97 414.449 1000.97 414.449 1020.09C409.704 1022.43 404.448 1023.67 399.119 1023.67 392.768 1023.67 386.782 1020.75 382.475 1016 377.949 1010.97 375.613 1004.32 375.613 997.534 375.613 990.745 377.949 984.102 382.475 978.992 386.782 974.247 392.768 971.327 399.119 971.327Z"​ stroke="#​D78D38"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A96A22"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.341"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​375.613"​ y="​1017.13">​Genome B</​text><​path d="​M638.51 1052.48C637.999 1055.19 635.736 1061.39 634.203 1065.7 630.48 1076.14 633.181 1068.47 629.458 1078.91L647.562 1078.91 640.919 1060.15C639.24 1055.33 638.729 1053.51 638.583 1052.48ZM394.447 1052.48C393.936 1055.19 391.673 1061.39 390.14 1065.7 386.417 1076.14 389.118 1068.47 385.395 1078.91L403.499 1078.91 396.856 1060.15C395.177 1055.33 394.666 1053.51 394.52 1052.48ZM520.663 1047.67 565.047 1047.67 565.047 1052.41 555.265 1052.41C554.389 1052.41 553.513 1052.34 552.637 1052.34L546.14 1052.34 546.14 1097.89 539.643 1097.89 539.643 1052.34 533.073 1052.34C532.197 1052.34 531.321 1052.41 530.445 1052.41L520.663 1052.41ZM422.121 1047.67 466.505 1047.67 466.505 1052.41 456.723 1052.41C455.847 1052.41 454.971 1052.34 454.095 1052.34L447.598 1052.34 447.598 1097.89 441.101 1097.89 441.101 1052.34 434.531 1052.34C433.655 1052.34 432.779 1052.41 431.903 1052.41L422.121 1052.41ZM635.955 1047.23 642.379 1047.23 661.432 1097.89 654.716 1097.89 649.168 1083 627.925 1083 622.304 1097.89 616.902 1097.89ZM391.892 1047.23 398.316 1047.23 417.369 1097.89 410.653 1097.89 405.105 1083 383.862 1083 378.241 1097.89 372.839 1097.89ZM596.203 1046.35C598.539 1046.35 600.875 1046.5 603.138 1046.94 605.474 1047.37 607.737 1048.1 609.927 1048.98L608.905 1054.97C607.007 1053.65 604.963 1052.56 602.773 1051.9 600.656 1051.24 598.393 1051.02 596.203 1051.02 591.458 1051.02 587.151 1053.58 584.158 1057.3 580.8 1061.61 579.194 1067.08 579.194 1072.56 579.194 1078.03 580.8 1083.44 584.158 1087.74 587.151 1091.47 591.458 1094.02 596.203 1094.02 598.685 1094.02 601.24 1093.95 603.576 1093.15 606.058 1092.42 608.175 1091.03 610.292 1089.57L610.73 1094.6C608.54 1095.92 606.277 1097.23 603.795 1097.89 601.313 1098.62 598.758 1098.69 596.203 1098.69 589.779 1098.69 583.866 1095.77 579.559 1091.03 575.033 1085.99 572.697 1079.35 572.697 1072.56 572.697 1065.77 575.033 1059.13 579.559 1054.02 583.866 1049.27 589.779 1046.35 596.203 1046.35ZM497.661 1046.35C500.216 1046.35 502.771 1046.57 505.253 1047.16 507.735 1047.81 510.144 1048.76 512.407 1050L511.312 1055.99C509.414 1054.38 507.297 1052.99 504.888 1052.19 502.552 1051.32 500.143 1051.02 497.661 1051.02 492.916 1051.02 488.609 1053.58 485.616 1057.3 482.258 1061.61 480.652 1067.08 480.652 1072.56 480.652 1078.03 482.258 1083.44 485.616 1087.74 488.609 1091.47 492.916 1094.02 497.661 1094.02 500.946 1094.02 504.231 1093.51 507.297 1092.49L507.297 1080.44 497.661 1080.44 497.661 1075.99 512.991 1075.99 512.991 1095.12C508.246 1097.45 502.99 1098.69 497.661 1098.69 491.31 1098.69 485.324 1095.77 481.017 1091.03 476.491 1085.99 474.155 1079.35 474.155 1072.56 474.155 1065.77 476.491 1059.13 481.017 1054.02 485.324 1049.27 491.31 1046.35 497.661 1046.35Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​372.839"​ y="​1092.15">​ATGTCA</​text><​path d="​M691.88 1046.35C694.216 1046.35 696.552 1046.5 698.815 1046.94 701.151 1047.37 703.414 1048.1 705.604 1048.98L704.582 1054.97C702.684 1053.65 700.64 1052.56 698.45 1051.9 696.333 1051.24 694.07 1051.02 691.88 1051.02 687.135 1051.02 682.828 1053.58 679.835 1057.3 676.477 1061.61 674.871 1067.08 674.871 1072.56 674.871 1078.03 676.477 1083.44 679.835 1087.74 682.828 1091.47 687.135 1094.02 691.88 1094.02 694.362 1094.02 696.917 1093.95 699.253 1093.15 701.735 1092.42 703.852 1091.03 705.969 1089.57L706.407 1094.6C704.217 1095.92 701.954 1097.23 699.472 1097.89 696.99 1098.62 694.435 1098.69 691.88 1098.69 685.456 1098.69 679.543 1095.77 675.236 1091.03 670.71 1085.99 668.374 1079.35 668.374 1072.56 668.374 1065.77 670.71 1059.13 675.236 1054.02 679.543 1049.27 685.456 1046.35 691.88 1046.35Z"​ stroke="#​D78D38"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A96A22"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​668.374"​ y="​1092.15">​C</​text><​path d="​M831.01 1052.48C830.499 1055.19 828.236 1061.39 826.703 1065.7 822.98 1076.14 825.681 1068.47 821.958 1078.91L840.062 1078.91 833.419 1060.15C831.74 1055.33 831.229 1053.51 831.083 1052.48ZM760.142 1047.67 804.526 1047.67 804.526 1052.41 794.744 1052.41C793.868 1052.41 792.992 1052.34 792.116 1052.34L785.619 1052.34 785.619 1097.89 779.122 1097.89 779.122 1052.34 772.552 1052.34C771.676 1052.34 770.8 1052.41 769.924 1052.41L760.142 1052.41ZM828.455 1047.23 834.879 1047.23 853.932 1097.89 847.216 1097.89 841.668 1083 820.425 1083 814.804 1097.89 809.402 1097.89ZM738.859 1046.35C741.195 1046.35 743.531 1046.5 745.794 1046.94 748.13 1047.37 750.393 1048.1 752.583 1048.98L751.561 1054.97C749.663 1053.65 747.619 1052.56 745.429 1051.9 743.312 1051.24 741.049 1051.02 738.859 1051.02 734.114 1051.02 729.807 1053.58 726.814 1057.3 723.456 1061.61 721.85 1067.08 721.85 1072.56 721.85 1078.03 723.456 1083.44 726.814 1087.74 729.807 1091.47 734.114 1094.02 738.859 1094.02 741.341 1094.02 743.896 1093.95 746.232 1093.15 748.714 1092.42 750.831 1091.03 752.948 1089.57L753.386 1094.6C751.196 1095.92 748.933 1097.23 746.451 1097.89 743.969 1098.62 741.414 1098.69 738.859 1098.69 732.435 1098.69 726.522 1095.77 722.215 1091.03 717.689 1085.99 715.353 1079.35 715.353 1072.56 715.353 1065.77 717.689 1059.13 722.215 1054.02 726.522 1049.27 732.435 1046.35 738.859 1046.35Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​715.353"​ y="​1092.15">​CTA</​text><​path d="​M1956.15 834.859C1951.84 834.859 1945.57 837.852 1945.57 847.488 1945.57 856.54 1950.9 859.971 1955.42 859.971 1957.32 859.971 1959.14 859.387 1960.82 857.927 1963.16 855.81 1963.23 854.496 1963.23 853.474L1963.23 838.874C1961.63 836.538 1959.44 834.859 1956.15 834.859ZM1921.82 834.421C1917.65 834.421 1913.79 838.071 1912.62 843.619L1930.65 843.619C1929.7 836.903 1925.61 834.421 1921.82 834.421ZM1860.89 834.421C1856.14 834.421 1850.6 837.998 1850.6 846.831 1850.6 855.664 1855.85 859.752 1860.89 859.752 1866.29 859.752 1871.26 855.445 1871.26 846.831 1871.26 838.217 1866 834.421 1860.89 834.421ZM1806.46 834.421C1801.72 834.421 1796.17 837.998 1796.17 846.831 1796.17 855.664 1801.43 859.752 1806.46 859.752 1811.86 859.752 1816.83 855.445 1816.83 846.831 1816.83 838.217 1811.57 834.421 1806.46 834.421ZM1903.25 830.406 1903.25 835.297C1896.1 835.443 1890.84 840.699 1890.84 847.999L1890.84 863.621 1885.37 863.621 1885.37 830.771 1890.48 830.771 1890.48 837.414C1892.74 834.056 1896.75 830.479 1903.25 830.406ZM1921.82 829.968C1924.44 829.968 1928.9 830.771 1931.89 835.297 1934.74 839.677 1934.81 845.152 1934.81 847.634L1912.25 847.634C1912.47 854.788 1917.14 859.971 1922.98 859.971 1924.66 859.971 1929.48 859.679 1934.08 855.883L1934.52 860.628C1931.67 862.672 1927.51 864.424 1922.91 864.424 1914.15 864.424 1907.14 856.759 1907.14 847.123 1907.14 837.706 1913.71 829.968 1921.82 829.968ZM1860.96 829.968C1869.65 829.968 1876.95 837.779 1876.95 847.561 1876.95 857.051 1869.65 864.424 1860.89 864.424 1852.35 864.424 1844.9 857.197 1844.9 847.561 1844.9 837.998 1851.98 829.968 1860.96 829.968ZM1806.54 829.968C1815.22 829.968 1822.52 837.779 1822.52 847.561 1822.52 857.051 1815.22 864.424 1806.46 864.424 1797.92 864.424 1790.48 857.197 1790.48 847.561 1790.48 837.998 1797.56 829.968 1806.54 829.968ZM1774.32 829.968C1778.77 829.968 1781.25 830.625 1785.56 833.107L1784.68 837.852C1780.67 835.224 1778.19 834.64 1774.39 834.64 1766.65 834.64 1763.95 841.648 1763.95 847.342 1763.95 854.496 1768.04 859.752 1774.1 859.752 1777.82 859.752 1781.76 858.73 1785.49 855.81L1785.92 860.701C1781.98 863.402 1777.97 864.424 1774.03 864.424 1764.9 864.424 1758.26 856.467 1758.26 847.415 1758.26 838.801 1764.17 829.968 1774.32 829.968ZM1963.45 812.959 1968.93 812.959 1968.93 863.621 1963.23 863.621 1963.23 859.825C1959.14 863.767 1954.84 864.424 1952.43 864.424 1945.49 864.424 1939.87 856.978 1939.87 847.415 1939.87 837.998 1945.57 830.406 1952.79 830.406 1955.49 830.406 1959.58 831.209 1963.45 834.421ZM1830.87 812.959 1836.34 812.959 1836.34 863.621 1830.87 863.621Z"​ stroke="#​BFBFBF"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A6A6A6"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​51.465"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​1758.26"​ y="​857.991">​colored</​text><​path d="​M2385.03 918.054 2390.28 918.054 2383.13 951.488 2401.16 936.304 2407.73 936.304 2392.84 948.86 2402.47 968.716 2396.49 968.716 2388.6 952.364 2381.45 958.423 2379.26 968.716 2374.22 968.716Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​50.662"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2374.22"​ y="​962.383">​k</​text><​path d="​M2421.62 949.663 2448.99 949.663C2451.47 949.663 2451.69 951.415 2451.69 951.926 2451.69 952.802 2451.25 954.189 2448.77 954.189L2421.69 954.189C2419.28 954.116 2418.92 952.656 2418.92 951.926 2418.92 951.05 2419.43 949.663 2421.62 949.663ZM2421.91 938.64 2448.7 938.64C2450.01 938.64 2451.69 938.932 2451.69 940.903 2451.69 941.706 2451.18 943.166 2449.21 943.166L2421.62 943.166C2419.28 943.093 2418.92 941.633 2418.92 940.83 2418.92 940.027 2419.43 938.64 2421.91 938.64Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​15.549"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2418.92"​ y="​952.246">​=</​text><​path d="​M2484.74 919.222C2491.96 919.222 2498.02 924.04 2498.02 930.318 2498.02 934.917 2495.47 939.881 2489.92 942.874 2494.88 944.407 2499.99 948.933 2499.99 955.576 2499.99 963.241 2493.57 970.322 2484.66 970.322 2481.74 970.322 2475.03 969.592 2469.7 962.73L2470.5 958.35C2473.71 963.314 2479.48 965.869 2484.52 965.869 2490.14 965.869 2493.5 961.197 2493.5 955.503 2493.5 951.853 2491.89 945.064 2484.01 945.064L2478.82 945.064 2478.82 940.611C2484.01 940.173 2484.15 940.173 2484.59 940.1 2489.04 939.078 2492.04 934.771 2492.04 930.318 2492.04 925.646 2488.46 923.456 2484.66 923.456 2480.21 923.456 2475.46 926.084 2473.35 931.194L2470.72 927.252C2473.79 922.142 2479.11 919.222 2484.74 919.222Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​51.1"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2469.7"​ y="​963.935">​3</​text><​path d="​M2059.5 1382C2059.5 1372.34 2067.34 1364.5 2077 1364.5L2231 1364.5C2240.67 1364.5 2248.5 1372.34 2248.5 1382L2248.5 1452C2248.5 1461.66 2240.67 1469.5 2231 1469.5L2077 1469.5C2067.34 1469.5 2059.5 1461.66 2059.5 1452Z" stroke="#​D78D38"​ stroke-width="​6.875"​ stroke-linecap="​butt"​ stroke-linejoin="​miter"​ stroke-miterlimit="​8"​ stroke-opacity="​1"​ fill="#​F7E8D7"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​path d="​M2108.36 1387.74C2110.7 1387.74 2113.03 1387.88 2115.29 1388.32 2117.63 1388.76 2119.89 1389.49 2122.08 1390.36L2121.06 1396.35C2119.16 1395.04 2117.12 1393.94 2114.93 1393.29 2112.81 1392.63 2110.55 1392.41 2108.36 1392.41 2103.61 1392.41 2099.31 1394.96 2096.31 1398.69 2092.96 1402.99 2091.35 1408.47 2091.35 1413.94 2091.35 1419.42 2092.96 1424.82 2096.31 1429.13 2099.31 1432.85 2103.61 1435.41 2108.36 1435.41 2110.84 1435.41 2113.4 1435.33 2115.73 1434.53 2118.21 1433.8 2120.33 1432.41 2122.45 1430.95L2122.89 1435.99C2120.7 1437.3 2118.43 1438.62 2115.95 1439.28 2113.47 1440.01 2110.91 1440.08 2108.36 1440.08 2101.94 1440.08 2096.02 1437.16 2091.72 1432.41 2087.19 1427.38 2084.85 1420.73 2084.85 1413.94 2084.85 1407.16 2087.19 1400.51 2091.72 1395.4 2096.02 1390.66 2101.94 1387.74 2108.36 1387.74Z"​ stroke="#​D78D38"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​A96A22"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2084.85"​ y="​1433.54">​C</​text><​path d="​M2176.62 1389.05 2221.01 1389.05 2221.01 1393.8 2211.22 1393.8C2210.35 1393.8 2209.47 1393.72 2208.6 1393.72L2202.1 1393.72 2202.1 1439.28 2195.6 1439.28 2195.6 1393.72 2189.03 1393.72C2188.16 1393.72 2187.28 1393.8 2186.4 1393.8L2176.62 1393.8ZM2155.34 1387.74C2157.68 1387.74 2160.01 1387.88 2162.27 1388.32 2164.61 1388.76 2166.87 1389.49 2169.06 1390.36L2168.04 1396.35C2166.14 1395.04 2164.1 1393.94 2161.91 1393.29 2159.79 1392.63 2157.53 1392.41 2155.34 1392.41 2150.59 1392.41 2146.29 1394.96 2143.29 1398.69 2139.94 1402.99 2138.33 1408.47 2138.33 1413.94 2138.33 1419.42 2139.94 1424.82 2143.29 1429.13 2146.29 1432.85 2150.59 1435.41 2155.34 1435.41 2157.82 1435.41 2160.38 1435.33 2162.71 1434.53 2165.19 1433.8 2167.31 1432.41 2169.43 1430.95L2169.87 1435.99C2167.68 1437.3 2165.41 1438.62 2162.93 1439.28 2160.45 1440.01 2157.89 1440.08 2155.34 1440.08 2148.92 1440.08 2143 1437.16 2138.7 1432.41 2134.17 1427.38 2131.83 1420.73 2131.83 1413.94 2131.83 1407.16 2134.17 1400.51 2138.7 1395.4 2143 1390.66 2148.92 1387.74 2155.34 1387.74Z"​ stroke="#​404040"​ stroke-width="​2"​ stroke-linecap="​butt"​ stroke-linejoin="​round"​ stroke-miterlimit="​10"​ stroke-opacity="​1"​ fill="#​262626"​ fill-rule="​evenodd"​ fill-opacity="​1"/><​text fill="#​000000"​ fill-opacity="​0"​ font-family="​Arial,​Arial_MSFontService,​sans-serif"​ font-size="​52.3409"​ direction="​ltr"​ writing-mode="​lr-tb"​ x="​2131.83"​ y="​1433.54">​CT</​text></​g></​g></​svg>​ 
 +</​html>​
  
-The cross-platform processing framework [[http://​maltcms.sf.net|Maltcms]], the basis for CHROMAprovides algorithms ​for peak-detection-integrationpeak- and profile alignment of chromatography-mass spectrometry dataIt is complemented by the graphical user interface ​[[http://maltcms.sourceforge.net/maui/|Maui]]. Current research focuses on the integration ​of metabolomics ​and gel-based proteomics data in our application Proteus.+=== Panacus === 
 +Pangenomics aims to capture the collective genomic diversity of taxonomically 
 +related genomestypically from the same speciesoffering potential insights 
 +for medicine and biology. Initially defined as collections of genespangenomes 
 +are now more accurately represented through variation graphs. These graphs 
 +illustrate genomes by using nodes to depict shared sequences, edges to denote 
 +sequential connections, and paths to reconstruct the original genomesDespite 
 +their benefits, there is a lack of scalable software for essential analyses, 
 +such as estimating ​the core genome size and evaluating the extent of genomic 
 +variability (pangenome growth). To address this need, we developed ​[[https://github.com/marschall-lab/panacus/​tree/​main|Panacus]] 
 +(pangenome-abacus),​ a tool designed for efficient data extraction from GFA 
 +files, ​the standard for pangenome graphs. Panacus facilitates quick generation 
 +of pangenome growth ​and core curves, handling millions of nodes in variation 
 +graphs within minutes.
  
-==== Modeling Tumor Heterogeneity ====+{{research:​variation_graph_margin.png?​3307,​nolink}}
  
-{{:heterogeneity_20161103.png?nolink |Heterogeneity|}}Cancer is set of diseases that is caused ​by accumulating genetic mutations  +=== MicroGenUniBi and NFDIs === 
-such as single-nucleotide alterations (SNAs) ​and structural variations including  +Under the acronym "​MicroGenUniBi"​ (de.NBI-Resource Center for Microbial Genome Research in Biotechnology and Medicine at Bielefeld University),​ we provide services as partner of the [[https://www.denbi.de/​network|de.NBI network]]. MicroGenUniBi ensures the operation of the de.NBI cloud site at Bielefeld University which involves the installation and maintenance of hardware components, the configuration of software and the (re)certification of the cloud infrastructure. 
-copy number aberrations ​(CNAs). Over timetumor cells evolve ​and accumulate  +Furthermore,​ MicroGenUniBi provides services in microbial bioinformatics and offers training courses introducing to the usage of these services on regular basis. Currently, provided services cover areas of pangenomics,​ metagenomics and multiomics analyses. In particular, the area of pangenomics ​is represented ​by the services [[https://​github.com/​tischulz1/​plast|PLAST]] for pangenome alignment, [[https://​gitlab.ub.uni-bielefeld.de/​gi/​corer|Corer]] for the prediction of a pangenome’s core genome ​and [[https://​gitlab.ub.uni-bielefeld.de/​gi/​sans|SANS]] for phylogenetic analyses ​(see also above). The programs [[https://​qupe.cebitec.uni-bielefeld.de/​QuPE/​|QuPE]][[https://​meltdb.cebitec.uni-bielefeld.de/​cgi-bin/​login.cgi|MeltDB]] ​and [[https://​fusion.cebitec.uni-bielefeld.de/​Fusion/​login|Fusion]] cover the area of multiomics analysesIn addition, MicroGenUniBi provides various software solutions, e.g. for the computation of alignments, ​the comparison of genomes ​and RNA structure prediction which are collectively available from the platform [[https://​bibiserv.cebitec.uni-bielefeld.de|BiBiServ]]. Moreover, ​the web-based software [[https://​biigle.de|BIIGLE]] for collaborative image and video annotation is offered, specifically for research in biodiversity
-different mutations, leading to a heterogeneous cell population that consists ​of  +We are also involved in the [[https://​www.nfdi.de|National Research Data Infrastructure Germany (NFDI)]] initiative. In particular, we contribute to [[https://​www.nfdi4biodiversity.org/​en/​|NFDI4Biodiversity]] ​and [[https://​nfdi4microbiota.de|NFDI4Microbiota]]
-different subclonal populationsInformation about the different mutations in  +<WRAP left>​{{research:​denbi_logo.png?​300,​nolink}}</​WRAP>​ 
-the subpopulations ​and their frequency ​- the subclonal composition ​can help to  +<WRAP left>​{{research:​nfdibiodiv.png?​300,​nolink}}</​WRAP><​WRAP left>​{{research:​nfdimicrobio.png?​150,​nolink}}</​WRAP>​
-identify driver mutations ​and to choose targeted therapies.\\  +
-We are developing a method - called Onctopus - that reconstructs ​the clonal  +
-composition of a bulk-sequenced cancer sample using both SNAs and CNAsWe built  +
-a joint likelihood model and developed a linear relaxation of our model as a  +
-mixed integer linear program that can be solved with state­of­the­art solvers.\\  +
-This is a joint project with Gunnar Rätsch from ETH Zürich and Quaid Morris from  +
-University of Toronto.+