Skip to main content

MADOKA: an ultra-fast approach for large-scale protein structure similarity searching

Abstract

Background

Protein comparative analysis and similarity searches play essential roles in structural bioinformatics. A couple of algorithms for protein structure alignments have been developed in recent years. However, facing the rapid growth of protein structure data, improving overall comparison performance and running efficiency with massive sequences is still challenging.

Results

Here, we propose MADOKA, an ultra-fast approach for massive structural neighbor searching using a novel two-phase algorithm. Initially, we apply a fast alignment between pairwise structures. Then, we employ a score to select pairs with more similarity to carry out a more accurate fragment-based residue-level alignment. MADOKA performs about 6–100 times faster than existing methods, including TM-align and SAL, in massive alignments. Moreover, the quality of structural alignment of MADOKA is better than the existing algorithms in terms of TM-score and number of aligned residues. We also develop a web server to search structural neighbors in PDB database (About 360,000 protein chains in total), as well as additional features such as 3D structure alignment visualization. The MADOKA web server is freely available at: http://madoka.denglab.org/

Conclusions

MADOKA is an efficient approach to search for protein structure similarity. In addition, we provide a parallel implementation of MADOKA which exploits massive power of multi-core CPUs.

Background

Protein structure alignment can reveal remote evolutionary relationships for a given set of proteins, and thus helps significantly to understand the function of proteins [17]. In the last two decades, numerous computational tools have been proposed to perform optimal protein structure alignment such as DALI [8], CE [9], SAL [10], FATCAT [11], TM-align [12], Fr-TM-align [13], FAST [14], CASSERT [15], DeepAlign [16], MICAN-SQ [6], etc. Because of the complexity of protein structures, these methods are mainly different from presentations of structures and similarity scoring matrices. In practice, most structure alignment approaches begin with constructing a set of equivalent residues [13]. The structural similarity score is then calculated using various steps and metrics, and a dynamic programming procedure is employed to acquire the final result. A bottom-up scheme by assembling small alignment fragments to build a global alignment is brought in many methods [8, 13, 1719]. This involves iterative comparisons and merges of many fragments, and its computational tasks become very heavy when making all-against-all operations [20].

Among structural alignment algorithms, root-mean-square deviation (RMSD), is the most widely used metric between a pair of length-equal structures for performance assessment, which is defined as:

$$ RMSD=\sqrt{\frac{1}{N}\sum_{i=1}^{N}d_{i}^{2}} $$
(1)

where N is the number of aligned pairs of residues, and di is the distance between the ith pair of residues. However, as Zhang [21] and Skolnick [22] figured out, a small number of local structural deviations may result in a large RMSD value, even the global topologies of the compared structures are very similar. Additionally, the RMSD of randomly chosen structures depends on the lengths of compared structures. TM-score [21] has overcome these deficiencies, which is a more accurate measure in evaluating the alignment quality of full-length pairwise protein structures, and it is independent of protein lengths:

$$ TM-score=Max\left [ \frac{1}{L}\sum_{i=1}^{N_{ali}}\frac{1}{1+\left (\frac{d_{i}}{d_{0}} \right)^{2}} \right ] $$
(2)

here, L denotes the length of the original structure, Nali is the number of aligned residue pairs, and \(d_{0}=1.24\sqrt [3]{L-15}-1.8\).

Protein structure similarity searching is a one-against-all structure alignment process, which is especially important in situations where sequence similarity searches (e.g., BLAST [23]) fail or deliver too few clues. Large-scale structural similarity searches using traditional structure alignment algorithms is typically time-consuming [24, 25]. A number of approaches have been proposed to accelerate the speed of structure similarities searching, such as [26], CASSERT [24] and ppsAlign [25]. Despite significant advances in structure alignment algorithms, protein structure similarity search against a large structural database is still a great challenge, as protein structures are highly complex and protein 3D structure repositories are becoming increasingly huge, such as Protein Data Bank (PDB) [27].

In this paper, we describe a new method named MADOKA for fast and accurate protein structure similarity searching. MADOKA is designed to filter out the structures with low secondary structural similarity in the first phase as initial alignment, and perform precise alignment in the second phase as accurate alignment. MADOKA also benefits from highly parallelized programming by using multi-core processors to accelerate processes of protein structure similarity neighbor search.

Results

SCOP and CATH [28] are used as standards for assessing the structure alignment in various methods. However, proteins that differ from fold families in the SCOP and CATH categories may contain significant structural similarity [13]. We have geometric measure benchmarks purely to evaluate the structure alignment quality between pairwise proteins.

Datasets

We use three datasets to assess the performance of MADOKA. The first dataset TM-align is obtained from the TM-align paper [12], which includes 200 non-homologous protein structures from PDB ranging in size from 46 to 1058 residues. We get (200×199)/2=19,900 protein pairs in total. The second dataset comes from MALIDUP [29], which contains 241 manually curated pairwise structure alignments homologous domains originated from internal duplication. The third is MALISAM [30], which consists of 130 protein pairs that are different in terms of SCOP [31] folds but structurally analogous.

MADOKA employs the secondary structure elements and the backbone C α coordinates of the protein structures for alignment.

Performance comparison with existing structure alignment techniques

We have performed comparison experiments on a workstation computer with two Intel Xeon E5-2630 v3 processors and 64GB of memory. The result of the alignments generated by MADOKA and CE [9], SAL [10], TM-align [12], Fr-TM-align [13] on the TM-align dataset is shown in Table 1. MADOKA achieves the best performance in the RMSD and TM-score metrics. Most importantly, the speed of MADOKA is much faster than the other four algorithms and its total time consumption was about 265 seconds, indicating the filtering process and parallel computing play a key role in improving search speed. By the first-phase alignment, our method largely narrows down the number of pairwise proteins for precise alignments to be done in the second phase, 11,052 pairs complete both phases in total, which account for about 55.5% of all 19,900 structure pairs. Moreover, the implementation of MADOKA is a concurrent system [32] that runs many alignments for different pairs on different CPU cores at the same time. We use MADOKA to search structure neighbors against the entire PDB database for each protein in the TM-align dataset. The calculation time corresponding to proteins with different lengths is shown in Fig. 1a, and the distribution of protein number with respect to the protein length is shown in Fig. 1b. We can see that the larger the size of protein structure, the longer the calculation time is needed. Most proteins are in 100aa-300aa in length, and the number of protein longer than 500aa is small. It is worth noting that the total calculation time depends on the number of proteins, but the average calculation time is only related to the size of protein structure. Moreover, we carry out another experiment to check the relationship between average calculation time and size of protein structure. From the entire dataset, we randomly extract certain number of proteins (N=20, 40 and 60) to execute searching task, and then compute the average protein length and average running time. This process is repeated for 1000 times. The result is shown in Fig. 1c, we find that three curves of average running time overlap to each other, meanwhile increase gradually with the protein length. This result indicates that the average running time is largely affected by the size of protein structure, not the number of proteins. Finally, we split the proteins into three groups by their length, i.e. short (≤200aa), moderate (201aa-400aa) and large (401aa-700aa). For each group, we randomly extract increasing number of proteins to execute the searching task, and the average running time is computed. The process is repeated till every protein in a group is selected at least one time. As shown in Fig. 1d, the curves of average running time regarding to each group keep steady, while they differ largely from each other for different size of protein structures.

Fig. 1
figure 1

Computing time and amount of protein at different protein sizes. a shows the average computing time of proteins in the TM-align dataset for structural similarity searching against the whole PDB database by using MADOKA. b indicates the number of structures at different protein sizes in the TM-align dataset. c shows average running time curves with respect to randomly selected proteins from entire TM-align dataset (N=20, 40 and 60 is the number of selected proteins each time). d shows average running time corresponding to three different group of protein split by lengths

Table 1 Alignment performance comparison on the TM-align dataset

Next, we conduct performance evaluation on the other two datasets for MADOKA and five different methods, including DeepAlign [33], DALI [8], MATT [34], Formatt [35] and TM-align [12] in Table 2. Nali measure represents the total count of aligned residues in each pairwise structure alignment [36]. In this test, we skip the first phase in order to verify the validity of the second phase. Among these approaches, MADOKA obtains highest TM-score and number of aligned residues (Nali). Moreover, MADOKA’s calculation time is far less than other methods.

Table 2 Performance of six pairwise structure alignment tools on benchmarks MALIDUP and MALISAM

Parameters selection

Note that the LCS length for strings of secondary structural elements of each protein pair will be compared with a threshold. If the length is less than the threshold, the pair will be filtered out. So the threshold for the second phase should be selected properly. The higher the threshold, the fewer pairs will get residue-level alignments. The lower the threshold, the weaker the acceleration effect of the first phase. The length of LCS for pairwise strings depends mainly on the length of the shorter one. For trade-off between time efficiency and alignment accuracy, we take the threshold as min(m,n)×0.7 in all of our tests. A protein pair will pass the first phase if the LCS length S[m,n]>threshold.

Within the TM-align dataset, we choose the gap open penalty of the second phase of MADOKA as 3×10−6. For MALIDUP and MALISAM datasets, we specify the gap penalty as 3×10−6 and 0.08, respectively. We find that maybe a low gap penalty contributes to a better result for dataset contains many remote homologous protein structures, but it likely just opposite for structurally analogous proteins.

Case study

As shown in Fig. 2a and b, there are two illustrative examples of TM-align alignments and MADOKA alignments. Benefits from optimal-position based fragment alignment, MADOKA could gain some improvements. Figure 2a shows structural alignments between 1A1O_A and 4HKJ_A, MADOKA is able to align nearly all regions and get a better superposition result, as well as RMSD and TM-score. Figure 2b shows alignments between 2GZA_A and 1A1M_B, MADOKA acquires an optimized aligned position which has a common region of β-strands, which obtains higher TM-score and lower RMSD value.

Fig. 2
figure 2

Two examples showing the structural alignments from TM-align and MADOKA. a shows alignment between 1A1O_A (276 residues) and 4HKJ_A (277 residues). b shows alignment between 2GZA_A (334 residues) and 1A1M_B (99 residues)

Web interface

Our MADOKA web server accepts a protein 3D structure file in PDB format or a PDB code as input. MADOKA will check the validity of the input protein, and then conduct structure similarity searching against the whole PDB database. The time required for similarity searching is dependent on the size of the query protein. Most searches can be completed within half an hour. The output consists of a list of structural neighbors, their RMSD and TM-scores for each submitted query protein, which can be downloaded in text format. A unique feature is the 3D visualization of structure alignment for the query protein and its structural neighbors (Fig. 3).

Fig. 3
figure 3

Web page for 3D visualization of structure alignment and structure neighbors

Discussion

Commonly, there are two kinds of protein structure alignment approaches. The first compares a pair of structures with an a priori specified equivalence between pairs of residues (often offered by sequence or threading alignments [37]). The second is to compare structures under a set of equivalent residues, which is not a priori given; this is an NP-hard problem with no exact solution for an optimal alignment [38]. Accurate protein structure alignment could be complicated and computationally expensive as protein structures are very large and databases are becoming increasingly huge such as PDB. In this study, we integrate SSE and residue similarity to search protein structural similarity neighbors effectively. Moreover, our algorithm focused on searching an optimal aligned position between a short structure and a long structure to obtain a local alignment, rather than an all-to-all residues comparisons based global alignment. The local alignment contributes to higher TM-score, lower RMSD and more aligned residues. A limitation of MADOKA is that it requires specified gap penalty value for residue-level alignment, which may limit its application. However, with the classification of protein data becomes clearer, we believe MADOKA can be a useful fast tool for accurately searching protein structural neighbor in large-scale context.

Conclusion

In this paper, we proposed a two-phase algorithm, referred to as MADOKA, for protein structural alignment and similarity neighbor searching, together with a web server. The secondary structure element, residue alignment and filtering mechanism are introduced to accelerate the alignment process and performs faster when a parallel implementation is used. Compared to existing representative protein structure alignment methods, MADOKA outperforms about 6, 20 and 100 times faster than TM-align, CE and SAL on large-scale datasets, respectively. Meanwhile, MADOKA achieves better alignment quality than a couple of methods. We expect MADOKA to be applied to structure-based protein interaction and function predictions [3942].

Methods

Overview of MADOKA

MADOKA performs one-against-all structure alignment procedure between the query protein and all proteins in the database. The illustrative workflow is shown in Fig. 4. The algorithm of MADOKA is composed of two phases. In the first phase, we represent pairwise protein structures as two strings of secondary structure units, and then conduct initial alignment between the secondary structure sequences by marking the Longest-Common-Subsequence (LCS) by dynamic programming. In the second phase, for each pairwise proteins with initial alignment score larger than a predefined threshold, we run pairwise 3D residue structural alignments by rigid body superposition and modified TM-align rotation matrix to pick up an alignment with highest TM-score (the comprehensive description of these two phases are showed in the following two sections). For versatility, The MADOKA implementation is written in C++ standard syntax and standard concurrency library, and thus supports multiple compilers natively and can run on many operating systems such as Microsoft Windows, macOS and Linux without modification. The program will decide whether to use multi-threading mode depending on the scale of input pairs; if the program is in parallel state, there will be multiple simultaneous executions of the algorithms for different pairs. The MADOKA website is developed using Perl, JavaScript, jQuery(AJAX) and CSS, and calls the MADOKA program for protein structure similarity searching.

Fig. 4
figure 4

Schematic diagram of MADOKA algorithm and the web interface. The algorithm involves two steps: 1) Search for Longest-Common-Subsequence (LCS) for each pairwise secondary structure elements using dynamic programming, and then structure pairs with the length of the LCS below the threshold are removed; 2) Pairwise 3D residue structural rigid body superposition is performed and residue-level alignments are constructed, and the best alignment with the highest TM-score and optimally aligned position for each pair of protein structures is selected

First phase: initial alignment

First of all, we denote pairwise protein structures A and B as two strings of secondary structure types (α-helix, β-strand, coil and others) by using the DSSP [43] program, each character in a string corresponds with the secondary structure element (SSE) of a residue:

$$ A=[SSE_{1}^{A},SSE_{2}^{A},...,SSE_{m}^{A} ] $$
(3)
$$ B=[SSE_{1}^{B},SSE_{2}^{B},...,SSE_{n}^{B}] $$
(4)

m, n is the number of residues in protein structures A and B, respectively.

The initial alignment is obtained by marking the two strings using the Longest-Common-Subsequence(LCS) between them, the effective solution using dynamic programming of the LCS problem is given in Eq. (5).

$$ S[\!i,j]\,=\,\left\{\begin{array}{ll} 0 & \text{} i=0\;or\;j=0\\ S[i-1,j-1]+1 & \text{} i,j>0\;and\;A_{i}=B_{j}\\ max(S[i-1,j],S[i,j-1]) & \text{} i,j>0\;and\;A_{i}\neq B_{j}\\ \end{array}\right. $$
(5)

In which S is a (m+1)×(n+1) dimension scoring matrix, S[i,j] is the length of LCS ranging from A1 to Ai and B1 to Bj. Then, S[m,n] is the length of LCS for the global A and B. Finally, make a traceback on S to get an optimal path for initial alignment. An example is demonstrated in Fig. 5 [44], and the detailed step of backtracking for constructing initial alignment is described in Algorithm 1.

Fig. 5
figure 5

Scoring matrix for LCS problem and dynamic programming backtrack

Second phase: accurate alignment

We set a threshold for each pairwise alignment in the first phase. Structures passed the first phase are being further aligned to obtain the accurate alignment in the second phase. This phase employs the 3D coordinates of backbone Cα atoms for a pair of aligned protein structures A and B. We pick the short structure that contains fewer residues as template structure, and the other as constant structure. Then we set Lt as the length of the template and Lc as the length of the constant. Starting with the template structure, we superpose it to the corresponding residues of the constant residues according to Kabsch algorithm [45]. Secondly, we create a new scoring matrix for template and a fragment of the same length with template on constant. The matrix is defined as:

$$ M[i,j]=\left\{\begin{array}{l} 0 \;\;when\;i=0\;or\;j=0 \\ Max \left\{\begin{array}{l} M[i-1,j]+g\\ M[i,j-1]+g\\ M[i-1,j-1]+\frac{1}{1+d_{ij}^{2}/d_{0}(L_{min})^{2}}\\ \end{array}\right. \end{array}\right. $$
(6)

where g is the gap penalty customized by user, dij is the distance of the ith residue in template structure and the jth residue in constant structure under the superposition, and \(d_{0}(L_{min}) =1.24\sqrt [3]{L_{min}-15}-1.8\) which Lmin being the length of the template. The formula above is a modified TM-align rotation matrix [12] definition. An alignment can be constructed by a dynamic programming backtrack on M. An alignment consists of residue pairs which are aligned or a gap inserted between a pair. Next, we collect all fragments on the alignment with at least 10 successive aligned residue pairs, then superpose this set of fragments onto the constant structure again. A new alignment is generated by another traceback with a new matrix. Then we perform a gapless threading which is composed of all (LcLt+1) iterations with residue location shifting from the N- to the C-terminus between the template and constant. Next, we choose an alignment with maximum TM-score computed by the superposed template and the corresponding fragment on the constant structure. Be aware that the optimal alignment is between the whole template and the fragment which has an optimized position on the constant and the same number of residues as the template.

There is usually a strong relationship between the converged superposition and the length of superposed fragment, so we create five groups; each group contains a copy of the template structure. Then each group divides their template into several parts; all parts in a group have an equal length. The number of parts in each group is 1, 2, 3, 5, and 8, respectively. Next, we take parts in each group to have the superposed, DP and gapless threading procedures with the order of template residue sequence, and then combine all sub-structure alignments into a complete alignment for each group. Eventually, the alignment with the highest TM-score among all number of parts is selected as the final accurate alignment. A more concrete description for the algorithm of phase two is presented in Algorithm 2.

Availability of data and materials

The web server, experiment benchmarks and the source code of the standalone program of MADOKA are freely available at http://madoka.denglab.org/.

Abbreviations

3D:

3-Dimensional

aa:

Amino acid

BLAST:

Basic local alignment search tool

CASSERT:

Cα atom (C), angle defined by vectors between successive Cα atoms (A), secondary structure element (SSE), residue type (RT)

CATH:

Protein class (C), architecture (A), topology (T) and homologous superfamily (H)

CE:

Combinatorial extension

CPU:

Central processing unit

DALI:

Distance mAtrix aLIgnment

DP:

Dynamic programming

DSSP:

Define secondary structure of proteins

FATCAT:

Flexible structure alignment by chaining AFPs (Aligned Fragment Pairs) with Twists

FAST:

A recursive acronym of FAST alignment and search tool

GB:

Gigabyte

LCS:

Longest-common-subsequence

MALIDUP:

Manual alignments of duplicated domains

MALISAM:

Manual alignments of structurally analogous motifs

MATT:

Multiple alignment with translations and twists

MICAN-SQ:

Multiple-chain complexes, inverse direction of secondary structures, Cα only models, alternative alignments, non-sequential alignments, and sequential alignment

NP-hard:

Non-deterministic polynomial-time hard

PDB:

Protein data bank

ppsAlign:

Parallel protein structure alignment

RMSD:

Root-mean-square deviation

SAL:

Structure alignment

SCOP:

Structural classification of proteins

TM-score:

Template modeling score

SSE:

Secondary structure element

References

  1. Zhang QC, Petrey D, Deng L, Qiang L, Shi Y, Thu CA, Bisikirska B, Lefebvre C, Accili D, Hunter T, et al.Structure-based prediction of protein–protein interactions on a genome-wide scale. Nature. 2012; 490(7421):556.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Wei L, Liao M, Gao X, Zou Q. An improved protein structural classes prediction method by incorporating both sequence and structure information. IEEE Trans Nanobiosc. 2014; 14(4):339–49.

    Article  Google Scholar 

  3. Petrey D, Chen TS, Deng L, Garzon JI, Hwang H, Lasso G, Lee H, Silkov A, Honig B. Template-based prediction of protein function. Curr Opin Struct Biol. 2015; 32:33–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Deng L, Chen Z. An integrated framework for functional annotation of protein structural domains. IEEE/ACM Trans Comput Biol Bioinform (TCBB). 2015; 12(4):902–13.

    Article  CAS  Google Scholar 

  5. Garzón JI, Deng L, Murray D, Shapira S, Petrey D, Honig B. A computational interactome and functional annotation for the human proteome. Elife. 2016; 5:18715.

    Article  CAS  Google Scholar 

  6. Minami S, Sawada K, Ota M, Chikenji G. Mican-sq: A sequential protein structure alignment program that is applicable to monomers and all types of oligomers. Bioinformatics. 2018; 1:8.

    Google Scholar 

  7. Zeng C, Zhan W, Deng L. Sdadb: a functional annotation database of protein structural domains. Database. 2018; 2018. https://doi.org/10.1093/database/bay064.

  8. Holm L, Sander C. Protein structure comparison by alignment of distance matrices. J Mol Biol. 1993; 233(1):123–38.

    Article  CAS  PubMed  Google Scholar 

  9. Shindyalov IN, Bourne PE. Protein structure alignment by incremental combinatorial extension (ce) of the optimal path. Protein Eng. 1998; 11(9):739–47.

    Article  CAS  PubMed  Google Scholar 

  10. Kihara D, Skolnick J. The pdb is a covering set of small protein structures. J Mol Biol. 2003; 334(4):793.

    Article  CAS  PubMed  Google Scholar 

  11. Ye Y, Godzik A. Flexible structure alignment by chaining aligned fragment pairs allowing twists. Bioinformatics. 2003; 19(suppl_2):246–55.

    Google Scholar 

  12. Zhang Y, Skolnick J. Tm-align: a protein structure alignment algorithm based on the tm-score. Nucleic Acids Res. 2005; 33(7):2302–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  13. Pandit SB, Skolnick J. Fr-tm-align: a new protein structural alignment method based on fragment alignments and the tm-score. Bmc Bioinformatics. 2008; 9(1):531.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  14. Zhu J, Weng Z. Fast: a novel protein structure alignment algorithm. Proteins Struct Funct Bioinform. 2005; 58(3):618–27.

    Article  CAS  Google Scholar 

  15. Mrozek D, Małysiak-Mrozek B. Cassert: a two-phase alignment algorithm for matching 3d structures of proteins. In: International Conference on Computer Networks. Springer: 2013. p. 334–43. https://doi.org/10.1007/978-3-642-38865-1_34.

    Chapter  Google Scholar 

  16. Wang S, Ma J, Peng J, Xu J. Protein structure alignment beyond spatial proximity. Sci Rep. 2013; 3:1448.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  17. Orengo CA, Taylor WR. Ssap: sequential structure alignment program for protein structure comparison. Methods Enzymol. 1996; 266(1):617–35.

    Article  CAS  PubMed  Google Scholar 

  18. Ortiz AR, Strauss CEM, Olmea O. Mammoth (matching molecular models obtained from theory): An automated method for model comparison. Protein Sci. 2009; 11(11):2606–21.

    Article  CAS  Google Scholar 

  19. Zou Q, Hu Q, Guo M, Wang G. Halign: Fast multiple similar dna/rna sequence alignment based on the centre star strategy. Bioinformatics. 2015; 31(15):2475–81.

    Article  CAS  PubMed  Google Scholar 

  20. Dong R, Pan S, Peng Z, Zhang Y, Yang J. mtm-align: a server for fast protein structure database search and multiple protein structure alignment. Nucleic Acids Res. 2018; 46:380–6.

    Article  CAS  Google Scholar 

  21. Zhang Y, Skolnick J. Scoring function for automated assessment of protein structure template quality. Proteins. 2004; 57(4):702–10.

    Article  CAS  PubMed  Google Scholar 

  22. Siew N, Elofsson A, Rychlewski L, Fischer D. Maxsub: an automated measure for the assessment of protein structure prediction quality. Bioinformatics. 2000; 16(9):776–85.

    Article  CAS  PubMed  Google Scholar 

  23. Altschul SF, Madden TL, Schäffer AA, Zhang J, Zhang Z, Miller W, Lipman DJ. Gapped blast and psi-blast: a new generation of protein database search programs. Nucleic Acids Res. 1997; 25(17):3389–402.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Mrozek D, BroŻek M, Małysiak-Mrozek B. Parallel implementation of 3d protein structure similarity searches using a gpu and the cuda. J Mol Model. 2014; 20(2):2067.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  25. Pang B, Zhao N, Becchi M, Korkin D, Shyu C-R. Accelerating large-scale protein structure alignments with graphics processing units. BMC Res Notes. 2012; 5(1):116.

    Article  PubMed  PubMed Central  Google Scholar 

  26. Yang A-S, Honig B. An integrated approach to the analysis and modeling of protein sequences and structures. i. protein structural alignment and a quantitative measure for protein structural distance1. J Mol Biol. 2000; 301(3):665–78.

    Article  CAS  PubMed  Google Scholar 

  27. Berman HM. The protein data bank: a historical perspective. Acta Crystallogr A. 2008; 64(1):88–95.

    Article  CAS  PubMed  Google Scholar 

  28. Orengo CA, Michie AD, Jones S, Jones DT, Swindells MB, Thornton JM. Cath – a hierarchic classification of protein domain structures. Structure. 1997; 5(8):1093–108.

    Article  CAS  PubMed  Google Scholar 

  29. Cheng H, Kim BH, Grishin NV. Malidup: a database of manually constructed structure alignments for duplicated domain pairs. Proteins Struct Funct Bioinform. 2010; 70(4):1162–6.

    Article  CAS  Google Scholar 

  30. Cheng H, Kim BH, Grishin NV. Malisam: a database of structurally analogous motifs in proteins. Nucleic Acids Res. 2008; 36(Database issue):211–7.

    Google Scholar 

  31. Murzin AG, Brenner SE, Hubbard T, Chothia C. Scop: a structural classification of proteins database for the investigation of sequences and structures. J Mol Biol. 1995; 247(4):536–40.

    CAS  PubMed  Google Scholar 

  32. Stroustrup B. The C++ Programming Language, 4th Edition; 2013.

  33. Wang S, Ma J, Peng J, Xu J. Protein structure alignment beyond spatial proximity. Sci Rep. 2012; 3(3):1448.

    Google Scholar 

  34. Menke M, Berger B, Cowen L. Matt: local flexibility aids protein multiple structure alignment. PloS Comput Biol. 2008; 4(1):10.

    Article  CAS  Google Scholar 

  35. Daniels NM, Shilpa N, Cowen LJ. Formatt: Correcting protein multiple structural alignments by incorporating sequence alignment. BMC Bioinformatics. 2012; 13(1):259.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  36. Brown P, Pullan W, Yang Y, Zhou Y. Fast and accurate non-sequential protein structure alignment using a new asymmetric linear sum assignment heuristic. Bioinformatics. 2016; 32(3):370.

    Article  CAS  PubMed  Google Scholar 

  37. Skolnick J, Kihara D, Zhang Y. Development and large scale benchmark testing of the prospector_3 threading algorithm. Proteins-Struct Funct Bioinform. 2004; 56(3):502–18.

    Article  CAS  Google Scholar 

  38. Lathrop RH. The protein threading problem with sequence amino acid interaction preferences is np-complete. Protein Eng. 1994; 7(9):1059.

    Article  CAS  PubMed  Google Scholar 

  39. Tang Y, Liu D, Wang Z, Wen T, Deng L. A boosting approach for prediction of protein-rna binding residues. BMC Bioinformatics. 2017; 18(13):465.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  40. Zheng N, Wang K, Zhan W, Deng L. Targeting virus-host protein interactions: Feature extraction and machine learning approaches. Curr Drug Metab. 2019; 20(3):177–84.

    Article  CAS  PubMed  Google Scholar 

  41. Pan Y, Wang Z, Zhan W, Deng L. Computational identification of binding energy hot spots in protein–rna complexes using an ensemble approach. Bioinformatics. 2018; 34(9):1473–80.

    Article  CAS  PubMed  Google Scholar 

  42. Wang H, Liu C, Deng L. Enhanced prediction of hot spots at protein-protein interfaces using extreme gradient boosting. Sci Rep. 2018; 8(1):14285.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  43. Kabsch W, Sander C. Dictionary of protein secondary structure: pattern recognition of hydrogen-bonded and geometrical features. Biopolymers. 1983; 22(12):2577–637.

    Article  CAS  PubMed  Google Scholar 

  44. Cormen TH, Leiserson CE, Rivest RL, Stein C. Introduction to Algorithms, Third Edition; 2009.

  45. Kabsch W. A discussion of the solution for the best rotation to relate two sets of vectors. Acta Crystallogr Section Found Crystallogr. 1976; 32(5):922–3.

    Google Scholar 

Download references

Acknowledgements

The authors thank Yang Zhang for making the TM-align code freely available.

About this supplement

This article has been published as part of BMC Bioinformatics, Volume 20 Supplement 19, 2019: 18th International Conference on Bioinformatics. The full contents of the supplement are available at https://bmcbioinformatics.biomedcentral.com/articles/supplements/volume-20-supplement-19.

Funding

This work was funded by National Natural Science Foundation of China [grants No. 61672541, 61672113], Fundamental Research Funds for the Central Universities of Central South University [grant No.2018zzts627], Social Development Projects of Jiangsu Province (BE2018643) and Scientific Program of Changzhou (CE20195048; ZD201919).

Author information

Authors and Affiliations

Authors

Contributions

LD, GZ and HL designed the study and conducted experiments. LD and GZ performed statistical analyses. LD, GZ, JL and HL drafted the manuscript. GZ prepared the experimental materials and benchmarks. LD, GZ and CL completed the web server. JL and HL administrated the project and acquired funding. All authors have read and approved the final manuscript.

Corresponding authors

Correspondence to Judong Luo or Hui Liu.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License(http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver(http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Deng, L., Zhong, G., Liu, C. et al. MADOKA: an ultra-fast approach for large-scale protein structure similarity searching. BMC Bioinformatics 20 (Suppl 19), 662 (2019). https://doi.org/10.1186/s12859-019-3235-1

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-019-3235-1

Keywords