Skip to main content

TECHNOLOGY AND CODE article

Front. Bioinform., 15 November 2024
Sec. Genomic Analysis

Benchmarking of Hi-C tools for scaffolding plant genomes obtained from PacBio HiFi and ONT reads

  • 1Department of Agricultural Sciences, University of Sassari, Sassari, Sardinia, Italy
  • 2Edinburgh Genomics, The University of Edinburgh, Edinburgh, United Kingdom

The implementation of Hi-C reads in the de novo genome assembly process allows the ordering of large regions of the genome in scaffolds and the generation of chromosome-level assemblies. Several bioinformatics tools have been developed for genome scaffolding with Hi-C, and each tool has advantages and disadvantages that need to be carefully evaluated before their adoption. We generated two de novo assemblies of Arabidopsis thaliana obtained from the same raw PacBio HiFi and Oxford Nanopore Technologies data. We scaffolded the assemblies implementing Hi-C reads with the scaffolders 3D-DNA, SALSA2, and YaHS, with the aim of identifying the tool providing the most accurate assembly. The scaffolded assemblies were evaluated according to contiguity, completeness, accuracy, and structural correctness. In our analysis, YaHS proved to be the best-performing bioinformatics tool for scaffolding de novo genome assemblies in Arabidopsis thaliana.

1 Introduction

Third-generation sequencing (TGS) technologies, for example, Pacific Biosciences (PacBio) and Oxford Nanopore Technologies (ONT), produce long reads that can be used to obtain high-quality genome sequences. Compared to next-generation sequencing technologies, TGS provides better resolution and contiguity, allowing partial resolution of the assembly of repeats and duplications, which is crucial for resolving repeat-rich genomic regions such as centromeres and telomeres, especially in plant genomes (Jung et al., 2019).

Although long read assembly alone can yield long contigs, this process can still be far from assembling at the chromosome scale without additional scaffolding efforts. Strategically, larger genome projects such as the Vertebrate Genome Project (VGP–https://vertebrategenomesproject.org/) and the Darwin Tree of Life (DToL–https://www.darwintreeoflife.org/) combine multiple data types such as optical mapping (Zhou et al., 2007) and Hi-C (Burton et al., 2013) to construct reliable chromosome-scale assemblies (Guan et al., 2021). Hi-C reads are also part of the standards and recommendations for genome assembly of the Earth BioGenome Project (Lawniczak et al., 2022).

Originally developed to study the three-dimensional organization of the genome (Lieberman-aiden et al., 2009), Hi-C reads are now largely employed for scaffolding de novo genome assemblies (Ghurye and Pop, 2019). Hi-C technology is a method that combines proximity-based ligation with massively parallel sequencing, allowing the unbiased identification of chromatin interactions across an entire genome. This allows grouping, ordering, and orienting contigs (i.e., contiguous sequences) based on chromatin contact frequency between different genomic regions (Yamaguchi et al., 2021), resulting in accurate chromosome-level assemblies (Marie-Nelly et al., 2014).

High-quality, chromosome-level genome assembly is essential in plant science and genetic research, as it influences our comprehension of the genetic architecture of significant traits and facilitates marker selection and candidate gene identification (Benevenuto et al., 2019). In addition, it enables comparative analysis of structural features and gives insights into the evolutionary history of plant genomes (Shirasawa et al., 2021). Hi-C is currently the favored method of de novo genome scaffolding because, unlike optical mapping, it does not necessarily require the extraction of super-long genomic DNA fragments (Shirasawa et al., 2021). In addition, optical mapping methodologies are technically demanding and necessitate optimization for each species (Michael and VanBuren, 2020). Hi-C reads enhance the differentiation of contigs from distinct chromosomes and ensure the continuity of scaffolding outcomes (Luo et al., 2021). Nonetheless, although Hi-C usually facilitates the resolution of genomes into chromosomes, they may not be sufficient with more complicated plant genomes (Michael and VanBuren, 2020).

The choice of the Hi-C scaffolding bioinformatic tool is crucial for obtaining optimal results in de novo assembly, and, therefore, comparative analyses are needed.

A previous benchmarking study of Hi-C-based scaffolders (Sur et al., 2022) evaluated the performance of five different tools: Lachesis (Burton et al., 2013), HiRise (https://github.com/DovetailGenomics/HiRise_July2015_GR), 3d-dna (Dudchenko et al., 2017), SALSA (Ghurye et al., 2017), and AllHiC (Zhang et al., 2019). The study was based on partitioned reference genomes and de novo assemblies generated from PacBio CLR reads with Canu (Koren et al., 2017). The scaffolders’ performance evaluation was based on the mapping of assemblies against the known reference genome using MUMmer4 (Marçais et al., 2018) and on a set of accuracy metrics calculated using the Python package Edison (https://github.com/Noble-Lab/edison), which examines scaffolding outcomes in comparison to a reference genome. The assembly evaluation method of this study strongly relied on the existence of a reference genome, leading to a reference-biased assessment that might not be the optimal strategy for de novo assembly.

A second benchmarking of Hi-C scaffolders was conducted by Hou et al., 2023. The authors generated several de novo assemblies from PacBio HiFi data of different plant species and performed the scaffolding using only simulated Hi-C data. They evaluated the assemblies scaffolded with LACHESIS (Burton et al., 2013), Pin_hic (Guan et al., 2021), YaHS (Zhou et al., 2023), SALSA2 (Ghurye et al., 2019), 3d-DNA (Dudchenko et al., 2017), and ALLHiC (Zhang et al., 2019) based on distinct k-mers using a variety of metrics.

In this study, we benchmarked the three most frequently used Hi-C scaffolders [3D-DNA (Dudchenko et al., 2017), SALSA2 (Ghurye et al., 2019), and YaHS (Zhou et al., 2023)], with the aim of identifying the tool producing the most accurate chromosome-scale de novo genome assembly. 3D-DNA was chosen due to its widespread application and ongoing active development. SALSA2 is the new version of SALSA, while YaHS is the most recently released scaffolder. We excluded several tools: LACHESIS (Burton et al., 2013) because it is no longer under development; HiRise (https://github.com/DovetailGenomics/HiRise_July2015_GR, which is not open source; SALSA (Ghurye et al., 2017), which was replaced by SALSA2; ALLHiC (Zhang et al., 2019), which is specifically developed for autopolyploid genomes; and Pin_hic (Guan et al., 2021), which is not extensively used among the community.

We generated two de novo assemblies of A. thaliana, the model species for plant genomics (Koornneef and Meinke, 2010), using the same raw reads obtained from the BioProject PRJCA005809 (Wang et al., 2022). The dataset was selected for being a plant dataset with an extensive array of reads including PacBio HiFi, ONT, Hi-C, and Illumina. The assemblies were produced using different assembly methodologies to obtain the primary contigs, with the goal of assessing potential discrepancies in the scaffolding results attributable to the assembly strategy.

To facilitate the benchmarking work, we developed assemblyQC, a Bash pipeline that combines QUAST (Mikheenko et al., 2018), BUSCO (Manni et al., 2021), and Merqury (Rhie et al., 2020). These three tools assess the quality of de novo assemblies without relying on a reference genome. The pipeline also optionally uses Liftoff (Shumate and Salzberg, 2021) to annotate the de novo assembly, and a Python script subsequently analyzes the positioning of genes on the target assembly compared to the reference genome. AssemblyQC automatically launches these tools with minimal user input. It is available on GitHub at https://github.com/LiaOb21/assemblyQC.

2 Materials and methods

2.1 The A. thaliana genome and raw data

The first A. thaliana genomic sequence was obtained in 2000 from the Columbia genotype using the minimum tiling path of BACs sequenced with Sanger technology (Kaul et al., 2000). The genome sequence spans approximately 135 Mb in length and is organized into five chromosomes (2n = 10).

In this study, we used publicly available raw data from BioProject PRJCA005809 (Wang et al., 2022) to construct two de novo assemblies and evaluate the performance of the three scaffolders and possible inconsistencies in outcomes due to the assembly method.

Table 1 summarizes the characteristics of the raw reads used. Illumina reads were not used for the assembly process, but they were used with Merqury (Rhie et al., 2020) for scaffolding evaluation purposes.

Table 1
www.frontiersin.org

Table 1. Overview of the characteristics of the raw reads from BioProject PRJCA005809 (Wang et al., 2022) used in the assembly process.

2.2 De novo assembly

ONT reads were trimmed with NanoFilt (Coster et al., 2018) using the parameter -l 500, which only retained the reads with a minimum length of 500 bp.

The first de novo assembly was obtained by assembling ONT reads using Flye (Kolmogorov et al., 2019) in --nano-raw mode with default parameters. To subsequently perform the polishing, the PacBio HiFi reads were mapped to the draft assembly using minimap2 (Li, 2018) in map-hifi mode, and then the polishing was performed with Racon (Vaser et al., 2017). Haplotigs and overlaps in the assembly were removed using Purge _dups (Guan et al., 2020). Contaminants were removed using BlobToolKit (Challis et al., 2020) by applying a filter for GC content equal to 0.4 because Tiara (Karlicki et al., 2022) identified contigs with higher GC content as “unknown.” Hereafter, we will refer to this assembly as “Flye.”

The second de novo assembly was obtained by assembling the HiFi and ONT reads together using Hifiasm (Cheng et al., 2021) with the default parameters. Haplotigs and overlaps in the assembly were removed using purge_dups (Guan et al., 2020). Contaminants were removed using BlobToolKit (Challis et al., 2020), applying a filter for GC content equal to 0.5 because Tiara (Karlicki et al., 2022) identified contigs with higher GC content as “unknown” or “bacteria.” Furthermore, a filter for HiFi coverage equal to 5,180 was applied as contigs above this level of coverage were identified as organelles by Tiara. Hereafter, we will refer to this assembly as “Hifiasm.”

2.3 Hi-C scaffolding

All the Hi-C scaffolders combine Hi-C linkage information with draft genome assemblies to resolve contig orientations.

As a first step, the 3D-DNA algorithm identifies assembly errors where a scaffold’s long-range contact pattern changes unexpectedly. Thereafter, the resulting sequences are anchored, ordered, and oriented via an algorithm based on the contact frequency between pairs of sequences to indicate their proximity in the genome. Finally, contigs and scaffolds that correspond to overlapping regions of the genome are merged (Dudchenko et al., 2017).

SALSA2 builds scaffold graph scoring edges according to a “best buddy” scheme. The scaffolds are then constructed according to a greedy weighted maximum matching. Afterward, SALSA2 performs an iterative step of misjoin detection and correction, which stops naturally when accurate Hi-C links are exhausted (Ghurye et al., 2019).

YaHS is the newest scaffolder that has been developed and compared to previous scaffolders, it proposes a new method for building the contact matrix. The software builds a contact matrix, constructs and prunes a scaffold graph, and outputs the scaffolds (Zhou et al., 2023).

Hi-C reads were trimmed before performing the scaffolding using fastp with the following parameters: -p, --detect_adapter_for_pe, --cut_front, --cut_tail, --cut_window_size 4, and--cut_mean_quality 20.

2.3.1 3D-DNA

Hi-C reads were filtered and aligned to the draft assembly, using Juicer (Durand et al., 2016) with the parameters -p assembly, -s none, and -S early. The fasta file of the contig-level assembly was given as input for both the Juicer flags --g, normally used to input a reference assembly, and --z, to avoid reference biases. Prior to scaffolding, the contig-level assembly was wrapped using the script wrap-fasta-sequence.awk. Finally, the run-asm-pipeline.sh script from 3D-DNA (Dudchenko et al., 2017) was run with the wrapped.fasta file, and the list of Hi-C contacts in .txt format was outputted by Juicer. The scripts used were those provided for a single CPU run.

2.3.2 SALSA2

Hi-C reads were filtered and aligned to the contig-level assembly following the Arima Genomics mapping pipeline (https://github.com/ArimaGenomics/mapping_pipeline). Steps 1A and 1B of the pipeline were modified by adding the flag -M to the bwa mem commands. The resulting bam file was subsequently sorted by read name using samtools sort and converted to a .bed file using bedtools. Finally, the script run_pipeline.py from SALSA2 (Ghurye et al., 2019) was run with the parameters -e GATC and -m yes to perform the scaffolding.

2.3.3 YaHS

The Hi-C reads were filtered and aligned to the contig-level assembly following the same methods described for SALSA2. The output.bam file of the Arima Genomics mapping pipeline was sorted and converted to the .bed format as described above. YaHS was finally run with the parameter -e GATC (Zhou et al., 2023).

2.4 AssemblyQC pipeline

We developed assemblyQC, a Bash pipeline designed to perform quality control of assemblies. AssemblyQC combines QUAST, BUSCO, and Merqury and optionally runs Liftoff along with a Python script that produces metrics about gene positioning in the assembly compared to a given reference genome.

QUAST (Mikheenko et al., 2018) is a tool that computes relevant quality metrics useful for evaluating de novo assemblies and comparing them against reference sequences. Using the flag -w, assemblyQC runs QUAST-LG, the QUAST extension for evaluating large genomes. In our case, regular QUAST was run.

BUSCO (Manni et al., 2021) evaluates genome assembly quality in terms of gene completeness. To run BUSCO using assemblyQC, it is necessary to previously download the database of the lineage of interest. In our case, this was brassicales_odb10.

Merqury (Rhie et al., 2020) allows reference-free assembly evaluation of accuracy and completeness, comparing the k-mers found in the de novo assembly with those present in high-accuracy raw reads. To run Merqury, it is necessary to previously generate a k-mer database using Meryl. Illumina short reads were used to construct the Meryl database. AssemblyQC supports only the case in which one assembly with no hap-mers (i.e., haplotype-specific k-mers) is provided to run Merqury.

Liftoff (Shumate and Salzberg, 2021) is a standalone tool that accurately maps annotations from a reference genome to a target assembly. Reference.fasta and .gff/.gtf files and the .fasta file of the target assembly are needed; the output is a .gff/.gtf file for the target assembly. Assembly QC accepts as input for Liftoff only files in .gff format and optionally filters out organelle annotations before running this program.

AssemblyQC runs Liftoff with the flag --exclude-partial, which is used to exclude partial/low sequence identity mappings (coverage ≥ 0.5 and sequence identity ≥ 0.5) from the output.gff.

liftoff_combine.py is a Python script we developed to output metrics about gene collinearity between the target assembly and the reference genome. We define gene collinearity as the correspondence between the gene position in the target assembly and that in the reference genome. The script takes the output.gff from Liftoff and the reference.gff file as input. The script analyses only gene collinearity; it excludes exons and transcripts from the .gff files. Moreover, the script allows us to set a threshold to evaluate the divergence in intergenic length between pairs of adjacent genes between the target and the reference assemblies: if the divergence is lower than the threshold, the compared genomic annotations are considered coherent (default: 500 bp).

liftoff_combine.py outputs a .txt file per reference chromosome that provides information regarding i) which contigs or scaffolds in the target assembly correspond to the reference chromosome, ii) which orientation contigs or scaffolds in the target assembly have compared to the reference, and iii) whether and in which measure the distance between adjacent genes in the target assembly match the distance between corresponding genes in the reference assembly.

The secondary outputs of this script are a merged assembly-reference.gff for the whole genome, merged.gff files per chromosome, and records of the genes showing divergent gene distances between the reference and the assembly per chromosome.

For this study, we ran assemblyQC, including the Liftoff step. We removed organelle annotations from the reference.gff file and adopted a divergence threshold of 500 bp for liftoff_combine.py. The input k-mer length was determined with the Merqury command best_k.sh.

2.5 Evaluation criteria

The evaluation of the two scaffolded assemblies was based on several approaches: 1) contiguity, that is, number of contigs, N50, N90, L50, and L90 and the cumulative length plot, obtained with QUAST; 2) completeness, calculated as i) genome fraction, obtained with QUAST; ii) presence, completeness, and duplication of ortholog genes, calculated by BUSCO comparing the assemblies with the database for Brassicales (brassicales_odb10); iii) k-mer completeness, calculated by Merqury; 3) accuracy, assessed through Merqury consensus quality (QV) and copy number spectrum plots; 4) structural correctness, based on gene collinearity metrics provided by the Liftoff plus liftoff_combine.py method and the Hi-C contact map generated using JuiceBox Assembly Tools (JBAT) (Dudchenko et al., 2018). Furthermore, the three scaffolders were evaluated according to the estimated runtime, determined by examining the timestamps (i.e., wall clock time) of the first file and the most recent files generated by the tools.

2.6 Cluster characteristics

The programs in benchmarking were executed on a Linux machine containing two 2.1 GHz, 18-core Intel Xeon E5-2695 (Broadwell) series processors, where each of the cores in these processors supports two hyperthreads enabled by default with 256 GB of memory.

3 Results and discussion

3.1 YaHS outperforms SALSA2 and 3D-DNA in terms of assembly contiguity

Table 2 shows the QUAST metrics of the scaffolded assemblies compared to the contig-level assemblies Flye and Hifiasm. All the scaffolders were able to align more than 99% of bases to the reference genome of A. thaliana (TAIR10.1).

Table 2
www.frontiersin.org

Table 2. Comparison of the assemblies according to QUAST metrics.

SALSA2 and YaHS were able to reduce the number of contigs of the draft assembly, while 3D-DNA increased the number. The best result was achieved by YaHS for both assemblies. YaHS reduced the number of contigs from fifteen to seven in the case of Flye and from five to four in the case of Hifiasm, probably introducing a false joint between two contigs as five chromosomes are expected for A. thaliana. Notably, the number of contigs dramatically increased for Hifiasm scaffolded with 3D-DNA, increasing to 342 contigs from the initial five contigs.

Compared with the draft assemblies, all the scaffolders increased the N50, except for Hifiasm scaffolded with 3D-DNA, for which the N50 decreased from the initial ≈26 Mb to ≈3 Mb. Only YaHS increased the N90 for both Flye (from ≈9 Mb to ≈19 Mb) and Hifiasm (from ≈22.3 Mb to ≈22.7 Mb). 3D-DNA increased the N90 only for Flye (from ≈9 Mb to ≈12 Mb), while it strongly decreased the N90 in the case of Hifiasm (from ≈22 Mb to ≈2 Mb). SALSA2 did not produce changes in N90 in the case of Flye, while it decreased N90 for Hifiasm (from ≈22 Mb to ≈13 Mb). YaHS produced the highest N50 and N90 for both assemblies.

Flye L50 was reduced by both 3D-DNA and YaHS, while no L50 changes were produced by SALSA2. Hifiasm L50 was decreased by YaHS. YaHS also achieved the lowest L90 for both assemblies.

The full QUAST report is shown in Supplementary Table S1.

Figure 1 shows the QUAST plot for cumulative length (Mbp). The Flye assembly was improved by all the scaffolders, with YaHS giving the best results for all the parameters considered. In this case, 3D-DNA slightly increased the fragmentation of the assembly by increasing the number of contigs, but it improved all the other parameters. SALSA2 reduced the number of contigs and increased the N50, keeping the other parameters unchanged.

Figure 1
www.frontiersin.org

Figure 1. QUAST plot for cumulative length (Mbp).

In conclusion, the Hifiasm assembly showed good metrics at the contig-level. YaHS was the only scaffolder that did not increase assembly fragmentation, but it introduced a false joint, joining two contigs in the same scaffold. SALSA2 and 3D-DNA increased the assembly fragmentation, with the latter representing the most extreme case.

3.2 3D-DNA decreased orthologs completeness in the assembly produced with Hifiasm

Figure 2 shows the comparison between Flye and Hifiasm and the relative scaffolded assemblies with respect to the BUSCO metrics.

Figure 2
www.frontiersin.org

Figure 2. Comparison of the assemblies according to BUSCO metrics.

Compared with those of the contig-level assemblies, the numbers of complete, missing, and fragmented BUSCOs in SALSA2 and YaHS remained unchanged. However, YaHS increased the number of complete and single-copy BUSCOs and decreased the number of duplicated BUSCOs, unlike SALSA2.

3D-DNA behaved differently according to the assembly considered. In the case of Flye, it increased the number of complete BUSCOs, decreased the number of missing BUSCOs, and kept fragmented BUSCOs unaltered compared to those of the contig-level assembly, overall improving the BUSCO metrics. On the other hand, for Hifiasm, 3D-DNA decreased the number of complete BUSCOs and increased the number of missing and fragmented BUSCOs, decreasing the overall metric quality compared to that of the contig-level assembly.

3.3 Hi-C scaffolders have little influence on k-mer completeness and consensus quality

Table 3 shows the results obtained for each assembly with Merqury.

Table 3
www.frontiersin.org

Table 3. Comparison of the assemblies according to Merqury metrics.

The QV values in the scaffolded assemblies compared to those in the contig-level assemblies remained unaltered, except for Hifiasm scaffolded with 3D-DNA, for which the QV decreased from 60.0914 to 60.0911.

All the Flye assemblies showed a level of completeness above 98.6%, and all the Hifiasm assemblies showed completeness >98.9%.

Copy number spectrum plots for each assembly are shown in Supplementary Figure S1. All the assemblies fit the expected copy number spectrum for a haploid genome.

3.4 YaHS generates the most structurally correct chromosome-length assemblies

The detailed results of comparing gene positioning in the assemblies and the reference genome TAIR10.1 are reported in Supplementary Tables S2–S6).

Table 4 displays the number of contigs or scaffolds in the target assemblies containing genes mapped to chromosomes 1 to 5 in the reference genome TAIR10.1 according to the Liftoff results.

Table 4
www.frontiersin.org

Table 4. Number of contigs or scaffolds in the target assemblies containing genes annotated on chromosomes 1 to 5 in the reference genome TAIR10.1 according to the Liftoff results.

YaHS was the only scaffolder able to reduce the number of scaffolds corresponding to the TAIR10.1 chromosomes according to gene content in comparison to both the contig-level assemblies and for all the chromosomes.

Notably, for Hifiasm, which was initially formed by five contigs (i.e., the expected number of chromosomes), 3D-DNA dramatically increased the number of scaffolds corresponding to the reference chromosomes according to the gene content.

With respect to the orientation of the scaffolds, we considered a contig or scaffold to have a clear orientation with respect to the reference genome when at least 90% of the gene coordinates were in ascending (forward orientation) or descending order (reverse orientation).

With respect to Flye, 3D-DNA provided a clear orientation for all the chromosomes, except for the scaffolds corresponding to chromosome 2, where the proportion of genes in the same orientation as the reference and the proportion of genes in reverse complement orientation were 86.6% and 13.1%, respectively. SALSA2 conserved the orientation of the scaffolds of the Flye contig-level assembly for chromosomes 1 and 3, which were in the same orientation and in reverse complement, respectively, compared to the reference genome. It was not able to provide a clear orientation for the scaffolds corresponding to chromosomes 2, 4, and 5 in TAIR10.1. YaHS was able to provide a clear orientation for all the scaffolds.

In the case of Hifiasm, 3D-DNA was not able to define scaffold orientation for any chromosome, except for the scaffolds corresponding to chromosome 4 of TAIR10.1, which were in reverse complement orientation compared to the reference genome, as the contig-level Hifiasm assembly. SALSA2 showed a clear orientation for the scaffolds corresponding to chromosomes 1, 3, and 5, while the orientation was not clear for chromosomes 2 and 4. YaHS was able to provide a clear orientation for all the scaffolds.

Overall, YaHS was the only scaffolder that decreased the number of scaffolds corresponding to the reference chromosomes for both assemblies. YaHS was also the only scaffolder to provide a clear orientation for all the scaffolds. The collinearity results confirmed that YaHS introduced a false joint in the Hifiasm assembly, merging the scaffolds that corresponded to chromosomes 3 and 4 in TAIR10.1.

The Hifiasm assembly deserves particular attention. This assembly contained only five contigs that mainly corresponded to the chromosomes of TAIR10.1 before scaffolding. The Hifiasm contigs ptg000001l_1 and ptg000002l_1 contained mainly genes corresponding to chromosome 2 and chromosome 4 of TAIR10.1, respectively. However, ptg000001l_1 and ptg000002l_1 also contained seven and two genes, respectively, which were mapped to TAIR10.1 chromosome 3. YaHS partially resolved these misplacement events: only the seven genes that were in contig ptg000001l_1 were placed in the scaffold_4 corresponding to chromosome 2 of TAIR10.1, while the other two genes that were originally mapped to ptg000002l_1 were correctly placed in scaffold_1, corresponding to chromosome 3. SALSA2 did not resolve these misplacements. Due to the high level of fragmentation introduced by 3D-DNA, it was impossible to evaluate how this scaffolder handled these misplacement events (Table 5). Further data are needed to ascertain whether the seven genes of Hifiasm contig ptg000002l_1 represent a misplacement or a true translocation event.

Table 5
www.frontiersin.org

Table 5. Correspondence between reference chromosome 3, contigs in Hifiasm, and scaffolds in Hifiasm scaffolded with SALSA2 and YaHS for the nine genes involved in an observed misplacement. The detailed correspondence chromosome-contigs and chromosome-scaffolds are reported in Supplementary Tables S2–S6.

JuiceBox Assembly Tools (JBAT) (Dudchenko et al., 2018) allows visualization of the Hi-C contact map and manual curation of the scaffolded assemblies (Figures 3A, C, D, F). SALSA2 provides a method that only allows visualization of the contact map in JBAT but does not allow the highlighting of contigs and scaffolds; therefore, manual curation of the assembly is not possible (Figures 3B, E).

Figure 3
www.frontiersin.org

Figure 3. Contact maps obtained with JBAT. (A–C) Contact maps of the Flye assembly scaffolded with 3D-DNA, SALSA2, and YaHS, respectively. (D–F) A contact map of the Hifiasm assembly scaffolded with 3D-DNA, SALSA2, and YaHS, respectively. In (A, C, D, F), the green lines represent the contigs, and the blue lines represent the scaffolds.

Only YaHS correctly identified the major scaffolds corresponding to the chromosomes in both Flye and Hifiasm (Figures 3C, F). In the latter case, YaHS identified four major scaffolds because two of the chromosome-length scaffolds were joined (Figure 3F). However, the error could be easily detected and corrected with JBAT by manually splitting the two chromosome-length scaffolds.

The Hi-C contact map confirmed that, for both assemblies, 3D-DNA and SALSA2 produced more fragmented assemblies than did YaHS, with the most extreme case observed in Hifiasm scaffolded with 3D-DNA.

3.5 YaHS exhibits remarkable speed compared to the other scaffolders

Table 6 displays the estimated runtime (h:mm:ss) for the tools used for the Hi-C pre-processing, specifically Juicer and Arima Genomics mapping pipeline, as well as for the scaffolders, which include 3D-DNA, SALSA2, and YaHS, for the two assemblies considered. As regards the pre-processing, Flye Juicer, used before 3D-DNA, was faster than the Arima Genomics mapping pipeline, used before SALSA2 and YaHS, while we observed little difference between the two pre-processing methods for the Hifiasm assembly.

Table 6
www.frontiersin.org

Table 6. Estimated runtime (h:mm:ss) for the tools used for the Hi-C pre-processing (i.e., Juicer and Arima Genomics mapping pipeline) and for the scaffolders (i.e., 3D-DNA, SALSA2, and YaHS).

In terms of the three scaffolders, YaHS clearly demonstrated an outstanding runtime for both assemblies, requiring less than 1 min to complete the scaffolding. SALSA2 had a decent runtime, taking roughly 20 min for Flye and 15 min for Hifiasm. 3D-DNA was the slowest scaffolder, requiring more than 1 h for scaffolding Flye and more than 2 h for Hifiasm.

4 Conclusion

The two assemblies scaffolded with YaHS showed the highest contiguity, completeness, and structural correctness, producing high-quality chromosome-length assemblies for the two investigated cases.

Overall, 3D-DNA performed well with the Flye assembly, but it heavily fragmented the Hifiasm assembly, showing a possible incompatibility between the two tools.

Compared to the other two scaffolders considered, SALSA2 produced intermediate results for both assemblies.

YaHS proved to be the most straightforward software to install and use. Additionally, the developers provided comprehensive documentation to facilitate the implementation of the software in the analysis process. 3D-DNA also has good documentation, but we found that it is more difficult to install and run. With respect to SALSA2, the main flaws are the lack of detailed and rich documentation and the lack of methods for manual curation of the assembly.

YaHS greatly outperformed the other two scaffolders in terms of runtime.

Of note, we did not try different combinations of parameters for the three scaffolders to determine whether they could perform better with other settings.

Our findings align with those presented by the scaffolder developers in their original articles: SALSA2 authors compared their software with 3D-DNA, finding that SALSA2 was producing higher quality results (Ghurye et al., 2019); YaHS authors compared their tool with SALSA2, finding that YaHS can produce higher quality results. To test their tools, both SALSA2 and YaHS developers used real and simulated human datasets. YaHS authors also tested the scaffolders with 15 species belonging to different taxonomic groups, including mammals, insects, fungi, and plants. They demonstrated that YaHS outperformed SALSA2 for most of the species considered, while in a limited number of cases, the results were comparable (Zhou et al., 2023). In the original article, the authors did not compare 3D-DNA with SALSA2 and YaHS due to its earlier development.

Of the three scaffolders that were benchmarked in this study, YaHS was the best performing for most of the parameters considered. Therefore, we conclude that it is the most appropriate scaffolding tool for de novo assemblies to date.

Data availability statement

Publicly available datasets were analyzed in this study. These data can be found here: BioProject PRJCA005809 (https://ngdc.cncb.ac.cn/bioproject/browse/PRJCA005809); GitHub assemblyQC repository: https://github.com/LiaOb21/assemblyQC.

Author contributions

LO: investigation, methodology, software, and writing–original draft. UT: conceptualization, supervision, and writing–review and editing. AP: supervision and writing–review and editing.

Funding

The author(s) declare that financial support was received for the research, authorship, and/or publication of this article. This study includes part of a PhD project carried out by Lia Obinu at the PhD School of Agricultural Sciences of the University of Sassari, funded by the University of Sassari. Lia Obinu was also supported by ERASMUS for a Traineeship program awarded to the University of Sassari. This study was carried out within the Agritech National Research Centre and received funding from the European Union Next-Generation EU (PIANO NAZIONALE DI RIPRESA E RESILIENZA (PNRR)–MISSIONE 4 COMPONENTE 2, INVESTIMENTO 1.4–D.D. 1032 17/06/2022, CN00000022). This manuscript reflects only the authors’ views and opinions, and neither the European Union nor the European Commission can be considered responsible for them.

Acknowledgments

We would like to thank Dr. Alex Mackintosh of The University of Edinburgh for his useful advice and input on the topic.

Conflict of interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Publisher’s note

All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors, and the reviewers. Any product that may be evaluated in this article, or claim that may be made by its manufacturer, is not guaranteed or endorsed by the publisher.

Supplementary material

The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/fbinf.2024.1462923/full#supplementary-material

References

Benevenuto, J., Ferrão, L. F. V., Amadeu, R. R., and Munoz, P. (2019). How can a high-quality genome assembly help plant breeders? GigaScience 8, giz068. doi:10.1093/gigascience/giz068

PubMed Abstract | CrossRef Full Text | Google Scholar

Burton, J. N., Adey, A., Patwardhan, R. P., Qiu, R., Kitzman, J. O., and Shendure, J. (2013). Chromosome-scale scaffolding of de novo genome assemblies based on chromatin interactions. Nat. Biotechnol. 31, 1119–1125. doi:10.1038/nbt.2727

PubMed Abstract | CrossRef Full Text | Google Scholar

Challis, R., Richards, E., Rajan, J., Cochrane, G., and Blaxter, M. (2020). Blobtoolkit – interactive quality assessment of genome assemblies. G3 Genes— Genomes— Genet. 10, 1361–1374. doi:10.1534/G3.119.400908

CrossRef Full Text | Google Scholar

Cheng, H., Concepcion, G. T., Feng, X., Zhang, H., and Li, H. (2021). Haplotype-resolved de novo assembly using phased assembly graphs with hifiasm. Nat. Methods 18 (2 18), 170–175. doi:10.1038/s41592-020-01056-5

PubMed Abstract | CrossRef Full Text | Google Scholar

Coster, W. D., D’Hert, S., Schultz, D. T., Cruts, M., and Broeckhoven, C. V. (2018). Nanopack: visualizing and processing long-read sequencing data. Bioinformatics 34, 2666–2669. doi:10.1093/bioinformatics/bty149

PubMed Abstract | CrossRef Full Text | Google Scholar

Dudchenko, O., Batra, S. S., Omer, A. D., Nyquist, S. K., Hoeger, M., Durand, N. C., et al. (2017). De novo assembly of the aedes aegypti genome using hi-c yields chromosome-length scaffolds. Science 356, 92–95. doi:10.1126/science.aal3327

PubMed Abstract | CrossRef Full Text | Google Scholar

Dudchenko, O., Shamim, M. S., Batra, S. S., Durand, N. C., Musial, N. T., Mostofa, R., et al. (2018). The juicebox assembly tools module facilitates de novo assembly of mammalian genomes with chromosome-length scaffolds for under $1000. bioRxiv. doi:10.1101/254797

CrossRef Full Text | Google Scholar

Durand, N. C., Shamim, M. S., Machol, I., Rao, S. S., Huntley, M. H., Lander, E. S., et al. (2016). Juicer provides a one-click system for analyzing loop-resolution hi-c experiments. Cell Syst. 3, 95–98. doi:10.1016/j.cels.2016.07.002

PubMed Abstract | CrossRef Full Text | Google Scholar

Ghurye, J., and Pop, M. (2019). Modern technologies and algorithms for scaffolding assembled genomes. PLoS Comput. Biol. 15, 10069944–e1007020. doi:10.1371/journal.pcbi.1006994

PubMed Abstract | CrossRef Full Text | Google Scholar

Ghurye, J., Pop, M., Koren, S., Bickhart, D., and Chin, C. S. (2017). Scaffolding of long read assemblies using long range contact information. BMC Genomics 18, 527–611. doi:10.1186/s12864-017-3879-z

PubMed Abstract | CrossRef Full Text | Google Scholar

Ghurye, J., Rhie, A., Walenz, B. P., Schmitt, A., Selvaraj, S., Pop, M., et al. (2019). Integrating hi-c links with assembly graphs for chromosome-scale assembly. PLoS Comput. Biol. 15, 10072733–e1007318. doi:10.1371/journal.pcbi.1007273

PubMed Abstract | CrossRef Full Text | Google Scholar

Guan, D., Guan, D., McCarthy, S. A., Wood, J., Howe, K., Wang, Y., et al. (2020). Identifying and removing haplotypic duplication in primary genome assemblies. Bioinforma. Oxf. Engl. 36, 2896–2898. doi:10.1093/BIOINFORMATICS/BTAA025

PubMed Abstract | CrossRef Full Text | Google Scholar

Guan, D., McCarthy, S. A., Ning, Z., Wang, G., Wang, Y., and Durbin, R. (2021). Efficient iterative hi-c scaffolder based on n-best neighbors. BMC Bioinforma. 22, 569–616. doi:10.1186/s12859-021-04453-5

CrossRef Full Text | Google Scholar

Hou, Y., Wang, L., and Pan, W. (2023). Comparison of hi-c-based scaffolding tools on plant genomes. Genes 14, 2147. doi:10.3390/genes14122147

PubMed Abstract | CrossRef Full Text | Google Scholar

Jung, H., Winefield, C., Bombarely, A., Prentis, P., and Waterhouse, P. (2019). Tools and strategies for long-read sequencing and de novo assembly of plant genomes. Trends Plant Sci. 24, 700–724. doi:10.1016/J.TPLANTS.2019.05.003

PubMed Abstract | CrossRef Full Text | Google Scholar

Karlicki, M., Antonowicz, S., and Karnkowska, A. (2022). Tiara: deep learning-based classification system for eukaryotic sequences. Bioinformatics 38, 344–350. doi:10.1093/BIOINFORMATICS/BTAB672

PubMed Abstract | CrossRef Full Text | Google Scholar

Kaul, S., Koo, H. L., Jenkins, J., Rizzo, M., Rooney, T., Tallon, L. J., et al. (2000). Analysis of the genome sequence of the flowering plant arabidopsis thaliana. Nat. 2000 408, 796–815. doi:10.1038/35048692

PubMed Abstract | CrossRef Full Text | Google Scholar

Kolmogorov, M., Yuan, J., Lin, Y., and Pevzner, P. A. (2019). Assembly of long, error-prone reads using repeat graphs. Nat. Biotechnol. 37, 540–546. doi:10.1038/s41587-019-0072-8

PubMed Abstract | CrossRef Full Text | Google Scholar

Koornneef, M., and Meinke, D. (2010). The development of arabidopsis as a model plant. Plant J. 61, 909–921. doi:10.1111/j.1365-313X.2009.04086.x

PubMed Abstract | CrossRef Full Text | Google Scholar

Koren, S., Walenz, B. P., Berlin, K., Miller, J. R., Bergman, N. H., and Phillippy, A. M. (2017). Canu: scalable and accurate long-read assembly via adaptive k -mer weighting and repeat separation. Genome Res. 27, 722–736. doi:10.1101/gr.215087.116

PubMed Abstract | CrossRef Full Text | Google Scholar

Lawniczak, M. K. N., Durbin, R., Flicek, P., Lindblad-Toh, K., Wei, X., Archibald, J. M., et al. (2022). Standards recommendations for the earth biogenome project. Proc. Natl. Acad. Sci. 119, e2115639118. doi:10.1073/pnas.2115639118

PubMed Abstract | CrossRef Full Text | Google Scholar

Li, H. (2018). Minimap2: pairwise alignment for nucleotide sequences. Bioinformatics 34, 3094–3100. doi:10.1093/bioinformatics/bty191

PubMed Abstract | CrossRef Full Text | Google Scholar

Lieberman-aiden, E., Berkum, N. L. V., Williams, L., Imakaev, M., Ragoczy, T., Telling, A., et al. (2009). Comprehensive mapping of long-range interactions reveals folding principles of the human genome. Science 33292, 289–294. doi:10.1126/science.1181369

PubMed Abstract | CrossRef Full Text | Google Scholar

Luo, J., Wei, Y., Lyu, M., Wu, Z., Liu, X., Luo, H., et al. (2021). A comprehensive review of scaffolding methods in genome assembly. Briefings Bioinforma. 22, bbab033. doi:10.1093/bib/bbab033

CrossRef Full Text | Google Scholar

Manni, M., Berkeley, M. R., Seppey, M., Simão, F. A., and Zdobnov, E. M. (2021). Busco update: novel and streamlined workflows along with broader and deeper phylogenetic coverage for scoring of eukaryotic, prokaryotic, and viral genomes. Mol. Biol. Evol. 38, 4647–4654. doi:10.1093/MOLBEV/MSAB199

PubMed Abstract | CrossRef Full Text | Google Scholar

Marçais, G., Delcher, A. L., Phillippy, A. M., Coston, R., Salzberg, S. L., and Zimin, A. (2018). Mummer4: a fast and versatile genome alignment system. PLoS Comput. Biol. 14, 10059444–e1006014. doi:10.1371/journal.pcbi.1005944

CrossRef Full Text | Google Scholar

Marie-Nelly, H., Marbouty, M., Cournac, A., Flot, J. F., Liti, G., Parodi, D. P., et al. (2014). High-quality genome (re)assembly using chromosomal contact data. Nat. Commun. 5, 5695–5710. doi:10.1038/ncomms6695

PubMed Abstract | CrossRef Full Text | Google Scholar

Michael, T. P., and VanBuren, R. (2020). Building near-complete plant genomes. Curr. Opin. Plant Biol. 54, 26–33. doi:10.1016/j.pbi.2019.12.009

PubMed Abstract | CrossRef Full Text | Google Scholar

Mikheenko, A., Prjibelski, A., Saveliev, V., Antipov, D., and Gurevich, A. (2018). Versatile genome assembly evaluation with quast-lg. Bioinformatics 34, i142–i150. doi:10.1093/bioinformatics/bty266

PubMed Abstract | CrossRef Full Text | Google Scholar

Rhie, A., Walenz, B. P., Koren, S., and Phillippy, A. M. (2020). Merqury: reference-free quality, completeness, and phasing assessment for genome assemblies. Genome Biol. 21, 245–327. doi:10.1186/s13059-020-02134-9

PubMed Abstract | CrossRef Full Text | Google Scholar

Shirasawa, K., Harada, D., Hirakawa, H., Isobe, S., and Kole, C. (2021). Chromosome-level de novo genome assemblies of over 100 plant species. Breed. Sci. 71, 117–124. doi:10.1270/jsbbs.20146

PubMed Abstract | CrossRef Full Text | Google Scholar

Shumate, A., and Salzberg, S. L. (2021). Liftoff: accurate mapping of gene annotations. Bioinformatics 37, 1639–1643. doi:10.1093/BIOINFORMATICS/BTAA1016

PubMed Abstract | CrossRef Full Text | Google Scholar

Sur, A., Noble, W. S., and Myler, P. J. (2022). A benchmark of hi-c scaffolders using reference genomes and de novo assemblies. bioRxiv 2022 (04.20.488415). doi:10.1101/2022.04.20.488415

CrossRef Full Text | Google Scholar

Vaser, R., Sović, I., Nagarajan, N., and Šikić, M. (2017). Fast and accurate de novo genome assembly from long uncorrected reads. Genome Res. 27, 737–746. doi:10.1101/GR.214270.116

PubMed Abstract | CrossRef Full Text | Google Scholar

Wang, B., Yang, X., Jia, Y., Xu, Y., Jia, P., Dang, N., et al. (2022). High-quality arabidopsis thaliana genome assembly with nanopore and hifi long reads. Genomics, Proteomics & Bioinforma. 20, 4–13. doi:10.1016/j.gpb.2021.08.003

CrossRef Full Text | Google Scholar

Yamaguchi, K., Kadota, M., Nishimura, O., Ohishi, Y., Naito, Y., and Kuraku, S. (2021). Technical considerations in hi-c scaffolding and evaluation of chromosome-scale genome assemblies. Mol. Ecol. 30, 5923–5934. doi:10.1111/mec.16146

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhang, X., Zhang, S., Zhao, Q., Ming, R., and Tang, H. (2019). Assembly of allele-aware, chromosomal-scale autopolyploid genomes based on hi-c data. Nat. Plants 5, 833–845. doi:10.1038/s41477-019-0487-8

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhou, C., McCarthy, S. A., and Durbin, R. (2023). YaHS: yet another Hi-C scaffolding tool. J. Bioinform. 39 (1), btac808. doi:10.1093/bioinformatics/btac808

CrossRef Full Text | Google Scholar

Zhou, S., Herschleb, J., and Schwartz, D. C. (2007). Chapter 9 a single molecule system for whole genome analysis. Perspect. Bioanal. 2, 265–300. doi:10.1016/S1871-0069(06)02009-X

CrossRef Full Text | Google Scholar

Keywords: genome scaffolding, Hi-C reads, de novo genome assembly, assemblyQC, benchmarking

Citation: Obinu L, Trivedi U and Porceddu A (2024) Benchmarking of Hi-C tools for scaffolding plant genomes obtained from PacBio HiFi and ONT reads. Front. Bioinform. 4:1462923. doi: 10.3389/fbinf.2024.1462923

Received: 10 July 2024; Accepted: 18 October 2024;
Published: 15 November 2024.

Edited by:

David W. Ussery, University of Arkansas for Medical Sciences, United States

Reviewed by:

Youtao Lu, University of Pennsylvania, United States
Mengyang Xu, Beijing Genomics Institute (BGI), China

Copyright © 2024 Obinu, Trivedi and Porceddu. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Lia Obinu, lobinu@uniss.it

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.