Skip to main content

Protein folding prediction in the HP model using ions motion optimization with a greedy algorithm

Abstract

Background

The function of a protein is determined by its native protein structure. Among many protein prediction methods, the Hydrophobic-Polar (HP) model, an ab initio method, simplifies the protein folding prediction process in order to reduce the prediction complexity.

Results

In this study, the ions motion optimization (IMO) algorithm was combined with the greedy algorithm (namely IMOG) and implemented to the HP model for the protein folding prediction based on the 2D-triangular-lattice model. Prediction results showed that the integration method IMOG provided a better prediction efficiency in a HP model. Compared to others, our proposed method turned out as superior in its prediction ability and resilience for most of the test sequences. The efficiency of the proposed method was verified by the prediction results. The global search capability and the ability to escape from the local best solution of IMO combined with a local search (greedy algorithm) to the new algorithm IMOG greatly improve the search for the best solution with reliable protein folding prediction.

Conclusion

Overall, the HP model integrated with IMO and a greedy algorithm as IMOG provides an improved way of protein structure prediction of high stability, high efficiency, and outstanding performance.

Peer Review reports

Background

Polypeptides consist of a maximum of 20 amino acids. The function of a given protein is determined by the native structure or its polymer structure, which correlates with particular protein functions [1]. The native three-dimensional structure of a protein primarily depends on its amino acid sequence [2]. The development of a highly efficient method for protein folding prediction is in high demand, particularly for protein studies in biotechnology. Currently, several methods have been proposed for protein structure prediction. Comparative modeling and fold recognition approaches commonly use a known protein structure database to train a model in order to classify an unknown protein structure [2]. In contrast, the ab initio method provides a direct prediction using the primary structure or amino acid sequence of a given protein.

Based on the ab initio method, Dill has proposed the hydrophobic-polar protein folding model (HP model) in 1985 which simulates protein folding based on amino acid sequences under the lattice model [3]. In 2013, Bechini used a triangular lattice model for protein folding prediction by simplifying amino acids into hydrophobic (H) and polar (P) types [4]. The predicted space in between the simulated folds is limited to the lattice model; the actual fold space is discrete and the folding of the amino acid sequence follows a self-avoiding walk along the lattice. However, for the protein structure prediction, it remains a challenge to explore the possibility of an extremely large folding in order to obtain an optimal solution for the nondeterministic polynomial-time-hard (NP-hard) problem [5].

Anfinsen’s dogma, following a thermodynamic hypothesis, assumes that the native structure of globular proteins usually folds according to a unique, stable, and kinetically accessible minimum of free energy [6]. The central structure of a globular protein usually contains hydrophobic (non-polar) amino acid compositions that produce hydrophobic attraction to avoid water molecules at the outside. This postulate was also applied to the HP model-based protein structure prediction. To provide an example, if two hydrophobic amino acids are closed together, a hydrophobic-hydrophobic (H-H) interaction is generated. Once the strength of H-H interactions is increased, a more stable structure is predicted. The HP model uses this property giving a negative value for the adjacent hydrophobic amino acids interaction and calculating the number of adjacent hydrophobic interactions [7]. When more adjacent hydrophobic amino acids are present, the predicted structure is closer to the real structure representing optimal protein folding. However, the development of an optimal algorithm for protein folding prediction remains a challenge.

A 2D-triangle-lattice-model [8] is commonly used for 2D HP model of protein folding problem. It has six neighbors in the two dimension triangular lattice on each lattice. When a triangle-lattice-model is embedded in the protein, it can be in topological contact with each other. The vector obtained from the triangle lattice that is easier to model a protein structure on the 2D-triangle-lattice-model [9]. The self-avoiding walk for protein folding is the NP-hard problem and led to several heuristic and meta-heuristic algorithms that were proposed to find best protein structure predictions. These include among others: genetic algorithm [10], branch and bound [11], replica exchange Monte Carlo [12], Evolutionary Monte Carlo [13], greedy-like-algorithm [14].

We use here an ions motion optimization (IMO) algorithm [15] as a heuristic algorithm that is combined – as a novum – with a greedy algorithm for local search within the 2D-triangle-lattice-model to optimize protein folding predictions of high stability, high efficiency, and outstanding performance.

Methods

We develop here a novel algorithm (IMOG) which combines ions motion optimization (IMO) algorithm [15] with a greedy algorithm as a local search strategy for predicting protein folding reliably at high resolution. Details of our approach are described below.

Protein folding problem of a 2D-HP-model

The HP-model is a well-known process for protein folding simulation that simulates the hydrophobic interaction between amino acid residues. All 20 amino acids are classified into two groups based on their hydrophobicity/hydrophilicity: H represents hydrophobic/nonpolar residues and P represents hydrophilic/polar residues. Given N amino acids residue sequences of a protein chain, S = {a1, a2, …, aN}  {H, P}. The energy E of a chain conformation was proposed for comparing the stability of several predicted protein structures [7]. The energy E of a chain conformation was defined to the number of H-H contacts h, i.e., E = − |ε| h, where |ε| is a positive constant. The units of energy E is |ε|. For simplification, the energy E of protein conformation is calculated by the following formula as described previously [9, 10]:

$$ E={\Sigma}_{i,j}\varDelta {r}_{ij}{\in}_{ij} $$
(1)

where

$$ {\in}_{ij}=\left\{\begin{array}{l}-1.0, the\ pair\ of\ H\ and\ H\ residues\\ {}0.0, others\end{array}\right. $$
(2)

and

$$ \varDelta {r}_{ij}=\left\{\begin{array}{l}1, if\;{a}_i\;\mathrm{and}\;{a}_j\;\mathrm{are}\;\mathrm{adjacent}\;\mathrm{but}\;\mathrm{do}\;\mathrm{not}\kern0.17em \mathrm{connect}\kern0.17em \mathrm{amino}\kern0.17em \mathrm{acids}\\ {}0, others\end{array}\right. $$
(3)

The 2D-HP protein folding problem can be formally defined as finding a conformation of S with minimum energy. This has been proven to be a NP-hard problem.

Imo

The IMO algorithm has been recently introduced as a metaheuristic optimization technique and it is inspired by the motion of ions [15]. Each single ion in its particular position provides a candidate for solving a particular optimization problem. The movements of ions depend on the attraction or repulsion of ions, i.e., anion (negative charged ion) and cation (positive charged ion). The attraction and repulsion forces between anions and cations are utilized to move the position of ions around a feasible search region. The forces are calculated as acceleration of ion motions. Anions move towards a best fitness of cations and cations move towards a best fitness of anions. Two strategies of ion motion for providing diversification and intensification, these are movements in a liquid phase and a solid phase scenario, respectively. In this study, we implemented an IMO as a heuristic algorithm to find the best HP model for protein folding simulation.

In the 2D-dimensional search space, assuming a population consists of N anions/cations moving around. The ith anion and ith cation are represented by Ai = (ai1, ai2, …, aiD) and Ci = (ci1, ci2, …, ciD) in their respective position. The populations of anions and cations are initialized by a uniform random position A {A1, A2, ..., AN} and position C {C1, C2, ..., CN}. Each position of an ion provides a candidate solution for a particular problem. When the fitness of evaluation results is calculated, the global best solutions (Abest and Cbest) and current individual worst solutions (Aworst and Cworst) are determined.

In the liquid phase strategy, the attraction forces are used for a search space [15], and its computation is calculated from the distance between two ions (e.g., anion and cation), the measurement is defined as follows:

$$ {AF}_{i,j}=\frac{1}{1+{e}^{-0.1/{AD}_{i,j}}} $$
(4)
$$ {CF}_{i,j}=\frac{1}{1+{e}^{-0.1/{CD}_{i,j}}} $$
(5)

where ADi, j = |Ai, j − Cbestj| is the distance between the current anion position and the globally best cation position; CDi, j = |Ci, j − Abestj| is the distance between the current cation position and the globally best anion position. AFi,j and CFi,j represent resultant attraction forces of anions and cations, respectively.

According to formula (4) and (5), the position of anions and cations based on the attraction force are updated as the following equations:

$$ {A}_{i,j}={A}_{i,j}+{AF}_{i,j}\times \left( Cbes{\mathrm{t}}_j-{A}_{i,j}\right) $$
(6)
$$ {C}_{i,j}={C}_{i,j}+{CF}_{i,j}\times \left({Abest}_j-{C}_{i,j}\right) $$
(7)

In the solid phase strategy, when convergence has occurred or solid phase conditions are satisfied, external forces are evaluated in order to escape entrapment in the local optima, and the formula is described as follows:

$$ {\displaystyle \begin{array}{l}\boldsymbol{if}\; CbestFit\ge CworstFit/2\ \mathrm{and}\ AbestFit\ge AworstFit/2\\ {}\kern1.08em \boldsymbol{if}\;{\operatorname{rand}}_1\left(\;\right)>0.5\\ {}\kern2.04em {A}_i={A}_i+{\Phi}_1\times \left( Cbest-1\right)\\ {}\begin{array}{l}\kern1.08em \boldsymbol{else}\\ {}\kern2.04em {A}_i={A}_i+{\Phi}_1\times Cbest\\ {}\kern1.08em \boldsymbol{end}\;\boldsymbol{if}\\ {}\begin{array}{l}\kern1.08em \boldsymbol{if}\;{\operatorname{rand}}_2\left(\;\right)>0.5\\ {}\kern2.04em {C}_i={C}_i+{\Phi}_2\times \left( Abest-1\right)\\ {}\kern1.08em \boldsymbol{else}\\ {}\begin{array}{l}\kern2.04em {C}_i={C}_i+{\Phi}_2\times Abest\\ {}\kern1.08em \boldsymbol{end}\;\boldsymbol{if}\\ {}\kern1.08em \boldsymbol{if}\;{\operatorname{rand}}_3\left(\;\right)<0.05\\ {}\begin{array}{l}\kern1.92em \operatorname{Re}\hbox{-} \mathrm{initialized}\;{A}_i\ \mathrm{and}\ {C}_i\;\mathrm{with}\kern0.17em \mathrm{random}\kern0.17em \mathrm{position}\\ {}\kern1.08em \boldsymbol{end}\;\boldsymbol{if}\\ {}\boldsymbol{end}\;\boldsymbol{if}\end{array}\end{array}\end{array}\end{array}\end{array}} $$
(8)

where Φ1 and Φ2 are random numbers in the range of −1 to 1. rand1(), rand2() and rand3() are random numbers in the range of 0 to 1. AworstFit and CworstFit are the worst fitness solutions of anion and cation fits, respectively.

Greedy algorithm

The greedy algorithm is a simple and straightforward heuristic algorithm that makes a current local optimal decision at each stage for global optimization [16]. It is easy to implement and works efficiently depending on the problems although it may or may not be the best approach for solving this task. In any case, it plays a useful role as a optimization method according to its characteristics. Greedy algorithms are widely applied in bioinformatics tools such as among others DNA sequence alignment [16], co-phylogeny reconstruction problem [17], detection of transient calcium signaling [18], resolving the structure and dynamics of biological networks [19].

IMOG for 2D-HP-model

We implemented the IMO algorithm with a greedy algorithm as a local search strategy for the 2D-HP-model protein folding problem as follows (including IMOG procedure, encoding scheme, fitness function, and improved solid phase strategy):

IMOG procedure

This study presents an improved IMO with a greedy algorithm to be implemented in a 2D-HP-model process. The flowchart of our proposed method is shown in Fig. 1, and the detailed procedure of IMOG is described as follows:

  1. Step 1)

    Initialize populations of ions (anions and cations) with random position, each position of an ion is a candidate for the protein folding.

  2. Step 2)

    Estimate the fitness of each ion using energy of the 2D-HP-model according to the Eq. (9).

  3. Step 3)

    Update the global best solution Abest and Cbest according to the fitness calculation results.

  4. Step 4)

    Calculate the force and update position of each ion according to the Eqs. (4)–(7).

  5. Step 5)

    If the solid phase condition was satisfied, the solid phase strategies were executed.

  6. Step 6)

    Repeat steps 2–5 until the stop criterion has been met. Consequently, the best protein folding was obtained.

Fig. 1
figure 1

Flowchart for developing an IMO algorithm

Encoding scheme

In accordance with the previous description of problems, we utilized the integer IMO to proceed with the analysis. The neighbors of vertex in the 2D-triangular-lattice model in IMO are under anion/cation coding. Each position of anion/cation was designed in a format as the amino acid directions of movement in protein folding, and this was described as Ai = (di1, di2, …, diD) and Ci = (di1, di2, …, diD), respectively, where d {1, 2, …, 6} represents six neighbors in the 2D-triangular-lattice-model (Fig. 2a). For example, the IMO encoding the best solution for the sequence HHPPHPHPHPHPHP presents as 4, 5, 6, 2, 6, 2, 1, 3, 2, 4, 3, 5, and 4 (Fig. 2b).

Fig. 2
figure 2

Example of a 2D-HP-model. a 2D triangular lattice model with six neighbors. b Illustration of best solution in 2D-HP-model. The arrow with number indicates next direction of current amino acid. The red dotted line is H-H contact

Fitness function

Two hydrophobic amino acids xi and xj of the lattice positions pi and pj are respectively indicated to have a H-H contact that is represented as contact(pi, pj) = − 1, otherwise contact(pi, pj) = 0. The energy of the protein conformation is defined as the sum of its H-H contacts. If S has an HP sequence, and P = p1, p2, ..., pn represents a valid conformation for S, the energy E(P) of P is defined as follows:

$$ fitness={\Sigma}_{i=1}^{n-2}{\Sigma}_{j=i+2}^n contact\left({p}_i,{p}_j\right) $$
(9)

In the case of Fig. 3, the point p4 is not adjacent to p8, p9, p10 and p11 in the amino acid chain but is adjacent in the 2D-model space, thus the fitness is calculated as − 4. Consequently, (p3, p5), (p3, p11) and (p5, p8) are estimated as − 3, non-repetitively. Taken together, the fitness as the energy is − 7.

Fig. 3
figure 3

Illustration of the best fit obtained from the 2D-HP-model

Improved solid phase strategy

The original condition of solid phase (e.g., if CbestFit ≥ CworstFit / 2 AND AbestFit ≥ AworstFit / 2) is unsuitable for our problem. Therefore, we improve the solid phase statement for the HP-model protein folding prediction. In order to enhance the optimal solution, we add the local search method to this phase and pseudo-codes are provided in the formula (10).

$$ {\displaystyle \begin{array}{l}\boldsymbol{if}\; CbestFitNum\ \mathrm{and}\ AbestFitNum\;\mathrm{do}\ \mathrm{not}\kern0.17em \mathrm{change}> SolidNum\\ {}\kern0.96em \boldsymbol{if}\;{\operatorname{rand}}_1\;\left(\;\right)>0.5\\ {}\kern2.04em {A}_i={A}_i+{\Phi}_1\times \left( Cbest-1\right)\\ {}\kern0.96em \boldsymbol{else}\\ {}\kern2.04em {A}_i={A}_i+{\Phi}_1\times Cbest\\ {}\kern0.96em \boldsymbol{end}\;\boldsymbol{if}\\ {}\kern0.96em \boldsymbol{if}\;{\operatorname{rand}}_2\left(\;\right)>0.5\\ {}\kern1.92em {C}_i={C}_i+{\Phi}_2\times \left( Abest-1\right)\\ {}\kern0.96em \boldsymbol{else}\\ {}\kern1.92em {C}_i={C}_i+{\Phi}_2\times Abest\\ {}\kern0.96em \boldsymbol{end}\;\boldsymbol{if}\\ {}\kern0.96em \boldsymbol{if}\;{\operatorname{rand}}_3\left(\;\right)<0.05\\ {}\kern1.8em \mathrm{Local}\kern0.17em \mathrm{search}\hbox{-} \mathrm{greedy}\kern0.17em \mathrm{algorithm}\\ {}\kern0.96em \boldsymbol{else}\\ {}\kern1.8em \operatorname{Re}-\mathrm{initialized}\;{A}_i\ \mathrm{and}\ {C}_i\;\mathrm{with}\kern0.17em \mathrm{random}\kern0.17em \mathrm{position}\;\\ {}\kern0.96em \boldsymbol{end}\;\boldsymbol{if}\\ {}\boldsymbol{end}\;\boldsymbol{if}\end{array}} $$
(10)

where CbestFitNum and AbestFitNum are the numbers for the global best solution of cation/anion not yet changed. SolidNum is a parameter setting for how many times the CbestFitNum and AbestFitNum were not yet changed.

In this study, the greedy algorithm is utilized for a local search that randomly selects the point position of an anion/cation and to search six neighbors for their best solution. In the sequence HHPPHPHPHPHPHP example, through the greedy algorithm the best solution for the tenth point is 4. This is illustrated in Fig. 4.

Fig. 4
figure 4

Illustration of IMO with a local search by a greedy algorithm. The greedy algorithm is utilized for local search that randomly selects the position point and searches the best fitness of six neighbors

Results

Data sets

In the current study, two benchmark data sets for the 2D HP model protein prediction are used and the details are shown in Tables 1 and 2. These tables show the information of amino acid sequences including sequence number, length, sequence, and optimal known energy values. The sequences are described as binary symbols where 0 indicates the polar residues and 1 indicates the hydrophobic residues. The data within parenthesis (…)i represent the i-fold duplicate of a subsequence. For example, (010)2 represents the original information of data being 010010 (e.g., HPHHPH). Recently, several approaches such as hybrid of hill climbing and genetic algorithm [9], elite-based reproduction strategy-genetic algorithm (ERS-GA) [9], cached divide and conquer evolutionary algorithm [20], co-evolution of memetic algorithms [21], hybrid genetic algorithm (HGA) [22], and tabu search (TS) [23] have been proposed to predict protein folding using benchmark data sets, through HP-model-based computation estimates for protein structure prediction.

Table 1 First benchmark of amino acids sequences in HP model [9]
Table 2 Second benchmark of amino acids sequences in HP model [21]

Parameter settings

The advantages of the IMOG algorithm is a fewer number of tuning parameters, only population size (e.g., number of anion and cation) and iteration size. Here, we set 100 for the numbers of anions and cations and 2000 for the iteration size in this study. Additionally, the mutation probability of a greedy algorithm for each point in the local search is 0.25.

Comparison of the best prediction

Table 3 shows a comparison of the best optimal solution obtained from approaches taken from the HGA [22], TS [23], ERS-GA [9], HHGA [9], and our proposed IMOG algorithms. Table 4 compares MMA [24] (Multimeme algorithms for protein structure prediction) with our proposed IMOG approach for predicting results. These methods were applied to eight and twenty amino acids sequence data sets, respectively, that were independently run 30 times for each experiment. All methods can easily obtain the best solution when the length is smaller than 20. However, our proposed method can even obtain best solution when the length is smaller than 40. Table 3 shows the TS is better than our proposed IMOG method for the sequence 7 and HHGA is better than ours for the sequence 5. Nevertheless, IMOG obtains outstanding results for all eight sequences, especially the longest one. Table 4 shows that IMOG can obtain the best outcomes for all 20 sequences. In contrast, IMOG cannot obtain an optimal solution when the sequence length is longer than 30. The results show that the IMOG method proposed here predicts protein folding structure better than other available methods.

Table 3 Comparison of algorithms studied here for optimal solutions
Table 4 Comparison of the best prediction results of IMO with MMA algorithm

Comparsion of stability

Table 5 shows the comparison of the stability of algorithm outcome utilizing the optimal results and means in 30 independent runs. The literature of MMA did not provide the results for stability analysis, hence the outcome of IMOG was unable to compare with MMA. The optimal results and means can be observed the ability of algorithm finding best structure and the stability of algorithm. Table 5 shows that the mean of fitness of IMOG is better than that of ERS-GA and HHGA in each sequence significantly although the best fitness of HHGA is slightly better than IMOG. Consequently, the result indicates that the IMOG had a high quality in searching stability.

Table 5 Comparison of the best solutions and stabilities with other algorithms

Discussion

The IMO algorithm [15] is a population-based algorithm designed according to the natural properties of ions. Its idea is to divide the ion population into negative and positive charged ions (i.e., anions and cations). It is based on the fact that anions repel anions but attract cations and cations repel cations but attracts anions. It is reported that IMO is very competitive in solving challenging optimization problems [15]. Moreover, the greedy algorithm is also reported to improve local searches [25]. In computer science, hybrid algorithms are commonly applied in solving optimization problems [26,27,28,29,30,31,32]. Accordingly, we developed a novel algorithm that combines the IMO algorithm [15] with a greedy algorithm we here name IMOG for protein folding prediction. The key concept of our proposed IMOG algorithm is based on the characteristics of IMO having global search capabilities while escaping from the local best solution. In addition, the greedy algorithm is used in each update to strengthen its local search ability.

In this paper, two phases (liquid and solid) were designed for diverse and intense search that can make sure convergence of the ions toward an optimum in the feasible space and resolve local optima trap. Our proposed method has redundant extra parameters and it adapts itself automatically to search spaces. The obtained results indicate that the integrated algorithm has a good search ability and stability. Compared with other methods, the stability and search ability of our proposed method is better than other methods for protein structure prediction for most of the test sequences.

The HP-model of protein structure prediction problem was developed as discrete problem in folding space. In HP model, the amino acids were classified into hydrophobic and polar that keeps the prediction complexity down. Nevertheless, the whole possible combinations of protein folding prediction problem is still complex. Recently, researchers assume that the simple optimization algorithms were hard to solve protein folding structure prediction effectively [21]. Accordingly, many improved algorithms were proposed to enhance ability of prediction in HP model problem, such as HHGA [9]. The HHGA is an effective algorithm which combines genetic algorithm with a hill climbing algorithm, it can solve longer amino acid sequence well performance.

In this study, we implement an IMO with a greedy algorithm as local search for a 2D-HP model protein folding problem. The technical behavior (liquid phase strategy) of IMO is similar to the particle swarm optimization (PSO) [33] algorithm but the IMO had improved the “particle” to divide into two parts as anion and cation. The two global superior solutions were utilized to search global optimal solutions. It also had a mechanism to escape local optima through the solid phase strategy. We improved the IMO in order to enhance seeking local optima by adding a greedy algorithm to the solid phase strategy. Consequently, our proposed IMOG algorithm has several advantages including low computational complexity, rapid convergence, a smaller number of tuning parameters, avoidance of local optima and superior performance in searching for global optima [15].

Recently, several protein structure prediction systems were developed. For example, Rosetta [34,35,36] and i-TASSER [37, 38] are sophisticated comprehensive software suites for protein structure and function prediction. Structure prediction with Rosetta was reported to be enhanced performance with an additional modeling, such as the combined covalent-electrostatic model of hydrogen bonding [34]. The processing that generates protein structure and function predictions by i-TASSER is firstly retrieved from protein data bank (PDB) library by Local Meta-Threading-Server (LOMETS) [39]. When LOMETS is unable to identify suitable template, i-TASSER will process the ab initio modeling for protein structure and identify the low free energy states by SPICKER [40]. It is possible that our proposed IMO may support the function of SPICKER and i-TASSER by the calculation of energy mentioned in the current study. It warrants further evaluating the performance that our proposed IMO algorithm combines with Rosetta and i-TASSER for protein folding prediction in the future.

There are some limitations in the current study. The longest length of test sequence is 64 amino acids and it has 664 possible combinations in 2D triangular lattice model with six neighbors, showing superior to other test algorithms [9, 21,22,23]. However, the performance of our proposed IMO algorithm is only based on 28 test data sets. It warrants further evaluating for more data sets and longer length of test protein sequences. It is noted that our proposed IMO method is based on the relative energy. For precise comparison, the absolute free energy for protein folding structure warrants further investigation in the future.

Conclusions

This study uses an ab initio technique (hydrophobic polar model) to predict protein structures. This is one of the most commonly applied methods for protein structure prediction. We propose and develop here a combination of the IMO with a greedy algorithm for protein folding predictions assuming a hydrophobic polar model. Experimental results show that our proposed IMOG method can reliably seek and find the best solution among short sequences, and also effectively obtain satisfying results with longer sequences. Taken together, these results demonstrate that the hybrid algorithm, combining the IMO algorithm with a greedy algorithm provides a useful tool for protein folding predictions.

References

  1. Wang HW, Chu CH, Wang WC, Pai TW. A local average distance descriptor for flexible protein structure comparison. BMC Bioinformatics. 2014;15:95.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  2. Bahar I, Atilgan AR, Jernigan RL, Erman B. Understanding the recognition of protein structural classes by amino acid composition. Proteins Struct Funct Genet. 1997;29(2):172–85.

    Article  PubMed  CAS  Google Scholar 

  3. Dill KA. Theory for the folding and stability of globular proteins. Biochemistry. 1985;24(6):1501–9.

    Article  PubMed  CAS  Google Scholar 

  4. Bechini A. On the characterization and software implementation of general protein lattice models. PLoS One. 2013;8(3):e59504.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  5. Berger B, Leighton T. Protein folding in the hydrophobic-hydrophilic (HP) model is NP-complete. J Comput Biol. 1998;5(1):27–40.

    Article  PubMed  CAS  Google Scholar 

  6. Anfinsen CB. Principles that govern the folding of protein chains. Science. 1973;181(4096):223–30.

    Article  PubMed  CAS  Google Scholar 

  7. Yue K, Fiebig KM, Thomas PD, Chan HS, Shakhnovich EI, Dill KA. A test of lattice protein folding algorithms. Proc Natl Acad Sci U S A. 1995;92(1):325–9.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  8. Gillespie J, Mayne M, Jiang M. RNA folding on the 3D triangular lattice. BMC Bioinformatics. 2009;10:369.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  9. Su SC, Lin CJ, Ting CK. An effective hybrid of hill climbing and genetic algorithm for 2D triangular protein structure prediction. Proteome Sci. 2011;9(Suppl 1):S19.

    Article  PubMed  PubMed Central  Google Scholar 

  10. Huang C, Yang X, He Z. Protein folding simulations of 2D HP model by the genetic algorithm based on optimal secondary structures. Comput Biol Chem. 2010;34(3):137–42.

    Article  PubMed  CAS  Google Scholar 

  11. Hsieh SY, Lai DW. A new branch and bound method for the protein folding problem under the 2D-HP model. EEE Trans Nanobioscience. 2011;10(2):69–75.

    Article  Google Scholar 

  12. Thachuk C, Shmygelska A, Hoos HH. A replica exchange Monte Carlo algorithm for protein folding in the HP model. BMC Bioinformatics. 2007;8:342.

    Article  PubMed  PubMed Central  Google Scholar 

  13. Liang F, Wong WH. Evolutionary Monte Carlo for protein folding simulations. J Chem Phys. 2001;115(7):3374–80.

    Article  CAS  Google Scholar 

  14. Traykov M, Angelov S, Yanev N. A new heuristic algorithm for protein folding in the HP model. J Comput Biol. 2016;23(8):662–8.

    Article  PubMed  CAS  Google Scholar 

  15. Javidy B, Hatamlou A, Mirjalili S. Ions motion algorithm for solving optimization problems. Appl Soft Comput. 2015;32:72–9.

    Article  Google Scholar 

  16. Zhang Z, Schwartz S, Wagner L, Miller W. A greedy algorithm for aligning DNA sequences. J Comput Biol. 2000;7(1–2):203–14.

    Article  PubMed  CAS  Google Scholar 

  17. Drinkwater B, Charleston MA. Introducing TreeCollapse: a novel greedy algorithm to solve the cophylogeny reconstruction problem. BMC Bioinformatics. 2014;15(Suppl 16):S14.

    Article  PubMed  PubMed Central  Google Scholar 

  18. Kan C, Yip KP, Yang H. Two-phase greedy pursuit algorithm for automatic detection and characterization of transient calcium signaling. IEEE J Biomed Health Inform. 2015;19(2):687–97.

    Article  PubMed  Google Scholar 

  19. Micale G, Pulvirenti A, Giugno R, Ferro A. GASOLINE: a greedy and stochastic algorithm for optimal local multiple alignment of interaction NEtworks. PLoS One. 2014;9(6):e98750.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  20. Santos EE. Effective computational reuse for energy evaluations in protein folding. Int J Artif Intell Tools. 2006;15(5):725–39.

    Article  Google Scholar 

  21. Smith JE. The co-evolution of memetic algorithms for protein structure prediction. In: Hart WE, Smith JE, Krasnogor N, editors. Recent Advances in Memetic Algorithms. Berlin, Heidelberg: Springer Berlin Heidelberg; 2005. p. 105–28.

    Chapter  Google Scholar 

  22. Hoque MT, Chetty M, Dooley LS. A hybrid genetic algorithm for 2D FCC hydrophobic-hydrophilic lattice model to predict protein folding. In: AI 2006: Advances in Artificial Intelligence. Berlin: Springer; 2006. p. 867–76.

  23. Böckenhauer H-J, Dayem Ullah AZM, Kapsokalivas L, Steinhöfel K. A local move set for protein folding in triangular lattice models, vol. 5251. Berlin: Springer; 2008.

    Google Scholar 

  24. Krasnogor N, Blackburne B, Burke EK, Hirst JD. Multimeme algorithms for protein structure prediction. In: International Conference on Parallel Problem Solving from Nature: 2002. Germany: Springer; 2002. p. 769–78.

  25. Merz P, Freisleben B. Greedy and local search heuristics for unconstrained binary quadratic programming. J Heuristics. 2002;8(2):197–213.

    Article  Google Scholar 

  26. Chuang LY, Chang HW, Lin MC, Yang CH. Chaotic particle swarm optimization for detecting SNP-SNP interactions for CXCL12-related genes in breast cancer prevention. Eur J Cancer Prev. 2012;21(4):336–42.

    Article  PubMed  CAS  Google Scholar 

  27. Yang CH, Lin YD, Chuang LY, Chang HW. Double-bottom chaotic map particle swarm optimization based on chi-square test to determine gene-gene interactions. BioMed Res Int 2014;2014:Article ID 172049.

  28. Wang CF, Zhang YH. An improved artificial bee colony algorithm for solving optimization problems. IAENG Int J Comp Sci. 2016;43(3):IJCS_43_3_09.

    Google Scholar 

  29. Brown WM, Thompson AP, Schultz PA. Efficient hybrid evolutionary optimization of interatomic potential models. J Chem Phys. 2010;132(2):024108.

    Article  PubMed  CAS  Google Scholar 

  30. Duan HB, Xu CF, Xing ZH. A hybrid artificial bee colony optimization and quantum evolutionary algorithm for continuous optimization problems. Int J Neural Syst. 2010;20(1):39–50.

    Article  PubMed  Google Scholar 

  31. Gonzalez-Alvarez DL, Vega-Rodriguez MA, Rubio-Largo A. Finding patterns in protein sequences by using a hybrid multiobjective teaching learning based optimization algorithm. IEEE/ACM Trans Comput Biol Bioinform. 2015;12(3):656–66.

    Article  PubMed  CAS  Google Scholar 

  32. Coelho VN, Coelho IM, Souza MJ, Oliveira TA, Cota LP, Haddad MN, Mladenovic N, Silva RC, Guimaraes FG. Hybrid self-adaptive evolution strategies guided by neighborhood structures for combinatorial optimization problems. Evol Comput. 2016;24(4):637–66.

    Article  PubMed  CAS  Google Scholar 

  33. Kennedy J, Eberhart RC. Particle swarm optimization. In: Proceedings IEEE International conference on neural networks: 1995. Perth, Western Australia: IEEE Service Center; 1995. p. 1942–8.

  34. O'Meara MJ, Leaver-Fay A, Tyka MD, Stein A, Houlihan K, DiMaio F, Bradley P, Kortemme T, Baker D, Snoeyink J, et al. Combined covalent-electrostatic model of hydrogen bonding improves structure prediction with Rosetta. J Chem Theory Comput. 2015;11(2):609–22.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  35. S OC, Barlow KA, Pache RA, Ollikainen N, Kundert K, O'Meara MJ, Smith CA, Kortemme T. A web resource for standardized benchmark datasets, metrics, and Rosetta protocols for macromolecular modeling and design. PLoS One. 2015;10(9):e0130433.

    Article  CAS  Google Scholar 

  36. Leaver-Fay A, Tyka M, Lewis SM, Lange OF, Thompson J, Jacak R, Kaufman K, Renfrew PD, Smith CA, Sheffler W, et al. ROSETTA3: an object-oriented software suite for the simulation and design of macromolecules. Methods Enzymol. 2011;487:545–74.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  37. Zhang Y. I-TASSER server for protein 3D structure prediction. BMC Bioinformatics. 2008;9:40.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  38. Yang J, Yan R, Roy A, Xu D, Poisson J, Zhang Y. The I-TASSER suite: protein structure and function prediction. Nat Methods. 2015;12(1):7–8.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  39. Wu S, Zhang Y. LOMETS: a local meta-threading-server for protein structure prediction. Nucleic Acids Res. 2007;35(10):3375–82.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  40. Zhang Y, Skolnick J. SPICKER: a clustering approach to identify near-native protein folds. J Comput Chem. 2004;25(6):865–71.

    Article  PubMed  CAS  Google Scholar 

Download references

Acknowledgements

The authors thank our colleague Dr. Hans-Uwe Dahms for English editing.

Funding

This work was supported by funds of the Ministry of Science and Technology, Taiwan (MOST 102–2221-E-151-024-MY3, MOST 105-2221-E-992-307-MY2, MOST 106-2221-E-992-327-MY2, and MOST 107–2320-B-037-016), the National Sun Yat-sen University-KMU Joint Research Project (#NSYSU-KMU 107-p001), and the Health and welfare surcharge of tobacco products, the Ministry of Health and Welfare, Taiwan, Republic of China (MOHW107-TDU-B-212-114016).

Availability of data and materials

The dataset of amino acids sequences in HP model used in this study was mentioned in Tables 1 and 2 with citing the references [9, 21].

Author information

Authors and Affiliations

Authors

Contributions

L-YC and H-WC conceived and designed the research and wrote the draft manuscript. C-HY instructed K-CW and Y-SL for algorithm processing. C-HY and H-WC revised the manuscript. All authors read and approved the final manuscript.

Corresponding authors

Correspondence to Li-Yeh Chuang or Hsueh-Wei Chang.

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.

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

Yang, CH., Wu, KC., Lin, YS. et al. Protein folding prediction in the HP model using ions motion optimization with a greedy algorithm. BioData Mining 11, 17 (2018). https://doi.org/10.1186/s13040-018-0176-6

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13040-018-0176-6

Keywords