Pan-genome graph construction

Pan-genome graph construction is the process of creating a graph-based representation of the collective genome (the pan-genome) of a species or a group of organisms. In such graphs, nodes are often represent genomic sequences (e.g. DNA segments or k-mers) and edges represent adjacency relationships as they occur in individual genomes within a population. Thus, a pan-genome encapsulates all genomic data for a species or clade. Such graphs provide a way to represent multiple genomes without bias to a single reference genome, which address the shortcomings of traditional linear references genomes that capture only one version of each locus.[2]
In contrast, traditional linear reference genomes represent only a single consensus genome sequence, capturing just one version of each genomic locus.[3] This approach is inherently limited, as it fails to account for genetic variations such as single-nucleotide polymorphism (SNPs), insertions and deletions (indels), and larger structural variants that commonly exist across populations. Linear references thus introduce biases by inadequately representing genomic diversity, potentially compromising the accuracy of analyses like variant calling and genotyping.
Pan-genome graphs address these limitations by incorporating all known genetic variations into their structure. This inclusive representation allows for unbiased analysis of genomic data, significantly improving sequencing read alignment, variant detection, and genotyping accuracy across diverse individuals. Advancements in both the quality and length of sequencing, alongside improved genome assembly techniques, have led to a rapidly growing collection of high quality genome assemblies, including haplotype-resolved human genome assemblies. As a result, pan-genome graphs have become an important paradigm in bioinformatics for analyzing population genomic data, improving read alignment, variant calling, and genotyping across diverse genomes.[4]
Historical development

The concept of the pan-genome was first introduced in 2005 by Tettelin and colleagues during comparative analysis of multiple Streptococcus agalactiae bacterial genomes.[5] In their study Tettelin et al. defined the pan-genome as consisting of a conserved "core genome" present in all strains and a variable "accessory genome" containing genes present in one or a subset of strains, highlighting the notion that any single genome contains only a fraction of a species' total gene repertoire. Early pan-genomic analyses in microbes focused on gene presence/absence using lists of genes or orthologous clusters, rather than nucleotide-level variation. As more genomes become available, researchers recognized the need to model genomic variation at the base-pair level and not just as gene lists.[4]
Graph-based representation of multiple sequences have roots in prior bioinformatic methods based on sequence graph.[6] For instance, in early 2000s, partial order graphs [7] were used to represent multiple sequence alignment and consensus sequences which can be seen as a kind of sequence graph capturing alternate alleles. In early 2010s, the first practical tools leveraging graph models for pan-genomes appeared. A notable example was the colored de Bruijn graph approach used by Cortex, which built a joint de Bruijn graph from multiple genomes or read sets to detect variations without a reference genome.[8] Around the same time, different research group such as Dilthey et al. began constructing graphs for specific genomic regions in humans , such as the highly variable major histocompatibility complex (MHC) locus and for collections of microbial genomes to represent all variations in one structure.[9][2]
Recently, large-scale projects have implemented pan-genome graph construction for eukaryotic genomes. In 2023 the Human Pangenome Reference Consortium published a first draft human pan-genome, which contains 47 diverse, haplotype-resolved human genomes encoded in a graph structure.[3] Similarly, graph pan-genomes have been built for crop species such as tomatoes, which were built from 838 genomes, enabling discovery of previously "missing" heritability and trait-linked variants that were not detectable with a single reference.[10]
Graph-based methodologies

The main step in pan-genome graph building includes the initial alignment step and downstream processing for representation.[11] Several graph-based methodologies have been developed to construct pan-genome representations, each with differing modeling methodology and graph construction algorithms. These methods can capture more complex rearrangements and efficiently represent large collections of sequences than traditional approaches such as multiple sequence alignments (MSAs) and K-mer–based strategies. Furthermore, graph methods are currently among the most effective at managing large-scale pan-genome data, even supporting the simultaneous representation of tens to hundreds of human haplotypes.[12]
Pan-genome graphs are often bidirected, meaning each node has two orientations (forward and reverse), and edges account for all combinations of these orientations.[13] Graph metrics, including the count of nodes, edges, and connected components, offer valuable insights into the granularity of represented variations as well as the complexity and accessibility of information within the pan-genome.[14]
De Bruijn graphs

De Bruijn graphs are a classical data structure from genome assembly that have been adapted for pan-genome representation. In a de Bruijn graph, genomic sequences are broken into fixed-length k-mers (substrings of length k). Each unique k-mer forms a node in the graph, and there is an edge from one k-mer to another if they overlap by k-1 bases (as occurs when they are adjacent in some genome). This graph encodes the sequence of each genome through a path of k-mer nodes. For pan-genomes, a single de Bruijn graph can be constructed from multiple genomes by taking the union of all k-mers present. To retain information about which genome(s) contain a given k-mer, methods use colored de Bruijn graphs, where each node is annotated with one or more colors indicating the samples or strains in which that k-mer appears.[4]
The principle behind using de Bruijn graphs for pan-genomes is that the graph inherently compresses identical sequence regions and reveals variant sequences as alternative paths. This makes de Bruijn graph-based methods naturally reference-free; they do not require anchoring to a known genome, which is useful for discovering novel genes or rearrangements.[15] A major advantage of de Bruijn graphs is their ability to handle repetitive sequences and high-diversity regions by breaking genomes into smaller k-mer pieces. However, a limitation is that the choice of k can affect the resolution of the graph, where a fixed k may be too small to capture structural variation (which then appears as complex graph patterns) or too large to include highly divergent regions.[16]
De Bruijn graphs have proven to be highly scalable for massive datasets (e.g., 600,000 bacterial genomes) due to k-mer compaction. However, they have limited ability to represent structural variants (SVs) or large indels, and they pose visualization and interpretation challenges because of their cyclic structures. Common applications include bacterial pan-genome analyses, short-read assembly, and k-mer-based population studies. Tools like Bifrost and mdbg optimize storage using colored compacted de Bruijn graphs.[17]
Variation graphs

Variation graphs (also known as sequence graphs) represent sequence homology and variation at the nucleotide level in a graph structure. In a variation graph model, nodes represent contiguous sequences (such as a reference segment or an allele sequence), and edges connect nodes to indicate allowed adjacencies in some genome. The graph can be viewed as a merger of many individual genomes: each genome corresponds to a path that traverses the nodes in the order of its sequence.[3] Unlike de Bruijn graphs, which are derived from fixed-length kmers, variation graphs are often derived from alignments or variant catalogs. For example, one can start with a reference genome and add alternate alleles as divergent branches at variant sites, or perform a multiple sequence alignment of several genomes and build a graph that embeds that alignment.[2] Variation graphs accurately capture SNPs, indels, and structural variants, and they enable a complete, lossless representation of entire genomes, a relevant feature for clinical genomics. Nevertheless, graph complexity grows rapidly with the addition of haplotypes, and most implementations offer limited support for dynamic updates.[17] Some applications include the Human Reference Pangenome and pathogen variant calling that integrates both SNPs and SVs. [2][18] Tools like pggb and Minigraph enable chromosome-scale human pan-genomes.[19]
Partial Order alignment graphs
Partial order alignment (POA) represents a multiple sequence alignment as a directed acyclic graph (DAG) instead of a linear consensus sequence. In a POA graph, each sequence in the pan-genome is a path through the graph, and aligned positions are merged into single nodes. This preserves the full alignment information without compressing it into a single linear profile.[20] POA graphs capture small variants (SNPs and indels) as branching and merging paths in the DAG, avoiding reference bias since no single genome is privileged as the reference. That being said, given that the POA graph must remain acyclic, graphs cannot represent structural rearrangements or complex genome variations that violate a single ordering of sequences. [21][2] POA graphs resolve small-scale complexity through iterative smoothing, reducing spurious loops and underalignment in graphs. Furthermore, they are compatible with long-read sequencing error correction. However, they are computationally intensive due to repeated realignment passes and less effective for large-scale structural variation. Some applications include refining graph topology in repetitive regions and hybrid short-/long-read pan-genome polishing. Tools like abPOA generate consensus sequences and visualize alignment graphs.[19][22]
Cactus graphs
The Cactus graph is a graph-based structure specifically designed for whole-genome multiple alignments with complex rearrangements. A cactus graph is defined as a connected graph in which every edge lies in, at most, one simple cycle.[23] In a cactus graph model of a pan-genome, nodes typically represent evolutionary breakpoints or homologous segments, and edges represent contiguous aligned regions between those breakpoints. When an inversion or rearrangement is present, it appears as a cycle (loop) in the graph connecting the segments, and because each edge is in only one cycle, each rearrangement is an isolated event in the graph structure. Although newer variations, such as Progressive Cactus, has improved significantly, the computational requirements remains high for such graphs.[24] Cactus graphs minimize reference bias by treating all genomes equally and handle large structural variants and rearrangements efficiently (e.g., the Minigraph-Cactus pipeline). However, they require significant computational resources, and their accuracy depends on the quality of the initial alignment.[17][19] Key applications include vertebrate-scale pangenomes (e.g., 90+ human haplotypes) and evolutionary studies of chromosomal rearrangements. Widely used implementations include Cactus (from the UCSC Genome Browser) and Minigraph-Cactus (for large-scale pangenome construction).[19] [25]
Objectives of data structures
The pan-genome representation is challenging not only because it involves aligning massive quantities of sequence data, potentially on the order of hundreds of billions of bases, but also due to the difficulty of deciding which alignments should be incorporated, particularly for sequences that have been recently duplicated or contain repetitive elements.:[11] Scaling pan-genome graph data structures to accommodate hundreds of genomes demands substantial computational power and engineering expertise.[26] Nevertheless, every pangenome data structure must fulfill the following objectives [12]
- Construction and Maintenance: Must be constructible from multiple genomic sources, including linear reference genomes, haplotype panels, and raw sequencing data, with the ability to update stored information dynamically without requiring a complete reconstruction.
- Coordinate System: Must provide a well-defined coordinate system that allows for unambiguous identification of genetic loci and variations.
- Annotation of Biological Features: Must support the annotation of biological features across individual genomes, including genes, introns, transcription factor binding sites, epigenetic modifications, and regulatory elements.
- Data Retrieval: Must allow efficient retrieval of genomic sequences, genetic variants, and allele frequencies, while preserving haplotype information.
- Sequence Mapping and Variant Identification: Must facilitate the comparison of short and long sequences against its database.
- Comparative Genomics: Must enable genome comparisons within a single pangenome and among multiple pangenomes.
- Computational Efficiency: Must minimize memory usage while remaining compatible with computational tools that operate within a reasonable runtime.
Graph storage
Although several approaches exist for constructing pangenome graphs, they have largely converged on a shared data model known as the Graphical Fragment Assembly (GFA) format.[27] This standardization supports the development of a unified set of tools designed to operate within the pangenome graph framework.[28]
GFA format

GFA (Graphical Fragment Assembly) is a format intended to encode sequence graphs, whether they arise from assemblies, genome variation, gene splice patterns, or even overlaps among long-read sequences. It uses a tab-delimited text layout to record sequences and their relationships, relying on UTF-8 encoding restricted to codepoints no larger than 127. Fields include H for headers, indicating the file version; S for segments, representing DNA fragments or nucleotides; L for links, which connect oriented segments, with their overlap represented by a CIGAR string; J for jumps, defining connections between segments that cannot be associated with a specific overlap or sequence (mainly gaps due to unassembled regions); and P for paths, containing an ordered list of oriented segments supported by a link or a jump. [27]
The GFA format offers a standardized way to encode sequence nodes and their linkages in variation graphs. While other formats like Variant Call Format (VCF) are integrated to embed variant information directly into the graph model, and succinct index structures like GCSA/GCSA2 exist, GFA's strength lies in providing a base for both structural connectivity and population variation data.[29]
Applications
Microbial genomics
Microbial species such as bacteria often have high levels of genome plasticity with high levels of horizontal gene transfer, gene content variation, and rearrangements. Thus, the pan-genome of a microbial species can encompass a core set of genes plus a large pool of accessory genes that vary by strain.[30] In microbial genomics, gene-level pan-genome graphs are used to analyze the repertoire of genes. For instance, nodes representing genes can help identify which pathways are core vs. accessory, and edges can show conserved gene neighbourhoods or genomic islands. In this description, graphs can be used to track the gain or loss of pathogenicity islands, antibiotic resistance genes, or mobile elements across strains. [31] Beyond gene presence, nucleotide-level graphs allow the detection of micro-variants within core genes and the mapping of sequencing reads from new strains to a graph of all known strains. Studies have shown that using a pan-genome graph instead of a single reference for read alignment in pathogens can improve mapping rates and variant calling.[32]
Personalized medicine
In human genomics and medicine, pan-genome graphs promise to make genomic analyses more inclusive and accurate for individuals from diverse populations. The current practice of using a single human reference genome (such as the GRCh38 build) has well-known biases. For instance, if a person has genetic variants not present in the reference, reads carrying those variants may align poorly or not at all, leading to missed or miscalled variants.[33] This is particularly problematic for structural variants or for populations under-represented in the reference genome. Accordingly, a human pan-genome graph, which incorporates sequences from many individuals, addresses this by providing alternate alleles at many loci.[34] Pangenome graphs have transformed clinical genomics and personalized medicine by providing a comprehensive view of genetic diversity, especially in regions that are underrepresented in traditional reference genomes. This enhanced resolution not only facilitates tailored therapeutic strategies but also promotes global health equity, as demonstrated by initiatives focusing on Middle Eastern and South Asian populations.[35]
Comparative genomic
Comparative genomics involves studying the similarities and differences in genome content and organization between different species or within a species. Pan-genome graphs are powerful in this arena because they provide a unifying framework to compare multiple genomes directly. For within-species comparisons, a graph can represent polymorphisms and structural variants (SVs), which enables analyses of genome diversity and evolution. For example, in plant genomics, a graph of many cultivars or wild accessions can reveal structural variations like the presence/absence of gene duplications or inversions that may underlie trait differences. For instance, the construction of a tomato pan-genome graph from 838 genomes enabled the discovery of previously "missing" heritability and trait-linked variants that were not detectable with a single reference.[10] Additionally, pan-genome graphs allow for the integration and analysis of SVs across a diverse set of genomes, improving the accuracy in detecting rare SVs that are commonly overlooked with single reference genomes. For example, pan-genome graphs have substantially enhanced the analysis of SVs in rare genetic diseases by integrating SV data from haploid genomes into a unified graph structure, which enables precise delineation of complex and rare alleles. This approach not only boosts allele sharing between related individuals, confirming lower error rates but also facilitates the identification of ultra-rare SVs (minor allele frequency <1%) that disrupt coding sequences in known disease genes, such as the novel diagnostic deletion in KMT2E, ultimately offering a more robust framework for population genomic analyses and rare disease diagnostics.[36]
Pan-Transcriptome analysis
By incorporating population-level genetic variation, spliced pan-genome graphs make it possible to identify transcripts that are unique to specific haplotypes. This increases the accuracy of gene expression measurements, especially for complex cases like allele-specific expression. In practice, tools can combine known transcripts with genomic variants to create a spliced pan-genome graph, generating haplotype-specific transcripts (HSTs). Specialized aligners then map RNA-seq reads to this graph, capturing the full range of splicing and variation more effectively than traditional methods. Finally, expression levels for these HSTs are quantified, reducing bias and further improving accuracy. As a result, this approach can achieve very high accuracy in matching reads to an individual's specific haplotypes.[37]
Genotyping
Genotyping accuracy and scalability, particularly for structural variants (SVs), have been enhanced by pangenome graphs because they address the limitations of linear reference genomes. Integrating population diversity into reference structures in pangenome graphs enables high-throughput genotyping. For instance, GraphTyper2 is a method for SV and small variant genotyping in a pangenome graph framework, paving the way for more comprehensive and bias‐reduced population-scale genome analyses. It employs graph-aware alignment via pangenome paths, mitigating biases inherent to linear references, improving SV representation in diverse populations such as pathogenic SVs in Icelandic families.[38]
References
- ^ Hickey, Glenn; et al. (2024). "Pangenome graph construction from genome alignments with Minigraph-Cactus". Nature Biotechnology. 42 (4): 663–673. doi:10.1038/s41587-023-01793-w. PMC 10638906. PMID 37165083.
- ^ a b c d e Garrison, Erik; Sirén, Jouni; Novak, Adam M.; Hickey, Glenn; Eizenga, Jordan M.; Dawson, Eric T.; Jones, William; Garg, Shilpa; Markello, Charles; Lin, Michael F.; Paten, Benedict; Durbin, Richard (2018). "Variation graph toolkit improves read mapping by representing genetic variation in the reference". Nature Biotechnology. 36 (9): 875–879. doi:10.1038/nbt.4227. PMC 6126949. PMID 30125266.
- ^ a b c Liao, Wen-Wei; et al. (2023). "A draft human pangenome reference". Nature. 617 (7960): 312–324. Bibcode:2023Natur.617..312L. doi:10.1038/s41586-023-05896-x. PMC 10172123. PMID 37165242.
- ^ a b c Eizenga, Jordan M.; Novak, Adam M.; Sibbesen, Jonas A.; Heumos, Simon; Ghaffaari, Ali; Hickey, Glenn; Chang, Xian; Seaman, Josiah D.; Rounthwaite, Robin; Ebler, Jana; Rautiainen, Mikko; Garg, Shilpa; Paten, Benedict; Marschall, Tobias; Sirén, Jouni; Garrison, Erik (2020). "Pangenome Graphs". Annual Review of Genomics and Human Genetics. 21: 139–162. doi:10.1146/annurev-genom-120219-080406. PMC 8006571. PMID 32453966.
- ^ Tettelin, Hervé; et al. (2005). "Genome analysis of multiple pathogenic isolates of Streptococcus agalactiae: Implications for the microbial "pan-genome"". Proceedings of the National Academy of Sciences of the United States of America. 102 (39): 13950–13955. Bibcode:2005PNAS..10213950T. doi:10.1073/pnas.0506758102. PMC 1216834. PMID 16172379.
- ^ Paten, Benedict; Novak, Adam M.; Eizenga, Jordan M.; Garrison, Erik (2017). "Genome graphs and the evolution of genome inference". Genome Research. 27 (5): 665–676. doi:10.1101/gr.214155.116. PMC 5411762. PMID 28360232.
- ^ Lee, Christopher; Grasso, Catherine; Sharlow, Mark F. (2002). "Multiple sequence alignment using partial order graphs". Bioinformatics. 18 (3): 452–464. doi:10.1093/bioinformatics/18.3.452. PMID 11934745.
- ^ Iqbal, Zamin; Caccamo, Mario; Turner, Isaac; Flicek, Paul; McVean, Gil (2012). "De novo assembly and genotyping of variants using colored de Bruijn graphs". Nat Genet. 44 (2): 226–232. doi:10.1038/ng.1028. PMC 3272472. PMID 22231483.
- ^ Dilthey, Alexander; Cox, Charles; Iqbal, Zamin; Nelson, Matthew R.; McVean, Gil (2015). "Improved genome inference in the MHC using a population reference graph". Nat Genet. 47 (6): 682–688. doi:10.1038/ng.3257. PMC 4449272. PMID 25915597.
- ^ a b Zhou, Yao; Zhang, Zhiyang; Bao, Zhigui; Li, Hongbo; Lyu, Yaqing; Zan, Yanjun; Wu, Yaoyao; Cheng, Lin; Fang, Yuhan; Wu, Kun; Zhang, Jinzhe; Lyu, Hongjun; Lin, Tao; Gao, Qiang; Saha, Surya; Mueller, Lukas; Fei, Zhangjun; Städler, Thomas; Xu, Shizhong; Zhang, Zhiwu; Speed, Doug; Huang, Sanwen (2022). "Graph pan-genome captures missing heritability and empowers tomato breeding". Nature. 606 (7914): 527–534. Bibcode:2022Natur.606..527Z. doi:10.1038/s41586-022-04808-9. PMC 9200638. PMID 35676474.
- ^ a b Liao, WW.; Asri, M.; Ebler, J. (2023). "A draft human pangenome reference". Nature. 617 (7960): 312–324. Bibcode:2023Natur.617..312L. doi:10.1038/s41586-023-05896-x. PMC 10172123. PMID 37165242.
- ^ a b The Computational Pan-Genomics Consortium (January 2018). "Computational pan-genomics: status, promises and challenges". Briefings in Bioinformatics. 19 (1): 118–135. doi:10.1093/bib/bbw089. PMC 5862344. PMID 27769991.
- ^ Garrison, E; Guarracino, A (2023-01-01). "Unbiased pangenome graphs". Bioinformatics. 39 (1): btac743. doi:10.1093/bioinformatics/btac743. PMC 9805579. PMID 36448683.
- ^ Andreace, F.; Lechat, P.; Dufresne, Y. (2023). "Comparing methods for constructing and representing human pangenome graphs". Genome Biol. 24 (1): 274. doi:10.1186/s13059-023-03098-2. PMC 10691155. PMID 38037131.
- ^ Wittler, Roland (2020). "Alignment- and reference-free phylogenomics with colored de Bruijn graphs". Algorithms Mol Biol. 15: 4. doi:10.1186/s13015-020-00164-3. PMC 7137503. PMID 32280365.
- ^ Compeau, P. E.; Pevzner, P. A.; Tesler, G. (2011). "Why are de Bruijn graphs useful for genome assembly?". Nat Biotechnol. 29 (11): 987–991. doi:10.1038/nbt.2023. PMC 5531759. PMID 22068540.
- ^ a b c Andreace, F; Lechat, P; Dufresne, Y; Chikhi, R (2023-11-30). "Comparing methods for constructing and representing human pangenome graphs". Genome Biol. 24 (1): 274. doi:10.1186/s13059-023-03098-2. PMC 10691155. PMID 38037131.
- ^ Yang, Z; Guarracino, A; Biggs, PJ; Black, MA; Ismail, N; Wold, JR; Merriman, TR; Prins, P; Garrison, E; de Ligt, J (2023-08-10). "Pangenome graphs in infectious disease: a comprehensive genetic variation analysis of Neisseria meningitidis leveraging Oxford Nanopore long reads". Front Genet. 14: 1225248. doi:10.3389/fgene.2023.1225248. PMC 10448961. PMID 37636268.
- ^ a b c d Hickey G, Monlong J, Ebler J, Novak AM, Eizenga JM, Gao Y, Human Pangenome Reference Consortium, Marschall T, Li H, Paten B (2024). "Pangenome graph construction from genome alignments with Minigraph-Cactus". Nat Biotechnol. 42 (4): 663–673. doi:10.1038/s41587-023-01793-w. PMC 10638906. PMID 37165083.{{cite journal}}: CS1 maint: multiple names: authors list (link)
- ^ Van Dijk, Lucas R.; Manson, Abigail L.; Earl, Ashlee M.; Garimella, Kiran V.; Abeel, Thomas (2025). "Fast and exact gap-affine partial order alignment with POASTA". Bioinformatics. 41 (1). doi:10.1093/bioinformatics/btae757. PMC 11755094. PMID 39752324.
- ^ Raphael, Benjamin; Zhi, Degui; Tang, Haixu; Pevzner, Pavel (2004). "A novel method for multiple alignment of sequences with repeated and shuffled elements". Genome Res. 14 (11): 2336–2346. doi:10.1101/gr.2657504. PMC 525693. PMID 15520295.
- ^ Garrison, E.; Guarracino, A.; Heumos, S. (2024). "Building pangenome graphs". Nat Methods. 21 (11): 2008–2012. doi:10.1038/s41592-024-02430-3. PMID 39433878.
- ^ Paten, Benedict; Earl, Dent; Nguyen, Ngan; Diekhans, Mark; Zerbino, Daniel; Haussler, David (2011). "Cactus: Algorithms for genome multiple sequence alignment". Genome Res. 21 (9): 1512–1528. doi:10.1101/gr.123356.111. PMC 3166836. PMID 21665927.
- ^ Armstrong, Joel; Hickey, Glenn; Diekhans, Mark; Fiddes, Ian T.; Novak, Adam M.; Deran, Alden; Fang, Qi; Xie, Duo; Feng, Shaohong; Stiller, Josefin; Genereux, Diane; Johnson, Jeremy; Marinescu, Voichita Dana; Alföldi, Jessica; Harris, Robert S.; Lindblad-Toh, Kerstin; Haussler, David; Karlsson, Elinor; Jarvis, Erich D.; Zhang, Guojie; Paten, Benedict (2020). "Progressive Cactus is a multiple-genome aligner for the thousand-genome era". Nature. 587 (7833): 246–251. Bibcode:2020Natur.587..246A. doi:10.1038/s41586-020-2871-y. PMC 7673649. PMID 33177663.
- ^ Paten, B; Earl, D; Nguyen, N; Diekhans, M; Zerbino, D; Haussler, D (2011). "Cactus: Algorithms for genome multiple sequence alignment". Genome Res. 21 (9): 1512–1528. doi:10.1101/gr.123356.111. PMC 3166836. PMID 21665927.
- ^ Garrison, E; Guarracino, A (Jan 1, 2023). "Unbiased pangenome graphs". Bioinformatics. 39 (1): btac743. doi:10.1093/bioinformatics/btac743. PMC 9805579. PMID 36448683.
- ^ a b "GFA: Graphical Fragment Assembly (GFA) Format Specification". GitHub.
- ^ Guarracino, Andrea; Heumos, Simon; Nahnsen, Sven; Prins, Pjotr; Garrison, Erik (July 2022). "ODGI: understanding pangenome graphs". Bioinformatics. 38 (13): 3319–3326. doi:10.1093/bioinformatics/btac308. PMC 9237687. PMID 35552372.
- ^ Garrison, Erik Peter (2018). Graphical pangenomics (Doctoral dissertation thesis). University of Cambridge, Wellcome Sanger Institute. doi:10.17863/CAM.41621.
- ^ Juhas, Mario; Van Der Meer, Jan Roelof; Gaillard, Muriel; Harding, Rosalind M.; Hood, Derek W.; Crook, Derrick W. (2009). "Genomic islands: tools of bacterial horizontal gene transfer and evolution". FEMS Microbiol Rev. 33 (2): 376–393. doi:10.1111/j.1574-6976.2008.00136.x. PMC 2704930. PMID 19178566.
- ^ Noll, Nicholas; Molari, Marco; Shaw, Liam P.; Neher, Richard A. (2023). "PanGraph: scalable bacterial pan-genome graph construction". Microb Genom. 9 (6). doi:10.1099/mgen.0.001034. PMC 10327495. PMID 37278719.
- ^ Yang, Zuyu; Guarracino, Andrea; Biggs, Patrick J.; Black, Michael A.; Ismail, Nuzla; Wold, Jana Renee; Merriman, Tony R.; Prins, Pjotr; Garrison, Erik; De Ligt, Joep (2023). "Pangenome graphs in infectious disease: a comprehensive genetic variation analysis of Neisseria meningitidis leveraging Oxford Nanopore long reads". Front. Genet. 14. doi:10.3389/fgene.2023.1225248. PMC 10448961. PMID 37636268.
- ^ Matthews, Chelsea A.; Watson-Haigh, Nathan S.; Burton, Rachel A.; Sheppard, Anna E. (2024). "A gentle introduction to pan-genomics". Briefings in Bioinformatics. 25 (6). doi:10.1093/bib/bbae588. PMC 11570541. PMID 39552065.
- ^ Abondio, Paolo; Cilli, Elisabetta; Luiselli, Donata (2023). "Human Pangenomics: Promises and Challenges of a Distributed Genomic Reference". Life (Basel). 13 (6): 1360. Bibcode:2023Life...13.1360A. doi:10.3390/life13061360. PMC 10304804. PMID 37374141.
- ^ Nassir, N.; Almarri, A.; Akter, H. (2025). "Advancing clinical genomics with Middle Eastern and South Asian pangenomes". Nat Med. doi:10.1038/s41591-025-03544-7. PMID 40038508.
- ^ Groza, C.; Schwendinger-Schreck, C.; Cheung, W.A. (2024). "Pangenome graphs improve the analysis of SVs in rare genetic diseases". Nat Commun. 15 (1): 657. doi:10.1038/s41467-024-44980-2. PMC 10803329. PMID 38253606.
- ^ Sibbesen, Jonas A.; Eizenga, Jordan M.; Novak, Adam M. (2023-02-01). "Pangenome-aware transcriptome analyses using spliced pangenome graphs". Nature Methods. 20 (2): 239–247. doi:10.1038/s41592-022-01731-9. ISSN 1548-7091. PMID 36646895.
- ^ Eggertsson, H.P.; Kristmundsdottir, S.; Beyter, D. (2019). "GraphTyper2 enables population-scale genotyping of structural variation using pangenome graphs". Nat Commun. 10 (1): 5402. Bibcode:2019NatCo..10.5402E. doi:10.1038/s41467-019-13341-9. PMC 6881350. PMID 31776332.