Next Article in Journal
Design, Synthesis and Characterization of Cyclic NU172 Analogues: A Biophysical and Biological Insight
Previous Article in Journal
Relevance of SIRT1-NF-κB Axis as Therapeutic Target to Ameliorate Inflammation in Liver Disease
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Positional Correlation Natural Vector: A Novel Method for Genome Comparison

1
Department of Mathematical Sciences, Tsinghua University, Beijing 100084, China
2
Department of Biological Sciences, Chicago State University, Chicago, IL 60628, USA
*
Author to whom correspondence should be addressed.
Int. J. Mol. Sci. 2020, 21(11), 3859; https://doi.org/10.3390/ijms21113859
Submission received: 13 April 2020 / Revised: 17 May 2020 / Accepted: 26 May 2020 / Published: 29 May 2020
(This article belongs to the Section Molecular Informatics)

Abstract

:
Advances in sequencing technology have made large amounts of biological data available. Evolutionary analysis of data such as DNA sequences is highly important in biological studies. As alignment methods are ineffective for analyzing large-scale data due to their inherently high costs, alignment-free methods have recently attracted attention in the field of bioinformatics. In this paper, we introduce a new positional correlation natural vector (PCNV) method that involves converting a DNA sequence into an 18-dimensional numerical feature vector. Using frequency and position correlation to represent the nucleotide distribution, it is possible to obtain a PCNV for a DNA sequence. This new numerical vector design uses six suitable features to characterize the correlation among nucleotide positions in sequences. PCNV is also very easy to compute and can be used for rapid genome comparison. To test our novel method, we performed phylogenetic analysis with several viral and bacterial genome datasets with PCNV. For comparison, an alignment-based method, Bayesian inference, and two alignment-free methods, feature frequency profile and natural vector, were performed using the same datasets. We found that the PCNV technique is fast and accurate when used for phylogenetic analysis and classification of viruses and bacteria.

1. Introduction

Predicting the structures, functions, and evolutionary relationships of genes is a fundamental and vital aspect of modern biological research. Therefore, the comparison of genetic sequences is a pivotal step in many protocols and numerous approaches have been employed for this task. Most researchers use conventional alignment-based techniques for sequence comparison; these techniques involve sequence alignment based on selected scoring systems. The algorithms used are generally precise and highlight correlations among sequences. Several sequence alignment methods have been implemented via software packages, such as MrBayes [1]. However, alignment-based methods have disadvantages: they are slow and require a large amount of memory. Furthermore, based on previous studies, multiple sequence alignment (MSA)-based methods cannot be extended with using the huge datasets currently available [2]. Therefore, alignment-free (AF) methods may be used to overcome these problems [3]. Additionally, AF sequence comparison is drawing great interest driven by data-rich applications [4]. A notable common feature of AF approaches is the analysis of special numerical properties of the sequences being compared. High computational efficiency is observed when such techniques are applied to gene and protein data. A series of AF methods for sequence comparison has been developed. AF approaches include iterated-function systems [5], information theory [6], Fourier transformations [7], sequence representations based on chaos theory [8], and moments of the positions of the nucleotides [9,10]. The most widely used AF method is the k-mer-based method and has been published in many excellent journals [11,12,13,14,15,16,17,18,19]. This method involves the analysis of the frequency of strings of specific length k within sequences [20]. Several k-mer-based methods have been developed and applied for the phylogenetic analysis of bacteria and viruses. A notable example is feature frequency profiles (FFP) [21].
Although k-mer-based methods have been applied widely, they do not include positional correlations of nucleotides. However, it is significant to investigate the location for gene sequence comparison. Therefore, positional correlation is important for computational and analytical approaches. Recently, two methods based on moments of the positions of the nucleotides, namely natural vector (NV) [9] and multiple encoding vector (MEV) method [10], were proposed. They were successfully used for the classification and phylogenetic analysis of sequences. The NV method uses frequency, average site, and variance of site to compare sequences. Based on NV, the MEV method can add information about the chemical and physical properties of a nucleotide. The distribution of four bases is considered independently in these two methods. However, it has been reported that the four bases are correlated; in fact, the correlation of nucleotides is based on the widely applied hidden Markov model (HMM) [22]. In the present study, we propose a novel 18-dimensional numerical feature vector method to characterize DNA sequences. The method is named positional correlation natural vector (PCNV) to characterize DNA sequences. Our vector contains the frequency, average, and variance the locations of four bases. Furthermore, we added the position correlation of each pair of the four bases as important features. We tested the PCNV method using several datasets and compared it with the alignment-based Bayesian inference approach, which can be applied using MrBayes software [1], as well as two AF methods, FFP and NV.

2. Results

To demonstrate that PCNV is effective, we applied it to different datasets: the genomes of hepatitis C virus (HCV), hepatitis B virus (HBV), human papillomavirus (HPV), dengue virus (DENV), and 59 bacterial species. The length of the sequences studied ranged from thousands to millions of base pairs. For each dataset, the PCNVs of the sequences were computed using MATLAB R2016a and phylogenetic trees were reconstructed using MEGA 7. Finally, we evaluated the performance of our methods based on sensitivity, specificity, and accuracy. Computations were performed on a PC with Intel Core i7-6560U CPU @ 2.20 GHz and 8 GB RAM.

2.1. Phylogeny of HCV

Using our PCNV method, 82 HCVs are correctly clustered into six clades, as shown in Figure 1a [23]. Using the FFP method, the value of k for analysis of these viruses is 6. As shown in Figure 1b, some Genotype 6 and 1 HCVs are clustered together incorrectly in the FFP phylogenetic tree. Furthermore, a sequence in Genotype 4 is assigned to Genotype 6. PCNV produces better results for this dataset than FFP. The Bayesian inference method was also utilized for the evolutionary analysis of this dataset. Figure 1c shows that this method divides Genotype 3, shown in violet, into two groups.

2.2. Phylogeny of HBV

Using PCNV, 152 HBVs are correctly divided into eight lineages, as shown in Figure 2a. The phylogenetic tree created using the FFP method is shown in Figure 2b. According to the HBV database, “AJ627224” belongs to Genotype D. However, according to the FFP method, it is related to Genotype B. The FFP method also cluster “FJ356715” and “FJ356716”, belonging to Genotype H, to Genotypes F and G, respectively. Therefore, for this dataset, our PCNV method is superior to FFP. The phylogenetic tree created using the traditional NV method is shown in Figure 2c. However, in this tree, three Genotype C viruses are classified into other groups. The phylogenetic tree created using Bayesian inference is shown in Figure 2d. It shows that “AB371164” belongs to Genotype H, as separated from Genotype H. This is an indication that the positional correlation between nucleotides can improve the accuracy of classification.

2.3. Phylogeny of DENV

As shown in Figure 3a, the phylogenetic tree constructed using PCNV classifies all viruses into the correct categories. However, as shown in Figure 3b, the NV method divides Genotype 1 into two clusters. Therefore, once again, it is clear that positional correlation between nucleotides can effectively improve the NV method.

2.4. Phylogeny of HPV

We found that PCNV categorizes the dataset into the correct biological groups in 0.78 s (Figure 4a; Table 1); this is much faster than the FFP method, which takes 35 s (Table 1). The Bayesian inference method divide Genotype 11 into two parts, as highlighted in cyan in Figure 4b.

2.5. Phylogeny of Bacteria

The dataset consisted of 14 families, as shown in Figure 5a,b, of bacterial species with long genomes that ranged from 0.8 to 5 million bp. Using the PCNV method, the phylogenetic tree of these organisms was reconstructed. As shown in Figure 5a, the 59 bacterial species are divided into 14 families that are separated from each other. The 11-mer FFP method mixed these families (Figure 5b). Additionally, the run time for FFP is more than a day, which is far longer than the time required for PCNV. Bayesian inference takes even longer, to the extent that it is not possible to complete the analysis using this method in Muscle on a server equipped with an Intel Xeon E5-2667 v3 Processor and Linux Home Premium with 384 GB RAM (Table 1).

2.6. Classification

Besides evolutionary analysis, PCNV can also be used for classification. Both FFP and Alignment-Free-Kmer-Statistics (AFKS) [16], based on the k-mer approach, can also be used for classification. However, the question of how to choose the value of k is not easily answered. In the present paper, for the FFP method, we set the k value as the minimum integer of l o g 4 ( N ) , i.e., k = f l o o r ( l o g 4 ( N ) ) , where N is the maximum length of the sequences studied [21]. For the AFKS method, we used k = f l o o r ( l o g 4 ( 1 n i S l e n ( i ) ) ) , where n is the number of sequences in the set S [16].
In the PCNV method, after computing the distance matrix using each approach, the one-nearest neighbor (1-NN) [24] method was used for predictions. The sensitivity, specificity, and accuracy of the predictions made using each method are shown in Table 2. It is clear that PCNV is superior to the other two algorithms in this study.

3. Discussion

In the present paper, we propose a novel 18-dimensional vector method for genome comparison. This PCNV method can be used to successfully define the distribution of nucleotides based on information on the frequency and position of DNA sequences. The correlation of position between two different bases is used in addition to the average position and variance of position of each base. As a result, a high-dimensional DNA genome sequence is reduced to an 18-dimensional numerical vector. Correlations in base distribution play a key role in sequence comparison. Usually, conventional alignment-based methods produce reasonable phylogenetic trees and are therefore widely applied. However, when the dataset volume is large or the sequences analyzed are very long, these methods become ineffective. The phylogenetic analysis results on several distinct datasets show that PCNV can quickly and accurately compare massive datasets of long DNA sequences. We also compared our method with three methods: the popular alignment-based Bayesian inference method, the alignment-free FFP, and Natural Vector methods. The results show that our method can construct more accurate evolutionary relationships among sequences.
To demonstrate the computational advantage of PCNV, we compared our running time constructing phylogenetic trees with FFP, AFKS, Bayesian inference, and Muscle. Compared with the two extensively applied alignment-free methods FFP and AFKS, the running time of PCNV is smallest for all datasets and even takes less than 1 s, except on the bacteria dataset. For bacteria dataset, PCNV is extremely fast and only takes about 53 s, while FFP and AFKS take more than one day. Compared with the two alignment-based methods Bayesian inference and Muscle, PCNV takes much less time for all datasets. For bacteria dataset, Bayesian inference and Muscle cannot obtain phylogeny tree within several days.
With long DNA sequences, particularly bacterial genomes, the Bayesian inference method was much slower than the PCNV approach, sometimes to the extent that it simply did not work, the main reason being that Bayesian inference method is based on alignment method, such as Muscle (Table 1). Even alignment-free methods such as FFP and AFKS were slow in comparison with PCNV, especially when the analyzed sequences were longer, as shown in Table 1.
Furthermore, the MEV was used for comparison. Although both PCNV and MEDV studies aim to solve the problem of genetic sequence comparison, they have significant differences in the features extracted from the sequences. MEV method did not consider the position correlation feature which is an important source of information for genetic sequences. The novelty of our new method is that it designs six suitable features to characterize the correlation among nucleotide position in sequences. The second difference is that our new method does not categorize four types of nucleotides into three groups according to their chemical properties. The third difference is that our new method applies the popular neighbor-joining algorithm to construct phylogenetic trees, while the old study used the UPGMA algorithm which may produce misleading trees.
To show the advantages of our new method (PCNV), MEV and PCNV were compared using all datasets studied used in for the present study. The Neighbor-Joining (NJ) algorithm is used in tree construction of both methods. The NJ trees built by the MEV method are shown in Figures S1–S5. As shown in Figure S1, there are six types of HCV dataset. Using the MEV method, the type 6 marked in pink is divided into two parts. In the NJ tree of the HBV dataset shown in Figure S2, the virus KX765843 belonging to clade C (marked in black) is incorrectly assigned to clade F (marked in red). Similarly, as shown in Figure S3, types 1 (marked in blue) and 3 (marked in navy) of dengue are mixed together. In Figure S4, two viruses from type 35 group (marked in gray) are categorized into other groups.
Horizontal (or lateral) gene transfer (HGT) is a common phenomenon in bacteria. Due to the problem of HGT, Koski and Golding [25] even stated that genes appearing to be the most similar based on BLAST hits are often not the closest relatives each other phylogenetically. It means when there are HGT, if alignment is used, there may be mistakes. For example, given two distantly related bacteria that have exchanged a gene, a phylogenetic tree including those species will show them to be closely related because that gene is the same, even though most other genes are dissimilar. For bacteria, due to the extensively existing HGT, the phylogenetic tree based on alignment may be misleading. To get correct phylogenetic trees of bacteria, one main method is the 16s rRNA-based method, which constructs trees according to the alignment of 16s ribosomal RNA, i.e., 16s rRNA. The 16s rRNA gene tends to be conserved among bacteria with close phylogenetic distances, and thus is often not affected by HGT, but has enough variable differences. However, the method of 16sRNA loses some information in the whole genome. Our PCNV method uses the whole genome sequence and needs no sequence alignment, thus has the potential to be not affected by the HGT and obtain the correct phylogenetic relationship among bacteria.
To show that our method may be not affected by HGT, we used another dataset of eight Yersinia genomes in a previous study [4]. The eight Yersinia genomes are too similar in sequence for classical phylogenetic inference, but share gene segments. The dataset includes two Yersinia pseudotuberculosis and six Yersinia pestis complete genomes. Using PCNV, we get the neighbor-joining tree of the eight bacteria shown in Figure 6. For the figure, we see that the two Yersinia pseudotuberculosis isolates form sisters and are separate from the six Yersinia pestis genomes.
Genetic distance is a measure of the genetic divergence between species or between populations within a species, whether the distance measures time from common ancestor or degree of differentiation. Several genetic distances have been proposed based on different evolutionary models. The genetic distance can only be applied to alignment results. A commonly used measure of genetic distance is the fixation index, which varies between 0 and 1. Our PCNA is an alignment-free approach; we measure the distance between species using Euclidean distance and we do not assume any evolutionary model. This distance is positively correlated with their genetic distance, since it can successfully measure the divergence between two species as well. In the neighbor-joining trees constructed by PCNV, sum of the length of the branches traversed from one species to another is equal to their distance and thus positively correlated with their genetic distance. Due to difference in mutation rates for species, for two given datasets, the average internal genetic distance in each dataset may be different enough. In this case, the average distance obtained with PCNV for two datasets may have a big difference, which leads to very different scales in the two derived phylogenetic trees. For the same dataset, different alignment-free method may produce different average distance and thus produce different scales of phylogenetic trees.
Our new method has several limitations, for example we cannot work out the time of evolution. These limitations will need to be studied in the future.

4. Materials and Methods

4.1. Dataset

Five datasets were used to test and verify the new technique.

4.1.1. HCV

Hepatitis C is a liver infection caused by HCV. The World Health Organization (WHO) estimates that HCV infects 3% of the world’s population [26]. Because this virus causes few symptoms, diagnosis is difficult in many cases [27]. In the present study, we acquired 82 complete HCV genomes from the Virus Pathogen Database and Analysis Resource (ViPR) [23]. This dataset has a genomic length of 8957–9666 nucleotides. The NCBI accession numbers are shown in Table S1.

4.1.2. HBV

HBV is a hepatotropic virus that can establish a persistent and chronic infection in humans through immune anergy. It exhibits formidable morbidity and mortality in humans and currently infects 3.5% of the global population [28,29]. HBV is genetically diverse and comprises 10 different genotypes, designated A–J [29,30]. Additional subgenotypes exist within Genotypes A–D and F [31]. The HBV genotypes differ in their geographic distributions. Identifying HBV genotypes quickly and accurately is very important for clinical diagnosis. In the present work, 152 complete HBV genomes including eight genotypes (A–H), were downloaded from the Hepatitis B Virus Database (HBVdb) [30]. The NCBI accession numbers are shown in Table S2.

4.1.3. DENV

DENVs are mosquito-borne aviviruses that have plagued humans for centuries [32]. Statistics show that DENVs infect up to 390 million people worldwide each year; 25% of these people suffer from clinical disease. With four antigenically distinct but immunologically cross-reactive serotypes (DENV-1–4), dengue has one of the most complex transmission processes of all infectious diseases in human populations [33]. Therefore, it is important to distinguish which group particular DENVs belong to. In the present study, 330 dengue viruses were used to demonstrate the effectiveness of the method. The NCBI accession numbers are shown in Table S3.

4.1.4. HPV

HPV is a circular double-stranded DNA virus that causes a variety of proliferative epithelial lesions at specific anatomical sites. It is also the most common sexually transmitted virus. There are many different types of HPV, several of which cause health problems such as genital warts and cancer [34]. For example, the low-risk HPV Types 6 and 11 can cause genital warts or benign cell changes, while the high-risk HPV Types 16 and 18 cause about 70% of cervical cancers [35]. Therefore, identification of HPV genotypes in infected patients is particularly important. In the present work, 326 complete genomes of 12 HPV strands (6, 11, 16, 18, 31,33, 35, 45, 52, 53, 58, and 66) were studied. All viral genomes in this HPV dataset are publicly available at GenBank or NCBI databases. The NCBI accession numbers are shown in Table S4.

4.1.5. Bacteria

There is a biomass of bacteria, the main representatives of the prokaryotes, on Earth. Researchers usually investigate evolutionary relationships among bacteria by building phylogenetic trees. Owing to the large genome size (>1 million bp) of bacteria, it is impossible to reconstruct a bacterial phylogenetic tree in a reasonable amount of time using traditional multiple sequence alignment methods with current computational technology. We used 59 bacterial species to test our method (Table 3). The NCBI accession numbers are shown in Table S5.

4.2. Positional Distribution

Let S = s 1 , s 2 , . . . , s N be a DNA sequence of length N. Denote n α as the number of nucleotides α in the sequence, where α { A , C , G , T } . Here, p α j is the position of the nucleotide α at the jth appearance, j = 1 , 2 , , n α , and p α 0 = 0 . Obviously, p α j < p α j + 1 ( 0 j < n α ) . For example, given the sequence “ACTGGCAAT”, n A = 3 ,   p A 1 = 1 ,   p A 2 = 7 ,   p A 3 = 8 . We first define the positional distribution of α ( U α ( i ) , i = 1 , 2 , , N ) as follows:
U α ( i ) = p α j p α j + 1 p α j ; p α j i < p α j + 1 ; j = 0 , 1 , , n α 1 . p α n α N ( p α n α 1 ) ; p α n α i N .
The positional distribution of α ( α A , C , G , T ) is
0 , 0 , , 0 p α 1 1 , p α 1 p α 2 p α 1 , p α 1 p α 2 p α 1 , , p α 1 p α 2 p α 1 p α 2 p α 1 , , p α n α 1 p α n α p α n α 1 , p α n α 1 p α n α p α n α 1 , , p α n α 1 p α n α p α n α 1 p α n α p α n α 1 , p α n α N ( p α n α 1 ) , p α n α N ( p α n α 1 ) , , p α n α N ( p α n α 1 ) N ( p α n α 1 )
Example: Given the sequence “ACTGGCAAT”, the positional distribution is as shown in Table 4. Here, we take α = C as an example to show the details of the calculation process. According to the above definition: N = 9 ,   n C = 2 ;   P C 0 = 0 ,   P C 1 = 2 ,   P C 2 = 6 .
(1)
When p C 0 i < p C 1 , namely, i = 1 , so U C ( 1 ) = p C 0 p C 1 p C 0 = 0 .
(2)
When p C 1 i < p C 2 , namely, i { 2 , 3 , 4 , 5 } , thus U C ( 2 ) = U C ( 3 ) = U C ( 4 ) = U C ( 5 ) = p C 1 p C 2 p C 1 = 2 6 2 = 2 4 .
(3)
When p C 2 i N , namely, i { 6 , 7 , 8 , 9 } , U C ( 6 ) = U C ( 7 ) = U C ( 8 ) = U C ( 9 ) = p C 2 N ( p C 2 1 ) = 6 9 ( 6 1 ) = 6 4 .
Similarly, we can get U A , U G , U T .

4.3. Position Correlation Vector

4.3.1. Average Positional Distribution

The average positional distribution κ α is defined as ( α , β { A , C , G , T } ):
κ α = i = 1 N U α ( i ) n α , α { A , C , G , T } .
Therefore,
κ α = i = 1 N U α ( i ) n α = j = 0 n α 1 p α i p α j + 1 p α j × ( p α j + 1 p α j ) n α + p n α N ( p n α 1 ) × [ N ( p n α 1 ) ] n α = j = 0 n α p α j n α .
For the example sequence “ACTGGCAAT” above, κ A = i = 1 N U A ( i ) n A = 1 6 × 6 + 7 1 + 8 2 × 2 3 = j = 0 n A p A j n A 3 = 1 + 7 + 8 3 = 16 3 , and likewise for C, G, and T.

4.3.2. Positional Covariance

The positional covariance of nucleotide α and β ( c o v ( α , β )) are defined as follows:
c o v ( α , β ) = i = 1 N ( U α ( i ) U ¯ α ) ( U β ( i ) U ¯ β ) n α · n β .
where
U ¯ α = 1 N i = 1 N U α ( i ) = 1 N j = 0 n α p α j .
For the sequence “ACTGGCAAT”, the positional distributions of A and C are ( 1 6 , 1 6 , 1 6 , 1 6 , 1 6 , 1 6 , 7 , 8 2 , 8 2 ) and ( 0 , 2 4 , 2 4 , 2 4 , 2 4 , 6 4 , 6 4 , 6 4 , 6 4 ) , respectively.
U ¯ A = 1 N i = 1 N U A ( i ) = j = 0 n A p A N = 1 6 × 6 + 7 1 + 8 2 × 2 9 = 16 9 .
U ¯ C = 1 N i = 1 N U C ( i ) = j = 0 n C p C N = 0 + 2 4 × 4 + 6 4 × 4 9 = 8 9 .
c o v ( A , C ) = i = 1 N ( U A ( i ) U ¯ A ) ( U C ( i ) U ¯ C ) n A · n C = 1 3 2 [ ( 1 6 16 9 ) ( 0 8 9 ) + ( 1 6 16 9 ) ( 2 4 8 9 ) × 4 + ( 1 6 16 9 ) ( 6 4 8 9 ) + ( 7 1 16 9 ) ( 6 4 8 9 ) + ( 8 2 16 9 ) ( 6 4 8 9 ) × 2 ] = 1.4769 .
The same method is used to compute cov (A;G); cov (A; T); cov (C;G); cov (C; T); and cov (G; T).

4.3.3. Positional variance

The positional variance D α is described as:
D 2 α = c o v ( α , α ) = i = 1 N ( U α ( i ) U ¯ α ) ( U α ( i ) U ¯ α ) n α · n α .
Consequently, an 18-dimensional PCNV of a DNA sequence was constructed as follows:
( n A , n C , n G , n T , κ A , κ C , κ G , κ T , D 2 A , D 2 C , D 2 G , D 2 T , c o v ( A , C ) , c o v ( A , G ) , c o v ( A , T ) , c o v ( C , G ) , c o v ( C , T ) , c o v ( G , T ) ) .
Then, we used the Euclidean distance to compute the pairwise distance among the 18-dimensional vectors of the genome sequences. A phylogenetic tree can be built using the NJ algorithm in MEGA 7.0 software [36].
Additionally, the PCNV method can be used to classify organisms. Naturally, sensitivity, specificity, and accuracy were used to evaluate classification performance. The definitions of these measures are as follows:
S e n s i t i v i t y = T P / ( T P + F N ) .
and
S p e c i f i c i t y = T N / ( F P + T N ) .
where TP, TN, FP, and FN are the number of true positive, true negative, false positive, and false negative predictions, respectively. The MATLAB source code in this paper is freely available to the public upon request.

Supplementary Materials

The information for all five datasets is shown in the Supplementary_File. The following are available at https://www.mdpi.com/1422-0067/21/11/3859/s1.

Author Contributions

S.S.-T.Y. and L.H. conceived the initial planning; L.H. implemented the code; and R.D. and R.L.H. analyzed the results. All authors wrote and reviewed the manuscript. All authors have read and agreed to the published version of the manuscript.

Funding

This research was funded by the National Natural Science Foundation of China (91746119), Tsinghua University Education Foundation fund (042202008), and Tsinghua University start-up fund.

Acknowledgments

This study was supported by the National Natural Science Foundation of China (91746119), Tsinghua University Education Foundation fund (042202008), and Tsinghua University start-up fund. Stephen S.-T. Yau is grateful to National Center for Theoretical Sciences (NCTS) for providing an excellent research environment while part of this research was done.

Conflicts of Interest

The authors declare no competing financial interests.

Abbreviations

The following abbreviations are used in this manuscript:
AFKSAlignment-Free-Kmer-Statistics
DENVDengue virus
HCVHepatitis C virus
HBVHepatitis B virus
HMMhidden Markov model
HPVHuman papillomavirus
PCNVPositional Correlation Natural Vector
NVNatural Vector
ViPRVirus Pathogen Database and Analysis Resource
FFPFeature Frequency Profiles

References

  1. Fredrik, R.; Maxim, T.; van der Mark, P.; Ayres, D.L.; Darling, A.; Höhna, S.; Liu, B.; Liu, L.; Suchard, M.A.; Huelsenbeck, J.P. MrBayes 3.2: Efficient Bayesian phylogenetic inference and model choice across a large model space. Syst. Biol. 2012, 61, 539–542. [Google Scholar]
  2. Bernard, G.; Chan, C.X.; Chan, Y.-B.; Chua, X.-Y.; Cong, Y.; Hogan, J.M. Alignment-free inference of hierarchical and reticulate phylogenomic relationships. Brief. Bioinform. 2017, 2, 2. [Google Scholar]
  3. Zielezinski, A.; Vinga, S.; Almeida, J.; Karlowski, W.M. AAlignment-free sequence comparison: Benefits, applications, and tools. Genome Biol. 2017, 1, 186. [Google Scholar] [CrossRef] [Green Version]
  4. Zielezinski, A.; Girgis, H.Z.; Bernard, G. Benchmarking of alignment-free sequence comparison methods. Genome Biol. 2019, 20. [Google Scholar] [CrossRef] [Green Version]
  5. Vinga, S. Information theory applications for biological sequence analysis. Genome Biol. 2014, 15, 376–389. [Google Scholar] [CrossRef] [Green Version]
  6. Almeida, J.S. Sequence analysis by iterated maps, a review. Brief. Bioinform. 2014, 15, 369–375. [Google Scholar] [CrossRef] [Green Version]
  7. Yin, C.; Yau, S.S.-T. An improved model for whole genome phylogenetic analysis by Fourier transform. J. Theor. Biol. 2015, 382, 99–110. [Google Scholar] [CrossRef]
  8. Jeffrey, H.J. Chaos game representation of gene structure. NAR 1990, 18, 2163–2170. [Google Scholar]
  9. Deng, M.; Yu, C.L.; Liang, Q.; He, R.L.; Yau, S.S.-T. A novel method of characterizing genetic sequences: Genome space with biological distance and applications. PLoS ONE 2011, 31, e17293. [Google Scholar] [CrossRef] [Green Version]
  10. Li, Y.; He, L.; Lucy, H.R.; Yau, S.S.-T. A novel fast vector method for genetic sequence comparison. Sci. Rep. 2017, 7, 12226. [Google Scholar] [CrossRef] [Green Version]
  11. Ren, J.; Bai, X.; Lu, Y.Y.; Tang, K.; Wang, Y.; Reinert, G. Alignment-free sequence analysis and applications. Annu. Rev. Biomed. Data Sci. 2018, 1, 93–114. [Google Scholar] [CrossRef] [PubMed]
  12. Wu, G.H.A.J.; Juna, S.-R.; Simsa, G.E.S.; Kim, S.-H. Whole-proteome phylogeny of large dsDNA virus families by an alignment-free method. PNAS 2009, 106, 12826–12831. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  13. Dai, Q.; Yang, Y.C.; Wang, T.M. Markov model plus k-word distributions: A synergy that produces novel statistical measures for sequence comparison. Bioinformatics 2012, 20, 2296–2302. [Google Scholar] [CrossRef] [Green Version]
  14. Xu, Z.; Hao, B.L. CVTree update: A newly designed phylogenetic study platform using composition vectors and whole genomes. NAR 2009, 37 (Suppl. 2), W174–W178. [Google Scholar] [CrossRef] [Green Version]
  15. Hatje, K.; Kollmar, M. A phylogenetic analysis of the brassicales clade based on an alignment-free sequence comparison method. Front. Plant Sci. 2012, 3, 192. [Google Scholar] [CrossRef] [Green Version]
  16. Luczak, B.B.; James, B.T.; Girgis, H.Z. A survey and evaluations of histogram-based statistics in alignment-ree sequence comparison. Brief. Bioinform. 2017, 20, 1222–1237. [Google Scholar] [CrossRef] [Green Version]
  17. Leimeister, C.-A.; Boden, M.; Horwege, S.; Lindner, S.; Morgenstern, B. Fast alignment-free sequence comparison using spaced-word frequencies. Bioinformatics 2014, 30, 1991–1999. [Google Scholar] [CrossRef] [Green Version]
  18. Leimeister, C.-A.; Sohrabi-Jahromi, S.; Morgenstern, B. Fast and accurate phylogeny reconstruction using filtered spaced-word matches. Bioinformatics 2017, 33, 971–979. [Google Scholar] [CrossRef] [Green Version]
  19. Murray, K.D.; Webers, C.; Ong, C.S.; Borevitz, J.; Warthmann, N. kWIP: The k-mer weighted inner product, a de novo estimator of genetic similarity. PLoS Comput. Biol. 2017, 13, e1005727. [Google Scholar] [CrossRef] [Green Version]
  20. Blaisdell, B.E. Average values of a dissimilarity measure not requiring sequence alignment are twice the averages of conventional mismatch counts requiring sequence alignment for a computer-generated model system. J. Mol. Evol. 1989, 29, 538–547. [Google Scholar] [CrossRef]
  21. Sims, G.E.; Jun, S.R.; Wu, G.A.; Kim, S.H. Alignment-free genome comparison with feature frequency profiles (FFP) and optimal resolutions. PNAS 2009, 106, 2677–2682. [Google Scholar] [CrossRef] [Green Version]
  22. Yoon, B.-J. Hidden Markov Models and their Applications in Biological Sequence Analysis. Curr. Genom. 2009, 10, 402–415. [Google Scholar] [CrossRef] [Green Version]
  23. Pickett, B.E.; Greer, D.S.; Zhang, Y.; Stewart, L.; Zhou, L.; Sun, G.Y.; Gu, Z.P.; Kumar, S.; Zaremba, S.; Larsen, C.N.; et al. Virus pathogen database and analy-sis resource (vipr): A comprehensive bioinformatics database and analysis resource for the coronavirus research community. Viruses 2012, 4, 3209–3226. [Google Scholar] [CrossRef] [Green Version]
  24. Kramer, O. K-Nearest Neighbors. Dimensionality Reduction with Unsupervised Nearest Neighbors; Springer: Berlin/Heidelberg, Germany, 2013; pp. 13–23. [Google Scholar]
  25. Koski, L.B.; Golding, G.B. The closest BLAST hit is often not the nearest neighbor. J. Mol. Evol. 2001, 52, 540–542. [Google Scholar] [CrossRef] [PubMed]
  26. Echeverría, N.; Moratorio, G.; Cristina, J.; Moreno, P. Hepatitis C virus genetic variability and evolution. World J. Hepatol. 2015, 7, 831–845. [Google Scholar] [CrossRef] [PubMed]
  27. Campo, D.S.; Dimitrova, Z.; Mitchell, R.J.; Lara, J.; Khudyakov, Y. Coordinated evolution of the hepatitis C virus. PNAS 2008, 105, 9685–9690. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  28. Yuen, M.-F.; Chen, D.-S.; Dusheiko, G.M.; Janssen, H.L.A.; Lau, D.T.Y.; Locarnini, S.A.; Peters, M.G.; Lai, C.-L. Hepatitis B virus infection. Nat. Rev. Dis.Prim. 2018, 4, 18035. [Google Scholar] [CrossRef] [PubMed]
  29. Patterson, R.Z.; Klunk, J.; Fornaciari, G.; Giuffra, V.; Duchěne, S.; Duggan, A.T.; Poinar, D.; Douglas, M.W.; Eden, J.-S.; Holmes, E.C.; et al. Correction: The paradox of hbv evolution as revealed from a 16th century mummy. PLoS Pathog. 2012, 14, e1006887. [Google Scholar] [CrossRef]
  30. Hayer, J.; Jadeau, F.; Deléage, G.; Kay, A.; Zoulim, F.; Combet, C. HBVdb: A knowledge database for Hepatitis B Virus. NAR 2013, 41, D566–D570. [Google Scholar] [CrossRef] [Green Version]
  31. Norder, H.; Hammas, B.; Lee, S.D.; Bile, K.; Courouc, A.M.; Mushahwar, I.K.; Magnius, L.O. Genetic relatedness of hepatitis B viral strains of diverse geographical origin and natural variations in the primary structure of the surface antigen. J. Gen. Virol. 1993, 74, 1341–1348. [Google Scholar] [CrossRef]
  32. Sirisena, P.D.N.N.; Noordeen, F. Evolution of dengue in Sri Lanka–changes in the virus, vector, and climate. Int. J. Infect. Dis. 2014, 19, 6–12. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  33. Tsang, T.K.; Ghebremariam, S.L.; Gresh, L.; Gordon, A.; Halloran, M.E.; Katzelnick, L.C.; Rojas, D.P.; Kuan, G.; Balmaseda, A.; Sugimoto, J.; et al. Effects of infection history on dengue virus infection and pathogenicity. Nat. Commun. 2019, 10, 1246. [Google Scholar] [CrossRef]
  34. Eom, J.H.; Park, S.B.; Zhang, B.T. Genetic Mining of DNA Sequence Structures for Effective Classification of the Risk Types of Human Papillomavirus (HPV). Lect. Notes Comput. Sci. 2004, 3316, 1334–1343. [Google Scholar]
  35. Smith, J.S.; Lindsay, L.; Hoots, B.; Keys, J.; Franceschi, S.; Winer, R.; Clifford, G.M. Human papillomavirus type distribution in invasive cervical cancer and high-grade cervical lesions: A meta-analysis update. Int. J. Cancer 2007, 121, 621–632. [Google Scholar] [CrossRef] [PubMed]
  36. Kumar, S.; Stecher, G.; Tamura, K. MEGA7: Molecular Evolutionary Genetics Analysis Version 7.0 for Bigger Datasets. Mol. Biol. Evol. 2016, 33, 1870–1874. [Google Scholar] [CrossRef] [Green Version]
Figure 1. (a) The Neighbor-Joining phylogenetic tree of 82 HCV genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 82 HCV genome sequences based on FFP method (k = 6). (c) The phylogenetic tree of 82 HCV genome sequences based on Bayesian inference method.
Figure 1. (a) The Neighbor-Joining phylogenetic tree of 82 HCV genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 82 HCV genome sequences based on FFP method (k = 6). (c) The phylogenetic tree of 82 HCV genome sequences based on Bayesian inference method.
Ijms 21 03859 g001aIjms 21 03859 g001b
Figure 2. (a) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on FFP method (k = 5). (c) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on NV method. (d) The phylogenetic tree of 152 HBV genome sequences based on Bayesian inference method.
Figure 2. (a) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on FFP method (k = 5). (c) The Neighbor-Joining phylogenetic tree of 152 HBV genome sequences based on NV method. (d) The phylogenetic tree of 152 HBV genome sequences based on Bayesian inference method.
Ijms 21 03859 g002aIjms 21 03859 g002b
Figure 3. (a) The Neighbor-Joining phylogenetic tree of 330 dengue viruses genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 330 dengue viruses genome sequences based on NV method.
Figure 3. (a) The Neighbor-Joining phylogenetic tree of 330 dengue viruses genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 330 dengue viruses genome sequences based on NV method.
Ijms 21 03859 g003
Figure 4. (a) The Neighbor-Joining phylogenetic tree of 326 HPV genome sequences based on PCNV method. (b) The phylogenetic tree of 326 HPV genome sequences based on Bayesian inference method.
Figure 4. (a) The Neighbor-Joining phylogenetic tree of 326 HPV genome sequences based on PCNV method. (b) The phylogenetic tree of 326 HPV genome sequences based on Bayesian inference method.
Ijms 21 03859 g004
Figure 5. (a) The Neighbor-Joining phylogenetic tree of 59 bacteria genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 59 bacteria genome sequences based on FFP method (k = 11).
Figure 5. (a) The Neighbor-Joining phylogenetic tree of 59 bacteria genome sequences based on PCNV method. (b) The Neighbor-Joining phylogenetic tree of 59 bacteria genome sequences based on FFP method (k = 11).
Ijms 21 03859 g005aIjms 21 03859 g005b
Figure 6. The Neighbor-Joining phylogenetic tree of eight Yersinia genomes based on PCNV method.
Figure 6. The Neighbor-Joining phylogenetic tree of eight Yersinia genomes based on PCNV method.
Ijms 21 03859 g006
Table 1. Running time for PCNV, Bayesian inference, FFP, AFKS, and Muscle methods. “∼”, unable to compute on laptop.
Table 1. Running time for PCNV, Bayesian inference, FFP, AFKS, and Muscle methods. “∼”, unable to compute on laptop.
MethodHCVHBVDengueHPVBacteria
(82)(152)(330)(326)(59)
PCNV0.33s0.27s0.66s0.78s53.71s
Bayesian1097s263s217,353s217,512s   ∼
inference
FFP11.11s0.38s49.40s35.00slarger than
(k = 6)(k = 5)(k = 6)(k = 6)1 day (k = 11)
AFKS70.21s29.62s429.87s413.79slarger than
(k = 5)(k = 4)(k = 5)(k = 5)4 day (k = 9)
Muscle753s155s3740s4002s
Table 2. Sensitivity (Sens), Specificity (Spec), and Accuracy (Acc) measures of classification are reported for the four virus datasets. For each dataset, the Ave. line displays average values for each measure.
Table 2. Sensitivity (Sens), Specificity (Spec), and Accuracy (Acc) measures of classification are reported for the four virus datasets. For each dataset, the Ave. line displays average values for each measure.
Nu-SensSensSensSpecSpecSpecAccAccAcc
TypemberPCNVFFPAFKSPCNVFFPAFKSPCNVFFPAFKS
(%)(%)(%)(%)(%)(%)(%)(%)(%)
HCV
(82)
type11610062.550.010087.986.410062.550.0
type21810055.694.410093.898.410055.694.4
type32010080.090.010093.596.810080.090.0
type41210050.033.310097.190.010050.033.3
type5410050.075.010096.297.410050.075.0
type61210050.083.310091.498.610050.083.3
Ave. 10058.071.010093.394.610058.071.0
HBV
(152)
A2010010010010010099.2100100100
B1510010040.010010096.410010040.0
C2010010070.010010096.210010070.0
D1310010076.910010097.110010076.9
E3010010090.010010097.510010090.0
F2210010072.710010093.810010072.7
G1710010094.110010099.310010094.1
H1510010080.010010097.110010080.0
Ave. 10010078.010010097.110010078.0
Dengue
(330)
type17210010076.410010093.410010076.4
type27510010073.310010093.310010073.3
type38310010078.310010092.710010078.3
type410010010087.010010093.010010087.0
Ave. 10010078.810010093.110010078.8
HPV
(326)
62410010075.010010097.710010075.0
111710010010010010099.7100100100
169910010092.910010096.510010092.9
181910010094.710010010010010094.7
312310010082.610010099.010010082.6
332210010086.410010099.710010086.4
352610010088.510010099.010010088.5
451210010083.310010099.710010083.3
522210010081.810010098.410010081.8
531410010085.710010098.710010085.7
583710010094.610010099.710010094.6
661110010090.910010099.710010090.9
Ave. 10010088.010010099.010010088.0
Table 3. Summary of the datasets HCV, HBV, Dengue, HPV, and Bacteria. The length distribution of each dataset validates that PCNV can work with long sequences.
Table 3. Summary of the datasets HCV, HBV, Dengue, HPV, and Bacteria. The length distribution of each dataset validates that PCNV can work with long sequences.
DatasetNumberMinMedianMeanMax
(bp)(bp)(bp)(bp)
HCV828957944294279666
HBV15210161106691060610780
Dengue33010,16110,66910,60610,780
HPV32678147,90578958051
Bacteria59846,2144,016,9473,610,9385,966,919
Table 4. The positional distribution of “ACTGGCAAT”.
Table 4. The positional distribution of “ACTGGCAAT”.
SequenceACTGGCAAT
Position123456789
U A ( i ) 1 6 1 6 1 6 1 6 1 6 1 6 7 1 8 2 8 2
U C ( i ) 0 2 4 2 4 2 4 2 4 6 4 6 4 6 4 6 4
U T ( i ) 00 3 6 3 6 3 6 3 6 3 6 3 6 9 1
U G ( i ) 000 4 1 5 5 5 5 5 5 5 5 5 5

Share and Cite

MDPI and ACS Style

He, L.; Dong, R.; He, R.L.; Yau, S.S.-T. Positional Correlation Natural Vector: A Novel Method for Genome Comparison. Int. J. Mol. Sci. 2020, 21, 3859. https://doi.org/10.3390/ijms21113859

AMA Style

He L, Dong R, He RL, Yau SS-T. Positional Correlation Natural Vector: A Novel Method for Genome Comparison. International Journal of Molecular Sciences. 2020; 21(11):3859. https://doi.org/10.3390/ijms21113859

Chicago/Turabian Style

He, Lily, Rui Dong, Rong Lucy He, and Stephen S.-T. Yau. 2020. "Positional Correlation Natural Vector: A Novel Method for Genome Comparison" International Journal of Molecular Sciences 21, no. 11: 3859. https://doi.org/10.3390/ijms21113859

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop