Skip to main content

METHODS article

Front. Bioeng. Biotechnol., 23 September 2020
Sec. Computational Genomics

KITSUNE: A Tool for Identifying Empirically Optimal K-mer Length for Alignment-Free Phylogenomic Analysis

  • 1Department of Biochemistry and Microbiology, Faculty of Pharmaceutical Sciences, and Research Unit of DNA Barcoding of Thai Medicinal Plants, Chulalongkorn University, Bangkok, Thailand
  • 2Department of Biomedical Informatics, University of Arkansas for Medical Sciences, Little Rock, AR, United States
  • 3Joint Graduate Program in Bioinformatics, University of Arkansas at Little Rock and University of Arkansas for Medical Sciences, Little Rock, AR, United States
  • 4National Center for Genetic Engineering and Biotechnology, National Science and Technology Development Agency, Pathum Thani, Thailand

Genomic DNA is the best “unique identifier” for organisms. Alignment-free phylogenomic analysis, simple, fast, and efficient method to compare genome sequences, relies on looking at the distribution of small DNA sequence of a particular length, referred to as k-mer. The k-mer approach has been explored as a basis for sequence analysis applications, including assembly, phylogenetic tree inference, and classification. Although this approach is not novel, selecting the appropriate k-mer length to obtain the optimal resolution is rather arbitrary. However, it is a very important parameter for achieving the appropriate resolution for genome/sequence distances to infer biologically meaningful phylogenetic relationships. Thus, there is a need for a systematic approach to identify the appropriate k-mer from whole-genome sequences. We present K-mer–length Iterative Selection for UNbiased Ecophylogenomics (KITSUNE), a tool for assessing the empirically optimal k-mer length of any given set of genomes of interest for phylogenomic analysis via a three-step approach based on (1) cumulative relative entropy (CRE), (2) average number of common features (ACF), and (3) observed common features (OCF). Using KITSUNE, we demonstrated the feasibility and reliability of these measurements to obtain empirically optimal k-mer lengths of 11, 17, and ∼34 from large genome datasets of viruses, bacteria, and fungi, respectively. Moreover, we demonstrated a feature of KITSUNE for accurate species identification for the two de novo assembled bacterial genomes derived from error-prone long-reads sequences, and for a published yeast genome. In addition, KITSUNE was used to identify the shortest species-specific k-mer accurately identifying viruses. KITSUNE is freely available at https://github.com/natapol/kitsune.

Introduction

Genome sequences have been used widely for species identification with high accuracy and have been useful to many research areas in the biotechnological (Costessi et al., 2018), environmental (Vandenkoornhuyse et al., 2010), evolutionary (Bruger and Marx, 2018; Sands, 2019), and clinical sciences (Balloux et al., 2018). With the rapid technological development of genome sequencing, more and more organisms have been sequenced across all kingdoms (Galagan et al., 2005; Land et al., 2015; Houldcroft et al., 2017; Chen et al., 2019; Rexroad et al., 2019). The enormous amount of data generated by sequencing has made it challenging to compare sequences with alignment-based approaches such as BLAST (Altschul et al., 1990). The alignment-based approach generally requires significant memory and is time consuming, making the comparison of multi-genome-scale sequence data infeasible. Therefore, alignment-free methods for biological sequence analysis have been developed and perform well for comparative genomics and metagenomics, while also being less time consuming than alignment-based methods (Ren et al., 2018).

The alignment-free approach, which is simple, efficient, and fast, relies on looking at the distribution of small consecutive pieces of DNA sequences, called k-mers. The k-mer–based approach has been applied to several types of biological sequence analyses, including assembly (Sohn and Nam, 2018), phylogenetic tree inference (Bernard et al., 2016, 2019; Thankachan et al., 2017; Zhang et al., 2017; Tang et al., 2019; Choi and Kim, 2020), and microbial/microbiome classification (Brinda et al., 2015; Ondov et al., 2016; Lu et al., 2017; Jain et al., 2018; Tang et al., 2019; Wood et al., 2019). A detailed assessment of different k-mer-counting algorithms was reported by Manekar and Sathe (2018), and rigorous comparisons and benchmarking of different alignment-free methods were provided in published reviews (Bonham-Carter et al., 2014; Zielezinski et al., 2017, 2019). Although the k-mer–based approach is not novel, selecting the appropriate k-mer length to obtain the good resolution in specific applications can be arbitrary. Nevertheless, k-mer length is a very important parameter in alignment-free phylogenetic inference (Bernard et al., 2019).

Empirically optimal k-mer is defined as the k-mer length that give a good discrimination among a considered set of genomes. A previous study attempted to calculate empirically optimal k-mer length based on cumulative relation entropy (CRE) and relative sequence divergence (Wu et al., 2009), which provided a foundation to choose the empirically optimal k-mer length. Bai et al. (2017) proposed a theoretical framework to define the empirically optimal k-mer length based on Markov chains modeling and the Chi-square statistic. However, we proposed a three-step approach based on information content (Zhang et al., 2017) to more systematically assess the empirically optimal k-mer length. Our approach produced a successful alignment-free phylogenomic analysis of thousands of viral genomes (Zhang et al., 2017). Here, we present KITSUNE (K-mer–length Iterative Selection for UNbiased Ecophylogenomics) software for identifying the empirically optimal k-mer length from a given set of genomes for phylogenomic analysis. The “empirically optimal k-mer length” could be defined as a selected k-mer length that gives a well distributed genomic distances that can be used to infer biologically meaningful phylogenetic relationships. In addition, the software provides various genomic distance estimations based on the k-mer frequency profile that can be used for inferring phylogenomic trees, identifying species, and identifying unique species-specific sequences for use as genetic markers.

Methods

Software Implementation

K-mer–length Iterative Selection for UNbiased Ecophylogenomics was implemented in Python programming language version 3.6. KITSUNE first uses Jellyfish software (Marcais and Kingsford, 2011) to generate a k-mer frequency profile from a FASTA file and stores the k-mer profile in sparse matrix format. This is a suitable representation because k-mer profiles are usually sparse due to the very large number of possible k-mers (<4k), and this representation still allows for an efficient calculation.

The Three-Step Approach to Identify Empirically Optimal K-mer Length

This k-mer frequency profile enables users to calculate three values, which are used for the three-step approach (Zhang et al., 2017) as summarized in Figure 1. KITSUNE provides three key commands, which are “cre,” “acf,” and “ocf,” to calculate cumulative relative entropy (CRE), average number of common features (ACF), and observed common features (OCF), respectively. The formulas for CRE, ACF, and OCF are as follows:

FIGURE 1
www.frontiersin.org

Figure 1. A 3-step approach for identifying empirically optimal k-mer length with KITSUNE. The KITSUNE begins with the following: (A) select a given set of genomes (T) that will be used for subsampling genomes (G) from T for N times and (B) apply the three-step approach at the desired range of k-mer lengths using CRE to obtain the lower bound of k-mer length (using the <10% of maximum CRE as the cut-off), using ACF to obtain the upper bound of k-mer length (using the >10% of maximum ACF as the cut-off), and using OCF to select the k-mer lengths that have the highest diversity within the identified bounds. (C) Illustration of ACF, CRE, and OCF for a single sampling. (D) The final step is to repeat the calculation for different samplings N times. (E) Empirically optimal k-mer lengths based on individual samplings (dots) and mean values (boxplots) for viral (red), bacterial (green), and fungal (blue) genome datasets.

1. CRE:

CRE ( l ) = k = l RE ( F k , F ^ k ) (1)
RE ( F l , F ^ k ) = i f i , l log 2 f i , l f ^ i , k (2)

Here, l is the feature (k-mer) length, fi,l is the observed feature frequency of feature i of length l, and f^i,l is the expected feature frequency formulated from the Markov model of feature i, as described in a previous study (Wu et al., 2009). The CRE value indicates the amount of information from the genome sequence encoded in a k-mer profile; it represents the relative information content of an individual genome over k-mer lengths. The CRE decreases monotonically as k-mer length increases (Figure 1C). The k-mer lengths that give a CRE of close to zero for an individual genome are selected to infer approximate information for increasingly longer k-mer lengths (Wu et al., 2009).

2. ACF:

ACF ( l ) = j i c ( g i , g j , l ) ( T - 1 ) (3)

Average number of common features is calculated as an ACF between one to all genomes where c(gi,gj,l) is a number of common k-mers of length l between genome gi and genome gj, and T is the number of genomes in the dataset. ACF represents the commonality between 2 genomes. The k-mer length that gives a value of zero value for ACF will produce a random relationship. In contrast, very high ACF will give poor discrimination because most of features are in common (Zhang et al., 2017). Therefore, the k-mer lengths that do not give ACF = 0 are selected.

3. OCF:

Observed common features includes unique and non-unique k-mers based on the occurrence of k-mers among all considered genomes at a specific k-mer length. The probability of features being found in individual genomes (pi,i=1Tpi=1) is calculated and used as the input for calculating the Shannon diversity index (H) to estimate the level of similarity and dissimilarity across all considered genomes, where i represents the individual genome and N is the total number of considered genomes. pi can be calculated as Ci/Ok, where Ok (Ok ≤ 4k) is the number of all observed k-mers for a specific k-mer length k, and Ci are the number of k-mers found in i genome (1 ≤ i ≤ T), see Zhang et al. (2017) for example of the calculation.

H = - i = 1 T p i l n p i (4)

H gives the degree of commonness of k-mers among all consider genomes, therefore a higher value for H is preferred to keep higher diversity in the commonness of k-mers.

Further detail on this three-step approach is available in our previous study (Zhang et al., 2017). In most cases, an empirically optimal k-mer length would give CRE and ACF values that are 10% of their maximum values and where the k-mer is not unique to a genome. CRE and ACF will give a minimum and maximum boundary for the k-mer length. Then, the Shannon diversity index based on OCF will be used to select the k-mer length in the range obtained from ACF and CRE that has the highest diversity (H). The k-mer selected based on the three-step approach gives the optimal distance among the viral genomes that can be used to delineate biologically meaningful phylogenetic relationships (Zhang et al., 2017). Each of these measurements gives the user a quantitative value to guide them on which k-mer length should be selected for further analysis. The CRE, ACF, and OCF complement each other in selecting the empirically optimal k-mer in a dataset of interest because they measure an empirically optimal range of k-mers from a different perspective.

Genomic Distance Estimation

K-mer–length Iterative Selection for UNbiased Ecophylogenomics provides 18 methods for calculating the genomic distance based on standard dissimilarity: i.e., Bray–Curtis, Canberra, Chebyshev, City Block (Manhattan), Correlation, Cosine, Euclidean, Jensen–Shannon, Squared Euclidean, Dice, Hamming, Jaccard, Kulsinski, Rogers–Tanimoto, Russell–Rao, Sokal–Michener, Sokal–Sneath, and Yule. KITSUNE also provides the transformation distance based on the formula presented by Fan et al. (2015), which is used for Mash (Ondov et al., 2016) and FastANI (Jain et al., 2018) for genomic distance calculation, that is

Transformation distance = - 1 k ln ( 2 j 1 + j ) (5)

where k is the considered k-mer length and j is the similarity index (1 – distance) between two genomes. The transformed genomic distances can be used for species identification.

Overview of KITSUNE Features and Uses

The input files for KITSUNE are the genome sequences of the organism of interest in standard FASTA format. KITSUNE provides three core functions, “cre,” “acf,” and “ocf” to calculate the CRE, ACF, and OCF, respectively, which are the three matrices for empirically optimal k-mer length identification, at a given k-mer length. The three functions are used as the basis to identify the empirically optimal k-mer length of a given genome sequences, based on the proposed three-step approach in the wrap-up function “kopt.” Users can specify the largest k-mer length for the “kopt” function, and the empirically optimal k-mer length will be reported if available; users can change the cut-off values for the two matrices (CRE and ACF). In addition, KITSUNE provides the function “dmatrix” for genomic distance calculations reported in the matrix format with the option of many distances method with or without transformation (Eq. 5). These functions provide a convenient analysis of empirically optimal k-mer length coupling the genomic distance calculations in the same package. Lastly, because “acf” calculates the ACF between genome sequences, the user can apply the function to identify a unique k-mer for an organism of interest. KITSUNE is designed to analyze assembled genomes, not data from deep sequencing; however, the identified empirically optimal k-mer length could guide the analysis of deep-sequencing data using other alignment-free tools.

Publicly Available Datasets Used in the Study

Genome Datasets

We downloaded nucleotide FASTA files for 8,967 viral reference genomes and 8,861 complete bacterial genomes from the National Center for Biotechnology Information (NCBI) database and 729 fungal genomes from the JGI MycoCosm database (Grigoriev et al., 2014). These datasets were used to identify empirically optimal k-mer lengths and to identify species in each domain. All of genomes in the datasets is listed in the Supplementary Table 1.

Yeast Genome for Evaluating the Identification of Fungal Species Identification at Different k-mer Lengths

We used the well-characterized Saccharomyces cerevisiae genome strain CEN.PK113-7D genome (Jenjaroenpun et al., 2018) to evaluate the ability of KITSUNE to identify species using different k-mer lengths. The yeast genome was downloaded from NCBI under BioProject accession number PRJNA398797.

Escherichia coli-Shigella Dataset for Evaluating the Identification of Closely Related Species

Escherichia coli reference genomes from known five phylogroups, which are A, B1, B2, D, and E (Gordon et al., 2008; Skippington and Ragan, 2011), and Shigella sp. genomes that were used previously for phylogenetic analysis (Bernard et al., 2016; Lu et al., 2017) were downloaded from the NCBI database. Only chromosomal genome sequences were used for the analysis. All of genomes in the datasets is listed in the Supplementary Table 1.

Selected Viral Genomes for Evaluating the Identification of Shortest Species-Specific Sequence

We arbitrarily selected and downloaded seven complete viral genomes associated with human diseases from different taxonomic ranks from NCBI: Chikungunya virus (CHIKV), Dengue virus (DENV) (Kinney et al., 1997), human immunodeficiency virus 1 (HIV) (Martoglio et al., 1997), influenza A virus (IAV) (Fields and Winter, 1982), Zika virus (ZIKV) (Wongsurawat et al., 2018a,b), severe acute respiratory syndrome coronavirus 2 (SARS-CoV-2) (Harcourt et al., 2020), and Kaposi’s sarcoma-associated human herpes virus (KSHV) strain GK18 (NC_009333) (Rezaee et al., 2006) (a DNA virus that can interact with the host through an RNA/DNA hybrid mechanism) (Wongsurawat et al., 2020).

Bacterial Culture and DNA Purification

Lactobacillus plantarum BCC9546 (BIOTEC culture collection, Thailand) (Chokesajjawatee et al., 2020) was grown in (Man, Rogosa, and Sharpe) MRS broth at 30°C for 16 h. The genomic DNA was extracted with the Wizard Genomic DNA Purification Kit (Promega, United States).

Streptococcus suis HU_SS30, isolated from a human patient in Thailand, was grown in 10 mL of Todd Hewitt broth (Oxoid Limited, Hampshire, United Kingdom) containing 0.2% yeast extract at 37°C with 5% CO2 for 18 h. The genomic DNA was extracted with the Quick-DNATM Fungal/Bacterial Microprep Kit (Zymo Research, Irvine, CA, United States). The study was carried out in strict compliance with the recommendations and approval of the ethical committee of Thammasat University (Protocol Number 10/2557) and the biosafety committee of Thammasat University (protocol number 021/2557 and 036/2561).

Whole Genome Sequencing Using the Oxford Nanopore Technologies Platform

Approximately 400 ng of purified DNA from each bacterial species was used as the input for the Rapid Barcoding Kit RBK004 (ONT, United States) to prepare the sequencing library. The library was loaded into an R9.4/FLOMIN106 flow cell in a MinION sequencing device. MinKNOW software was used to control the sequencing run and data acquisition for 48 h. The raw fastq data was deposited in the Sequence Read Archive database under BioProject number PRJNA644942

ONT Data Processing and de novo Genome Assembly

The raw Oxford Nanopore Technologies (ONT) signals were base-called using Albacore v2.3.4 (ONT) to generate FASTQ reads, and adapter sequences were trimmed with Porechop v0.2.3 using default parameters. Genome assembly was performed on reads that were longer than 200 bp. Flye assembler (Kolmogorov et al., 2019) version 2.5 was applied to the assembled genomes using default parameters to obtain the complete chromosomes and plasmids. The assembled contigs were visualized and plotted using Bandage software version 0.8.1 (Wick et al., 2015).

Results

Identification of Empirically Optimal K-mer Lengths for Viral, Bacterial, and Fungal Genomes Using KITSUNE

K-mer–length Iterative Selection for UNbiased Ecophylogenomics provides three matrices—CRE, ACF, and OCF—to identify the empirically optimal k-mer length for a given set of genomes (T) for making alignment-free comparisons between genomes (Figure 1). The empirically optimal k-mer length was calculated based on our three-step approach (Zhang et al., 2017; see Figure 1B): step (1) we selected k-mers length that gave CRE < 10% of the maximum to define the lower bound of k-mer length (minimum k); step (2) we selected k-mers length that gave ACF > 10% of the maximum to define the upper bound of k-mer length (maximum k); and step (3) we selected k-mer length within the minimum and the maximum of k-mer length that yield the highest diversity index (H) based on OCF.

We applied the KITSUNE workflow (see Figure 1) to identify the empirically optimal k-mer length for our selected reference viral genomes (T = 8,967 genomes), complete bacterial genomes (T = 8,861 genomes), and fungal genomes (T = 729 genomes). Identifying the empirically optimal k-mer length requires many iterations over different k-mer lengths; therefore, using all genomes in the iterative calculations requires significant computational resources. Instead, we used a random sampling approach to perform the iterative calculations across considered k-mer lengths on subsets of all genomes/subsample (G genomes) several times (N times). For the viral and bacterial genome datasets, we sampled 100 genomes (G = 100) 100 times (N = 100). For the fungal genome dataset, we sampled eight genomes (G = 8) 300 times (N = 300); this was due to the larger genome size of fungi and our available computational resources (RAM ∼ 200 GB). For the example of an iteration shown in Figure 1C, CRE gave a minimum k-mer length of 11 and ACF gave a maximum k-mer length of 15; a k-mer length of 11 was selected because it gave the highest diversity (H) within the k-mer length range of 11 and 15. The results for empirically optimal k-mer length derived from the iterative calculation are summarized in the boxplots in Figure 1E. We identified the empirically optimal k-mer length to be 11 for the viral genome dataset and 17 for the bacterial genome dataset.

Interestingly, the empirically optimal k-mer length, identified with individual sampling (subsample), was the same value for the viral and bacterial datasets. On the other hand, the empirically optimal k-mer length obtained from individual sampling of the fungal genome dataset varied from 23 to 43, with a mean of 37, indicating the insufficient sample size (G = 8). The subsample size is an important factor; therefore, we evaluated the impact of subsample size for the viral genome dataset. We found that a subsample of 20 viral genomes was sufficient to achieve convergence from individual iterations and gave the same empirically optimal k-mer length of 11 as subsample of 100 viral genomes (Supplementary Figure S1).

Comparison of Genomic Distances

We next compared different methods for calculating genomic distances using our empirically optimal viral k-mer length of 11, derived from 100 viral genomes as an example. We arbitrarily selected 11 methods, computed genomic distances, and compared them as shown in Figure 2. We also included the Mash method (Ondov et al., 2016) and the Afann method (Tang et al., 2019) in the comparison. Mash uses the MinHash/Sketching algorithm (Broder, 1977; Indyk and Motwani, 1998) to reduce the data size of k-mer frequency profiles and calculates the distance by a transformation of the Jaccard index, which is calculated from MinHash based on the formula presented by Fan et al. (2015) (Eq. 5). Afann uses neural network regression to adjust the sequence biases and then calculates genomic distance using background adjustment methods such as d2S and d2Star (Reinert et al., 2009). The computational time and memory use of different methods, including Mash, and Afann (with the 100 viral genomes), were compared, as illustrated in Figure 2A. As expected, the Mash method had the second shortest computational time and lowest memory use because the data were compressed by the MinHash/Sketching algorithm (Broder, 1977; Indyk and Motwani, 1998). The computational time for the d2Star distance derived from Afann was the shortest, but Afann used more memory than the others. The distances derived from KITSUNE required similar computational times, which were longer than Afann and Mash software.

FIGURE 2
www.frontiersin.org

Figure 2. Genomic distance comparison. (A) Bar plots of computational time and memory required for genomic distance calculation by individual methods. (B) Correlogram plot comparing transformed genomic distances calculated with different methods based on 100 viral genomes. Lower left triangle: scatter plots of genomic distances derived from of pairs of genomes calculated with different methods with correlation ellipses; upper right triangle: Spearman’s rank correlation coefficients for different methods; diagonal boxes: distribution of genomic distances. (C) Histograms with rug plots show the distributions of genomic distances (transformed Jaccard) based on the identified empirically optimal k-mer length (k11, green), k-mer length of 5 (k5, red), and k-mer length of 17 (k17, blue). See Supplementary Figure S2 for the distribution of genomic distances derived from all k-mer-length from 5 to 17.

We next computed the genomic distances of the 100 viral genomes using the standard distance formula for the 10 individual methods and compared them with the genomic distances calculated with Mash (Supplementary Figure S3). The scatter plots for all of the 10 distances had clear linear relationships with each other but not with the Mash distance. Unlike Mash distances, which have a normal distribution (see diagonal boxes), the 10 distances had a strong right-hand skew close to 1. The d2Star distances derived from Afann had a sharp distribution of around 0.5. However, all of them had a good correlation based on rank (Spearman’s rank correlation coefficient >0.69). We then applied the transformation formula (Eq. 5) presented by Fan et al. (2015) to calculate distances for all 11 methods and d2star then compared them together with the Mash distance (Figure 2B). After transformation, there was a clear linear relationship among the distances calculated with almost every method (see scatter plots), each with a normal distribution (see diagonal boxes), except for the Jensen–Shannon method. Nevertheless, the transformation did not much change the rank correlation among them (Spearman’s correlation coefficient >0.66).

We next determined the impact of k-mer lengths on genomic distance (transformed Jaccard) as illustrated in the histogram plot of Figure 2C for the identified empirically optimal k-mer length of 11 with k-mer length of 5 and 17 (see Supplementary Figure S2 for other k-mer lengths and a tree shows good discrimination among different virus families/genus using the empirically optimal k-mer length of 11). At k-mer length of 5, which is too short, most of the genomic distances were close to 0; therefore, discrimination among the genomes was limited. On the other hand, at a k-mer length is 17, which is too long, most of the genomic distances were close to 1; therefore, discrimination among the genomes was saturated. At the empirically optimal k-mer length of 11, the distribution of genomic distances was normally distributed near in the middle of the distance scale. This characteristic could be used to infer biologically meaningful phylogenetic relationships that need further investigations.

De novo Assembly of Bacterial Genomes From ONT Sequencing for Species Identification

ONT provides long-read sequencing (>10 kb), which overcomes the issue of assembling disambiguated reads from short-read sequencing data. This allows users to obtain contiguous chromosomal and plasmid sequences (Jenjaroenpun et al., 2018; De Maio et al., 2019). Unfortunately, because of the higher sequencing error rate of ONT over short-read sequencing, approximately 1% of errors remain in the assembled sequence even after self-consensus correction (Wick et al., 2019). Therefore, it is necessary to polish with short reads to obtain high-quality genome sequences (De Maio et al., 2019). Here, we evaluated whether a genome sequence assembled using only ONT long reads could be used to identify bacterial species with KITSUNE.

We performed whole-genome sequencing and de novo assembly for two bacterial species, S. suis HU_SS30 and L. plantarum BCC9546, using only ONT long-read sequencing. We generated sequencing depths of ∼53 × (146 Mb) for S. suis and ∼45 × (177 Mb) for L. plantarum. The assembled genomes are illustrated in Figures 3A,B. For S. suis, the de novo assembly yielded three circular contigs of a chromosome of approximately 2 Mb and two plasmids of approximately 73 and 14 kb. For L. plantarum, the de novo assembly yielded six circular contigs of a chromosome of approximately 3.2 Mb and five plasmids ranging in size from 4.5 to 84 kb. Only the assembled chromosome sequences were used for species identification by querying the sequences against our dataset of 8,861 complete bacterial genomes.

FIGURE 3
www.frontiersin.org

Figure 3. Bacterial species identification based on genome assembly via long-read sequencing. (A) Illustration of assembled chromosome and plasmids of S. suis HU_SS30 and (B) L. plantarum BCC9546. Scatter plots of genomic distances derived from of genomes pairs (Jensen–Shannon vs. transformed Jaccard methods) for S. suis (C) and L. plantarum (D) queried against the 8,861 complete bacterial genomes.

We used KITSUNE to calculate the genomic distances at our identified empirically optimal k-mer length of 17 (Figure 1) using the Jensen–Shannon method and the Jaccard method with transformation (Fan et al., 2015), which previously showed a non-linear relationship between them (Figure 2B), and compared them as illustrated in Figures 3C,D for S. suis and L. plantarum, respectively. By considering the nearest-neighbor genomes within the complete bacterial genome dataset, we could identify S. suis based on the clear cluster of genomic distances within the species (<0.06 for transformed Jaccard and <0.66 for Jensen–Shannon). For L. plantarum, we identified the unclassified Lactobacillus sp. D1501 as the closest species, as the complete bacterial genome dataset used here lacked L. plantarum, indicating the importance of a database for species identification.

Evaluation of Different K-mer Lengths for Fungal Species Identification

Unlike with the viral or bacterial genome datasets, we did not obtain a unique empirically optimal k-mer length from the fungal genome dataset (Figure 1). Therefore, we explored the impact of different k-mer lengths on identifying fungal species, using S. cerevisiae strain CEN.PK113-7D as an example. We used the transformed Jaccard index (see Eq. 5) to calculate the genomic distance for S. cerevisiae using k-mer lengths of between 27–45 (the range of empirically optimal k-mer lengths defined in Figure 1E) against the genomes in the dataset of 729 fungal genomes (Figure 4A). With this approach, we were able to identify the species S. cerevisiae at any k-mer length based on the shortest distance. We observed that the genomic distance, calculated at k-mer lengths ≥41, between S. cerevisiae strain CEN.PK113-7D and strain S288C was closer to the other distances derived S. cerevisiae CEN.PK113-7D and other fungi genomes in the reference dataset when compared with at k-mer lengths <37 (diagonal plots of Figure 4A). This indicated that the discrimination power decreased at k-mer lengths ≥41.

FIGURE 4
www.frontiersin.org

Figure 4. Fungal species identification and k-mer length identification of the E. coli-Shigella dataset. (A) Correlogram plot for identifying the fungal species S. cerevisiae CEN.PK 113-7D by querying against the dataset of 729 fungal genomes at k-mer lengths of 27–45 using the transformed Jaccard genomic distance. Lower left triangle: scatter plots of the genomic distance for different k-mer lengths; solid red circle is the shortest genomic distance between S. cerevisiae CEN.PK 113-7D and the species found in the fungal genome dataset (S. cerevisiae S288C). Upper right triangle: Spearman’s rank correlation coefficients among different k-mer lengths; diagonal boxes show the distribution of genomic distances. The diagonal boxes show the distribution of the genomics distances; the red arrows represent the genomic distance between S. cerevisiae strain CEN.PK 113-7D and S288C. (B) The plots of CRE, ACF, and OFC for the 30 strains of E. coli–Shigella dataset used to identify empirically optimal k-mer length. (C) Tree constructed from genomic distances based on the d2Star method using Afann at the identified empirically optimal k-mer length of 14. Phylogroups are indicated by colored boxes on the right side of the tree: black, Shigella spp.; blue, A; purple, B1; red, B2; green, D; and yellow, E.

Using KITSUNE to Identify Empirically Optimal K-mer Length for Closely Related Bacterial Species

The three-step approach to identify empirically optimal k-mer length was first designed for inter species comparison. We evaluated whether we could use KITSUNE to identify empirically optimal k-mer length for the closely related species of E. coli- Shigella, which is a classic problem in microbiology for species differentiation. We calculated CRE, ACF, and OCF for the 30 genomes in the E. coli-Shigella dataset as illustrated in Figure 4B. The minimum k-mer length of 14 was identified based on CRE. The ACF, which is used to evaluate the level of common features among the considered genomes, decreased slowly as k-mer length increased because of the high similarity of the genome sequences. Therefore, the maximum k-mer length could not be identified with ACF. However, the OCF indicated that a k-mer length of 14 was the empirically optimal k-mer length because it gave the highest diversity index (H). We then calculated the genomic distances based on d2Star method using Afann software and used them to constructed a tree as illustrated in Figure 4C. We observed a clear separation among groups of E. coli and Shigella spp. Moreover, different phylo-types of E. coli were well discriminated at the identified empirically optimal k-mer length.

Virus Species-Specific Sequence Identification Using ACF

Taxon-specific sequences have been used for rapid species classification, taxonomic rank identification, functional inference, and taxon abundance estimation for genome and metagenome samples (Truong et al., 2015; Wood et al., 2019). With this in mind, we demonstrated the capability of KITSUNE to identify the shortest k-mer length that is unique for individual viral species based on the genome sequence by applying the ACF, which can be used to identify common features of any two genomes. We selected RNA/DNA viruses associated with infectious disease epidemics/pandemics as described in the Methods section. Using the ACF for k-mer lengths of 7–51, the individual viral genomes were queried against the reference viral genome dataset (8,967 genomes) to evaluate whether the genomes had common sequences.

The frequency of genomes with sequences in common with the seven selected viruses was recorded for each k-mer length and plotted for comparison (Figure 5). Based on this graph, the shortest k-mer length that was unique for the selected viruses was identified; these lengths were 23 for IAV, 27 for HIV, 33 for KHSV, and 35 for DENV, CHIKV, and 39 for SARS-CoV-2, ZIKV. We assessed the specificity of these shortest unique k-mers with a BLAST search against the NCBI nr/nt database, which includes sequences from various organisms. The BLAST results based on the top 50 hits of randomly selected sequences for the viruses of interest showed very good specificity for the shortest unique k-mers for species identification (see Supplementary Material).

FIGURE 5
www.frontiersin.org

Figure 5. Virus specific sequence identification. Line plot of the number of genomes within the dataset of 8,967 viral reference genomes that have sequences in common with the seven selected viruses across k-mer lengths of 57–51. Solid dots represent the shortest unique k-mer of individual viruses. CHIKV, Chikungunya virus; DENV, Dengue virus; KSHV, Kaposi’s sarcoma-associated human herpes virus; HIV, human immunodeficiency virus; IAV, influenza A virus; SARS-CoV-2, severe acute respiratory syndrome coronavirus 2; and ZIKV, Zika virus.

Discussion

Although k-mer length is critical, few studies have endeavored to determine empirically optimal k-mer lengths for making alignment-free genomic comparisons. KITSUNE provides a systematic way to investigate empirically optimal k-mer lengths, and it can be used for many applications. Here, we applied KITSUNE to identify the empirically optimal k-mer length for large-scale datasets of viral, bacterial, and fungal genomes through random sampling. The subsample size, which is an important parameter, needs to be large enough to represent the population of considered genomes. This approach gave consistent results for empirically optimal k-mer length for the viral and bacterial datasets, but not for the fungal dataset, which contained larger and more diverse genomes, indicating an insufficient subsample size. The k-mer–based information content within a genome is highly dependent on genome size (Zhang et al., 2017); therefore, long k-mers are necessary to identify the empirically optimal k-mer length. Long k-mers length produces a large, highly complex search space, which increases exponentially by a factor of 4k for nucleotide sequence.

We found that the genomic distance calculation was quite consistent across methods in terms of ranking (Figure 2B) and could be used for species identification (Figures 3C,D, 4A). KITSUNE requires more computational time to calculate genomic distances than the Mash method (Ondov et al., 2016) because KITSUNE uses uncompressed k-mer frequency data. However, the MinHash/Sketching algorithm (Broder, 1977; Indyk and Motwani, 1998) uses lossy compression to represent k-mers, which allows only the Jaccard index to be used to determine genomic distance. Moreover, sequence information cannot be retrieved after it is compressed by MinHash, so it is not possible to identify actual nucleotide sequences within a k-mer frequency profile. Such actual nucleotide sequences are very useful for identifying genetic sequence markers, as demonstrated in Figure 5 for viruses using KITSUNE. These are the trade-offs between computational time and the resolution of sequence data.

The specific characteristic of genomic distance profile derived from individual method was observed especially by Jensen–Shannon, d2Star and Cosine (Figure 2B). This raises an important research question about how to calibrate genomic distances derived from alignment-free methods with standard phylogenetic analysis, which has a robust statistical model for in-depth evolutionary analysis, and use the genomic distances derived from alignment-free analysis to study evolution. Nevertheless, the alignment-free genomic distance yielded rapid and accurate species identification.

Researchers can use KITSUNE to systematically identify the empirically optimal k-mer length for genomes of interest based on the three-step approach. Calculating ACF, which must be done for all possible pairs of genomes, and OFC, which is an all-genomes comparison, is computationally intensive. A subsampling approach reduces this computational load and gives a good approximation of empirically optimal k-mer length. Even though KITSUNE was developed for genomes of different species, it can be used to analyze closely related species by ignoring the ACF. KITSUNE uses the assembled genomes, not sequencing reads, to identify the empirically optimal k-mer length. Nevertheless, the identified empirically optimal k-mer length in Figure 1 for the three kingdoms and taxa-specific k-mer as demonstrated in Figure 5. KITSUNE can be used to calculate genomic distances that can be used for many applications. However, we implemented the genomic distance methods based on available distance functions in the Python environment. Genomic distance is important for comparative genomics using an alignment-free approach; therefore, we recommended the users explore advanced genomic distance calculations from the published literature.

Conclusion

In summary, we present KITSUNE, an open source software that can be used to identify the empirically optimal k-mer length for phylogenomic analysis of a given set of genomes and for estimating genomic distances and identifying taxon-specific sequences. Thus, KITSUNE is an alternative alignment-free tool for comparative genomics.

Author’s Note

This paper is dedicated to the memory of IN’s beloved dog RAME, who inspired the KITSUNE logo.

Data Availability Statement

The datasets presented in this study can be found in online repositories. Sequence Read Archive (SRA) database under BioProject number PRJNA644942. Accession number(s) can be found below: https://www.ncbi.nlm.nih.gov/, PRJNA398797.

Author Contributions

IN conceived and directed the project and wrote the manuscript. NP developed and implemented the software. DA participated in the software development and implementation. PP developed and implemented the software in the beginning stage. IN, DA, and PJ performed the data analysis. TW, SY, and NC performed the Oxford Nanopore Technologies sequencing. SY and NC performed the bacterial culture and DNA extraction. S-RJ provided technical assistance with the methodology. All authors read and approved the final manuscript.

Funding

This work was supported in part by the National Institute of General Medical Sciences of the National Institutes of Health award number P20GM125503 to IN.

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.

Supplementary Material

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

Abbreviations

ACF, average number of common features; CHIKV, Chikungunya virus; CRE, cumulative relative entropy; H, Shannon diversity index; HIV, human immunodeficiency virus 1; IAV, influenza A virus; KITSUNE, K-mer –length Iterative Selection for UNbiased Ecophylogenomics; KSHV, Kaposi’s sarcoma-associated human herpes virus; MRS, Man Rogosa and Sharpe; NCBI, National Center for Biotechnology Information; OCF, observed common features; SARS-CoV-2, severe acute respiratory syndrome coronavirus 2; ZIKV, Zika virus.

References

Altschul, S. F., Gish, W., Miller, W., Myers, E. W., and Lipman, D. J. (1990). Basic local alignment search tool. J. Mol. Biol. 215, 403–410.

Google Scholar

Bai, X., Tang, K., Ren, J., Waterman, M., and Sun, F. (2017). Optimal choice of word length when comparing two Markov sequences using a chi (2)-statistic. BMC Genomics 18:732. doi: 10.1186/s12864-017-4020-z

PubMed Abstract | CrossRef Full Text | Google Scholar

Balloux, F., Bronstad Brynildsrud, O., Van Dorp, L., Shaw, L. P., Chen, H., Harris, K. A., et al. (2018). From theory to practice: translating whole-genome sequencing (WGS) into the clinic. Trends Microbiol. 26, 1035–1048. doi: 10.1016/j.tim.2018.08.004

PubMed Abstract | CrossRef Full Text | Google Scholar

Bernard, G., Chan, C. X., Chan, Y. B., Chua, X. Y., Cong, Y., Hogan, J. M., et al. (2019). Alignment-free inference of hierarchical and reticulate phylogenomic relationships. Brief. Bioinform. 20, 426–435. doi: 10.1093/bib/bbx067

PubMed Abstract | CrossRef Full Text | Google Scholar

Bernard, G., Chan, C. X., and Ragan, M. A. (2016). Alignment-free microbial phylogenomics under scenarios of sequence divergence, genome rearrangement and lateral genetic transfer. Sci. Rep. 6:28970.

Google Scholar

Bonham-Carter, O., Steele, J., and Bastola, D. (2014). Alignment-free genetic sequence comparisons: a review of recent approaches by word analysis. Brief. Bioinform. 15, 890–905. doi: 10.1093/bib/bbt052

PubMed Abstract | CrossRef Full Text | Google Scholar

Brinda, K., Sykulski, M., and Kucherov, G. (2015). Spaced seeds improve k-mer-based metagenomic classification. Bioinformatics 31, 3584–3592. doi: 10.1093/bioinformatics/btv419

PubMed Abstract | CrossRef Full Text | Google Scholar

Broder, A. Z. (1977). “On the resemblance and containment of documents,” in Proceedings of the Compression and Complexity of Sequences (Piscataway, NJ: IEEE).

Google Scholar

Bruger, E. L., and Marx, C. J. (2018). A decade of genome sequencing has revolutionized studies of experimental evolution. Curr. Opin. Microbiol. 45, 149–155. doi: 10.1016/j.mib.2018.03.002

PubMed Abstract | CrossRef Full Text | Google Scholar

Chen, F., Song, Y., Li, X., Chen, J., Mo, L., Zhang, X., et al. (2019). Genome sequences of horticultural plants: past, present, and future. Hortic. Res. 6:112.

Google Scholar

Choi, J., and Kim, S. H. (2020). Whole-proteome tree of life suggests a deep burst of organism diversity. Proc. Natl. Acad. Sci. U.S.A. 117, 3678–3686. doi: 10.1073/pnas.1915766117

PubMed Abstract | CrossRef Full Text | Google Scholar

Chokesajjawatee, N., Santiyanont, P., Chantarasakha, K., Kocharin, K., Thammarongtham, C., Lertampaiporn, S., et al. (2020). Safety assessment of a nham starter culture Lactobacillus plantarum BCC9546 via whole-genome analysis. Sci. Rep. 10:10241.

Google Scholar

Costessi, A., Van Den Bogert, B., May, A., Ver Loren Van Themaat, E., Roubos, J. A., Kolkman, M. A. B., et al. (2018). Novel sequencing technologies to support industrial biotechnology. FEMS Microbiol. Lett. 365:fny103.

Google Scholar

De Maio, N., Shaw, L. P., Hubbard, A., George, S., Sanderson, N. D., Swann, J., et al. (2019). Comparison of long-read sequencing technologies in the hybrid assembly of complex bacterial genomes. Microb. Genom. 5:e000294.

Google Scholar

Fan, H., Ives, A. R., Surget-Groba, Y., and Cannon, C. H. (2015). An assembly and alignment-free method of phylogeny reconstruction from next-generation sequencing data. BMC Genomics 16:522. doi: 10.1186/s12864-015-1647-5

PubMed Abstract | CrossRef Full Text | Google Scholar

Fields, S., and Winter, G. (1982). Nucleotide sequences of influenza virus segments 1 and 3 reveal mosaic structure of a small viral RNA segment. Cell 28, 303–313. doi: 10.1016/0092-8674(82)90348-8

CrossRef Full Text | Google Scholar

Galagan, J. E., Henn, M. R., Ma, L. J., Cuomo, C. A., and Birren, B. (2005). Genomics of the fungal kingdom: insights into eukaryotic biology. Genome Res. 15, 1620–1631. doi: 10.1101/gr.3767105

PubMed Abstract | CrossRef Full Text | Google Scholar

Gordon, D. M., Clermont, O., Tolley, H., and Denamur, E. (2008). Assigning Escherichia coli strains to phylogenetic groups: multi-locus sequence typing versus the PCR triplex method. Environ. Microbiol. 10, 2484–2496. doi: 10.1111/j.1462-2920.2008.01669.x

PubMed Abstract | CrossRef Full Text | Google Scholar

Grigoriev, I. V., Nikitin, R., Haridas, S., Kuo, A., Ohm, R., Otillar, R., et al. (2014). MycoCosm portal: gearing up for 1000 fungal genomes. Nucleic Acids Res. 42, D699–D704.

Google Scholar

Harcourt, J., Tamin, A., Lu, X., Kamili, S., Sakthivel, S. K., Murray, J., et al. (2020). Severe acute respiratory syndrome coronavirus 2 from patient with 2019 novel coronavirus disease, United States. Emerg. Infect. Dis. 26:200516.

Google Scholar

Houldcroft, C. J., Beale, M. A., and Breuer, J. (2017). Clinical and biological insights from viral genome sequencing. Nat. Rev. Microbiol. 15, 183–192. doi: 10.1038/nrmicro.2016.182

PubMed Abstract | CrossRef Full Text | Google Scholar

Indyk, P., and Motwani, R. (1998). “Approximate nearest neighbors: towards removing the curse of dimensionality,” in Proceedings of the Thirtieth Annual ACM Symposium on Theory of Computing (New York, NY: ACM).

Google Scholar

Jain, C., Rodriguez, R. L., Phillippy, A. M., Konstantinidis, K. T., and Aluru, S. (2018). High throughput ANI analysis of 90K prokaryotic genomes reveals clear species boundaries. Nat. Commun. 9:5114.

Google Scholar

Jenjaroenpun, P., Wongsurawat, T., Pereira, R., Patumcharoenpol, P., Ussery, D. W., Nielsen, J., et al. (2018). Complete genomic and transcriptional landscape analysis using third-generation sequencing: a case study of Saccharomyces cerevisiae CEN.PK113-7D. Nucleic Acids Res. 46:e38.

Google Scholar

Kinney, R. M., Butrapet, S., Chang, G. J., Tsuchiya, K. R., Roehrig, J. T., Bhamarapravati, N., et al. (1997). Construction of infectious cDNA clones for dengue 2 virus: strain 16681 and its attenuated vaccine derivative, strain PDK-53. Virology 230, 300–308. doi: 10.1006/viro.1997.8500

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

Land, M., Hauser, L., Jun, S. R., Nookaew, I., Leuze, M. R., Ahn, T. H., et al. (2015). Insights from 20 years of bacterial genome sequencing. Funct. Integr. Genomics 15, 141–161. doi: 10.1007/s10142-015-0433-4

PubMed Abstract | CrossRef Full Text | Google Scholar

Lu, Y. Y., Tang, K., Ren, J., Fuhrman, J. A., Waterman, M. S., and Sun, F. (2017). CAFE: aCcelerated Alignment-FrEe sequence analysis. Nucleic Acids Res. 45, W554–W559.

Google Scholar

Manekar, S. C., and Sathe, S. R. (2018). A benchmark study of k-mer counting methods for high-throughput sequencing. Gigascience 7:giy125.

Google Scholar

Marcais, G., and Kingsford, C. (2011). A fast, lock-free approach for efficient parallel counting of occurrences of k-mers. Bioinformatics 27, 764–770. doi: 10.1093/bioinformatics/btr011

PubMed Abstract | CrossRef Full Text | Google Scholar

Martoglio, B., Graf, R., and Dobberstein, B. (1997). Signal peptide fragments of preprolactin and HIV-1 p-gp160 interact with calmodulin. EMBO J. 16, 6636–6645. doi: 10.1093/emboj/16.22.6636

PubMed Abstract | CrossRef Full Text | Google Scholar

Ondov, B. D., Treangen, T. J., Melsted, P., Mallonee, A. B., Bergman, N. H., Koren, S., et al. (2016). Mash: fast genome and metagenome distance estimation using MinHash. Genome Biol. 17:132.

Google Scholar

Reinert, G., Chew, D., Sun, F., and Waterman, M. S. (2009). Alignment-free sequence comparison (I): statistics and power. J. Comput. Biol. 16, 1615–1634. doi: 10.1089/cmb.2009.0198

PubMed Abstract | CrossRef Full Text | Google Scholar

Ren, J., Bai, X., Lu, Y. Y., Tang, K., Wang, Y., Reinert, G., et al. (2018). Alignment-free sequence analysis and applications. Annu. Rev. Biomed. Data Sci. 1, 93–114.

Google Scholar

Rexroad, C., Vallet, J., Matukumalli, L. K., Reecy, J., Bickhart, D., Blackburn, H., et al. (2019). Genome to phenome: improving animal health, production, and well-being - a new USDA blueprint for animal genome research 2018-2027. Front. Genet. 10:327. doi: 10.3389/fgene.2019.00327

PubMed Abstract | CrossRef Full Text | Google Scholar

Rezaee, S. A., Cunningham, C., Davison, A. J., and Blackbourn, D. J. (2006). Kaposi’s sarcoma-associated herpesvirus immune modulation: an overview. J. Gen. Virol. 87, 1781–1804.

Google Scholar

Sands, T. R. (2019). Evolutionary genomics: the fruits of genomic approaches applied to evolutionary biology. Genome Biol. 20:10.

Google Scholar

Skippington, E., and Ragan, M. A. (2011). Within-species lateral genetic transfer and the evolution of transcriptional regulation in Escherichia coli and Shigella. BMC Genomics 12:532. doi: 10.1186/1471-2164-12-532

PubMed Abstract | CrossRef Full Text | Google Scholar

Sohn, J. I., and Nam, J. W. (2018). The present and future of de novo whole-genome assembly. Brief. Bioinform. 19, 23–40.

Google Scholar

Tang, K., Ren, J., and Sun, F. (2019). Afann: bias adjustment for alignment-free sequence comparison based on sequencing data using neural network regression. Genome Biol. 20:266.

Google Scholar

Thankachan, S. V., Chockalingam, S. P., Liu, Y., Krishnan, A., and Aluru, S. (2017). A greedy alignment-free distance estimator for phylogenetic inference. BMC Bioinformatics 18:238. doi: 10.1186/s12859-017-1658-0

PubMed Abstract | CrossRef Full Text | Google Scholar

Truong, D. T., Franzosa, E. A., Tickle, T. L., Scholz, M., Weingart, G., Pasolli, E., et al. (2015). MetaPhlAn2 for enhanced metagenomic taxonomic profiling. Nat. Methods 12, 902–903. doi: 10.1038/nmeth.3589

PubMed Abstract | CrossRef Full Text | Google Scholar

Vandenkoornhuyse, P., Dufresne, A., Quaiser, A., Gouesbet, G., Binet, F., Francez, A. J., et al. (2010). Integration of molecular functions at the ecosystemic level: breakthroughs and future goals of environmental genomics and post-genomics. Ecol. Lett. 13, 776–791. doi: 10.1111/j.1461-0248.2010.01464.x

PubMed Abstract | CrossRef Full Text | Google Scholar

Wick, R. R., Judd, L. M., and Holt, K. E. (2019). Performance of neural network basecalling tools for Oxford Nanopore sequencing. Genome Biol. 20, 129.

Google Scholar

Wick, R. R., Schultz, M. B., Zobel, J., and Holt, K. E. (2015). Bandage: interactive visualization of de novo genome assemblies. Bioinformatics 31, 3350–3352. doi: 10.1093/bioinformatics/btv383

PubMed Abstract | CrossRef Full Text | Google Scholar

Wongsurawat, T., Athipanyasilp, N., Jenjaroenpun, P., Jun, S. R., Kaewnapan, B., Wassenaar, T. M., et al. (2018a). Case of microcephaly after congenital infection with asian lineage zika virus, Thailand. Emerg. Infect. Dis. 24, 1758–1761. doi: 10.3201/eid2409.180416

PubMed Abstract | CrossRef Full Text | Google Scholar

Wongsurawat, T., Gupta, A., Jenjaroenpun, P., Owens, S., Craig Forrest, J., and Nookaew, I. (2020). R-loop-forming sequences analysis in thousands of viral genomes identify a new common element in herpesviruses. Sci. Rep. 10:6389.

Google Scholar

Wongsurawat, T., Jenjaroenpun, P., Athipanyasilp, N., Kaewnapan, B., Leelahakorn, N., Angkasekwinai, N., et al. (2018b). Genome sequences of zika virus strains recovered from amniotic fluid, placenta, and fetal brain of a microcephaly patient in Thailand, 2017. Microbiol. Resour. Announc. 7:e01020-18.

Google Scholar

Wood, D. E., Lu, J., and Langmead, B. (2019). Improved metagenomic analysis with Kraken 2. Genome Biol. 20:257.

Google Scholar

Wu, G. A., Jun, S. R., Sims, G. E., and Kim, S. H. (2009). Whole-proteome phylogeny of large dsDNA virus families by an alignment-free method. Proc. Natl. Acad. Sci. U.S.A. 106, 12826–12831. doi: 10.1073/pnas.0905115106

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhang, Q., Jun, S. R., Leuze, M., Ussery, D., and Nookaew, I. (2017). Viral phylogenomics using an alignment-free method: a three-step approach to determine optimal length of k-mer. Sci. Rep. 7:40712.

Google Scholar

Zielezinski, A., Girgis, H. Z., Bernard, G., Leimeister, C. A., Tang, K., Dencker, T., et al. (2019). Benchmarking of alignment-free sequence comparison methods. Genome Biol. 20:144.

Google Scholar

Zielezinski, A., Vinga, S., Almeida, J., and Karlowski, W. M. (2017). Alignment-free sequence comparison: benefits, applications, and tools. Genome Biol. 18:186.

Google Scholar

Keywords: k-mer, species identification, phylogenomics, comparative genomics, alignment-free

Citation: Pornputtapong N, Acheampong DA, Patumcharoenpol P, Jenjaroenpun P, Wongsurawat T, Jun S-R, Yongkiettrakul S, Chokesajjawatee N and Nookaew I (2020) KITSUNE: A Tool for Identifying Empirically Optimal K-mer Length for Alignment-Free Phylogenomic Analysis. Front. Bioeng. Biotechnol. 8:556413. doi: 10.3389/fbioe.2020.556413

Received: 28 April 2020; Accepted: 24 August 2020;
Published: 23 September 2020.

Edited by:

Max A. Alekseyev, George Washington University, United States

Reviewed by:

Cheong Xin Chan, The University of Queensland, Australia
Dong-Ho Cho, Korea Advanced Institute of Science and Technology, South Korea
Guillaume J. Filion, Centre for Genomic Regulation (CRG), Spain
Xin Bai, University of Southern California, Los Angeles, United States

Copyright © 2020 Pornputtapong, Acheampong, Patumcharoenpol, Jenjaroenpun, Wongsurawat, Jun, Yongkiettrakul, Chokesajjawatee and Nookaew. 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: Intawat Nookaew, INookaew@uams.edu

These authors share first authorship

Present address: Preecha Patumcharoenpol, Interdisciplinary Graduate Program in Bioscience, Faculty of Science, Kasetsart University, Bangkok, Thailand

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.