Skip to main content

Spiral search: a hydrophobic-core directed local search for simplified PSP on 3D FCC lattice

Abstract

Background

Protein structure prediction is an important but unsolved problem in biological science. Predicted structures vary much with energy functions and structure-mapping spaces. In our simplified ab initio protein structure prediction methods, we use hydrophobic-polar (HP) energy model for structure evaluation, and 3-dimensional face-centred-cubic lattice for structure mapping. For HP energy model, developing a compact hydrophobic-core (H-core) is essential for the progress of the search. The H-core helps find a stable structure with the lowest possible free energy.

Results

In order to build H-cores, we present a new Spiral Search algorithm based on tabu-guided local search. Our algorithm uses a novel H-core directed guidance heuristic that squeezes the structure around a dynamic hydrophobic-core centre. We applied random walks to break premature H-cores and thus to avoid early convergence. We also used a novel relay-restart technique to handle stagnation.

Conclusions

We have tested our algorithms on a set of benchmark protein sequences. The experimental results show that our spiral search algorithm outperforms the state-of-the-art local search algorithms for simplified protein structure prediction. We also experimentally show the effectiveness of the relay-restart.

Introduction

Proteins are essentially sequences of amino acids. They adopt specific folded three-dimensional structures to perform specific tasks. The function of a given protein is determined by its native structure, which has the lowest possible free energy level. Nevertheless, misfolded proteins cause many critical diseases such as Alzheimer's disease, Parkinson's disease, and Cancer [1, 2]. Protein structures are important in drug design and biotechnology.

PSP problem

Protein structure prediction (PSP) is computationally a very hard problem [3]. Given a protein's amino acid sequence, the problem is to find a three dimensional structure of the protein such that the total interaction energy amongst the amino acids in the sequence is minimised. The protein folding process that leads to such structures involves very complex molecular dynamics [4] and unknown energy factors. To deal with the complexity in a hierarchical way, researchers have used discretised lattice-based structures and simplified energy models [5–7] for PSP. However, the complexity of the simplified problem still remains challenging.

The state-of-the-art approaches

There are a large number of existing search algorithms that attempt to solve the PSP problem by exploring feasible structures called conformations. A memory based local search (LS-Mem) [8] method reportedly produced the best results on face-centred-cubic (FCC) lattice for hydrophobic-polar (HP) energy model. Before LS-Mem, the state-of-the-art results were achieved for similar model by tabu-based local search (LS-Tabu) methods [9, 10]. Besides these, genetic algorithms (GA) [11], and tabu search [12] found promising results on 2D and 3D hexagonal lattice based HP models.

Research issues

In general, the success of single-point and/or population-based search algorithms crucially depends on the balance of diversification and intensification of the exploration. However, these algorithms often get stuck in local minima. As a result, they perform poorly on large sized (> 100 amino acids) proteins. Any further progress to these algorithms requires addressing the above issues appropriately.

Our contributions

In this paper, we present a novel spiral search algorithm for ab initio protein structure prediction using HP energy model on three-dimensional (3D) FCC lattice. By using tabu heuristic, the search approaches towards the optimum solution by spinning around a dynamic hydrophobic-core centre (HCC) like a coil. We call our tabu-based spiral search algorithm SS-Tabu. In SS-Tabu, we consider the diagonal move (corner-flip) (as shown in Figure 1) to build the hydrophobic-core (H-core). We apply random-walk [13] to break the premature H-core. We use a novel relay-restart when the search is trapped in local minima and the random-walk fails to overcome the stagnation. On a set of benchmark proteins, SS-Tabu significantly outperforms the state-of-the-art local search algorithms [8, 9] on similar models.

Figure 1
figure 1

Diagonal move. Depiction of a diagonal move, for easy comprehension, shown in 2D space.

Background

Computational methods for PSP

Homology modeling, protein threading and ab initio are three computational approaches used in protein structure prediction. Prediction quality of homology modeling and protein threading depends on the sequential similarity of previously known protein structures. However, our work is based on the ab initio approach that only depends on the amino acid sequence of the target protein. Levinthal's paradox [14] and Anfensen's hypothesis [15] are the basis of ab initio method for protein structure prediction. The idea was originated in 1970 when it was demonstrated that all information needed to fold a protein resides in its amino acid sequence. In our simplified protein structure prediction model, we use 3D FCC lattice for conformation mapping, HP energy model for conformation evaluation, and a hydrophobic-core centric local search algorithm (SS-Tabu) for conformation search. Local search approach, 3D FCC lattice, and HP energy model are described below.

Local search

Starting from an initial solution, local search algorithms move from one solution to another to find a better solution. Local search algorithms are well known for efficiently producing high quality solutions, which are difficult for systematic search approaches. However, they are incomplete [16], and suffer from revisitation and stagnation. Restarting the whole or parts of a solution remains the typical approach to deal with such situations. In PSP, Cebrian et al. [9] used a local search algorithm combined with tabu heuristic. They implemented their method on 3D FCC lattice configuration for HP model, and tested its effectiveness on Harvard instances [17]. Later, Dotu et al. [10] extended the work in [9] by using a hybrid method that combines local search and constraint programming together. Prior to LS-Mem, these two methods [9, 10] produced the state-of-the-art results for PSP on FCC lattice and HP energy model.

Tabu meta-heuristic

Tabu meta-heuristic [18, 19] enhances the performance of local search algorithms. It maintains a memory structure to remember the local changes of a solution. Then any local changes for those stored positions are forbidden for certain number of subsequent iterations (known as tabu tenure).

3D FCC lattice

The FCC lattice has the highest packing density compared to the other existing lattices [20]. In FCC, each lattice point (the origin in Figure 2) has 12 neighbours with 12 basis vectors (1, 1, 0), (-1, -1, 0), (-1, 1, 0), (1, -1, 0), (0, 1, 1), (0, 1, -1), (1, 0, 1), (1, 0, -1), (0, -1, 1), (-1, 0, 1), (0, -1, -1), and (-1, 0, -1). The hexagonal closed pack (HCP) lattice, also known as cuboctahedron, was used in [11]. In HCP, each lattice point has 12 neighours that correspond to 12 basis vertices with real-numbered coordinates, which causes the loss of structural precision for PSP. In simplified PSP, conformations are mapped on the lattice by a sequence of basis vectors, or by the relative vectors that are relative to the previous basis vectors in the sequence.

Figure 2
figure 2

3D FCC lattice. A unit 3D FCC lattice; the 12 basis vectors are shown on the Cartesian coordinates; the vectors represent the 12 topological neighbours of the origin on the FCC lattice.

HP energy model

The 20 constituent amino acids of proteins are broadly divided into two categories based on the hydrophobicity of the amino acids: (a) hydrophobic amino acids denoted as H (Gly, Ala, Pro, Val, Leu, Ile, Met, Phe, Tyr, Trp); and (b) hydrophilic or polar amino acids denoted as P (Ser, Thr, Cys, Asn, Gln, Lys, His, Arg, Asp, Glu). In the HP model [21, 22], when two non-consecutive hydrophobic amino acids become topologically neighbours, they contribute a certain amount of negative energy, which for simplicity is shown as -1 in Figure 3. The total energy (E) of a conformation based on the HP model becomes the sum of the contributions of all pairs of non-consecutive hydrophobic amino acids as shown in Equation 1.

Figure 3
figure 3

HP model. HP energy model [22].

E = ∑ i < j - 1 c i j ⋅ e i j
(1)

where c ij = 1 if amino acids i and j are non-consecutive neighbours on the lattice, otherwise 0; and e ij = -1 if i th and j th amino acids are hydrophobic, otherwise 0.

Related work

Different types of metaheuristic have been used in solving the simplified PSP problem. These include Monte Carlo Simulation [23], Simulated Annealing [24], Genetic Algorithms (GA) [25, 26], Tabu Search with GA [12], Tabu Search with Hill Climbing [27], Ant Colony Optimisation [28], Immune Algorithms [29], Tabu-based Stochastic Local Search [8, 9], and Constraint Programming [10]. Cebrian et al. [9] used tabu-based local search, and Shatabda et al. [8] used memory-based local search with tabu heuristic and achieved the state-of-the-art results. However, Dotu et al. [10] used constraint programming and found promising results but only for small sized (< 100 amino acids) proteins. Besides local search, Unger and Moult [25] applied genetic algorithms to PSP and found their method to be more promising than the Monte Carlo based methods [23]. They used absolute encodings on the square and cubic lattices for HP energy model. Later, Patton [30] used relative encodings to represent conformations and a penalty method to enforce the self-avoiding walk constraint.

The GA has been used by Hoque et al. [11] for cubic, and 3D HCP lattices. They used Depth First Search (DFS) to generate pathways [31] in GA crossover for PSP. They also introduced a twin-removal operator [32] to remove duplicates from the population and thus to prevent the search from stalling.

Methods

In HP model, protein structures have H-cores that hide the hydrophobic amino acids from water and expose the polar amino acids to the surface to be in contact with the surrounding water molecules [33]. H-core formation is the main objective of HP based PSP. To achieve this, the total distance of all H-H pairs is minimised in [9]. A predefined motif based segment replacement strategy is applied in [11] to replace structure segments by pre-determined substructures based on matching H-P orientations in the target sequence. In SS-Tabu, we try to reduce the distance of each H-amino acid from the HCC; which eventually helps minimise the free energy level of the conformation.

Spiral search framework

In spiral search, only the diagonal move operator is used repeatedly (as shown in Figure 4) in building H-cores. A diagonal move displaces i th amino acid from its position to another position on the lattice without changing the position of its succeeding (i + 1)th and preceding (i - 1)th amino acids in the sequence. The move is just a corner-flip to an unoccupied lattice point. In SS-Tabu, we repeatedly use diagonal moves that squeeze the conformation and quickly form the H-core. The spiral search procedure (see the pseudocode in Figure 5) is composed of several sub-procedures mainly, for move selection, for handling local minima and stagnation, and for initialisation and evaluation.

Figure 4
figure 4

Spiral search. Spiral search comprising a series of diagonal moves. For simplification and easy understanding, the figures are presented in 2-dimensional space.

Figure 5
figure 5

Spiral search algorithm. Spiral Search framework: pseudocode of Procedure SpiralSearch.

Move selection

In move selection, the hydrophobic amino acids get priority in comparison to polar amino acids. The move selection criteria are explained in the following paragraphs.

H-move selection

In H-move selection (see the pseudocode in Figure 6), the HCC is calculated by finding arithmetic means of x, y, and z coordinates of all hydrophobic amino acids using Equation 2. The selection is guided by the Cartesian distance d i (as shown in Equation 3) between HCC and the hydrophobic amino acids in the sequence. For the i th hydrophobic amino acid, the common topological neighbours of the (i - 1)th and (i + 1)th amino acids are computed. The topological neighbours (TN) of a lattice point are the points at unit lattice-distance apart from it. For 3D FCC lattice, there are four common TN of the (i - 1)th and (i + 1)th amino acids. From the common neighbours, the unoccupied points are identified. The Cartesian distance of all unoccupied common neighbours are calculated from the HCC using Equation 3. Then the point with the shortest distance is picked. This point is listed in the possible H-move list for i th hydrophobic amino acid if its current distance from HCC is greater than that of the selected point. When all hydrophobic amino acids are traversed and the feasible shortest distances are listed in H-move list, the amino acid having the shortest distance in H-move list is chosen to apply diagonal move operator on it. A tabu list is maintained for each hydrophobic amino acid to control the selection priority amongst them. For each successful move, the tabu list is updated for the respective amino acid. The process stops when no H-move is found. In this situation, the control is transferred to select and apply P-moves.

Figure 6
figure 6

H-move algorithm. Spiral Search framework: pseudocode of Procedure selectMoveForH.

x hcc = 1 n h ∑ i = 1 n h x i , y hcc = 1 n h ∑ i = 1 n h y i , z hcc = 1 n h ∑ i = 1 n h z i
(2)

where nh is the number of H amino acids in the protein.

d i = ( x i - x hcc ) 2 + ( y i - y hcc ) 2 + z i - z hcc 2
(3)
P-move selection

For polar amino acids, the same kind of diagonal moves are applied as H-move. For each i th polar amino acid, all free lattice points that are common neighbours of lattice points occupied by (i - 1)th and (i + 1)th amino acids are listed. From the list, a point is selected randomly to complete a diagonal move for the respective polar amino acid. No hydrophobic-core center is calculated, no Cartesian distance is measured, and no tabu list is maintained for P-move. After one try for each polar amino acid the control is returned to select and apply H-moves.

Stagnation recovery

For hard optimisation problems such as protein structure prediction, local search algorithms often face stagnation. Thus, handling such situation intelligently is important to proceed further. In our SS-Tabu, we use random-walk [13] and a new relay-restart technique with on-demand basis to deal with stagnation.

Random-walk

Premature H-cores are observed at local minima. To escape local minima, a random-walk [13] algorithm (see the pseudocode in Figure 7) is applied. This algorithm uses pull moves [34] (as shown in Figure 8) to break the H-core. We use pull-moves because they are complete, local, and reversible. Successful pull moves never generate infeasible conformations. During pulling, energy level and structural diversification are observed to maintain a balance among these two. We allow energy level to change within 5% to 10% with changes in the structure from 10% to 75% of the original. We try to accept the conformation that is close to the current conformation in terms of energy level but is diverse in terms of structure.

Figure 7
figure 7

Random-walk algorithm. Spiral Search framework: pseudocode of Procedure randomWalk.

Figure 8
figure 8

Pull move. The pull move operator [34] used in random-walk for collapsing a premature H-core; for easy comprehension, presented in 2D space.

Relay-restart

Instead of using a fresh restart or restarting from the current best solution [8, 9], we use a new relay-restart technique (see the pseudocode in Figure 9) when the search stagnation situation arises. We use relay-restart when random-walk fails to escape from local minima. The relay restart starts from an improving solution. We maintain an improving solution list that contains all the improving solutions after initialisation. When a solution with energy level better than the current global best is found, the solution is added to the top of the list pushing existing solutions back. For relay-restart, a random conformation from the top 10% solutions of the list is selected to start with. The selected solution is then sent back to the bottom of the list to keep it away from the scope of reselection in very near future.

Figure 9
figure 9

Relay-restart algorithm. Spiral Search framework: pseudocode of Procedure relayRestart.

Further implementation details

Like other local search algorithms, our spiral search requires initialisation. It also needs evaluation of the solution in each iteration. Further, it needs to maintain a tabu meta-heuristic to guide the search.

Initialisation

Our algorithm starts with a feasible conformation. We generate an initial conformation following a self-avoiding walk (SAW) on FCC lattice points. The pseudocode of the algorithm is presented in Figure 10. It places the first amino acid at (0, 0, 0). It then randomly selects a basis vector to place the successive amino acid at a neighbouring free lattice point. The mapping proceeds until a self-avoiding walk is found for the whole protein sequence.

Figure 10
figure 10

Initialisation algorithm. Spiral Search framework: pseudocode of Procedure initialise.

Tabu tenure

Intuitively we use different tabu-tenures based on the number of hydrophobic amino acids (hCount) in the sequence. We intuitively calculate tabu-tenure using the formula in Equation 4:

tenure = 10 + hCount 10
(4)
Evaluation

After each iteration, the conformation is evaluated by counting the H-H contacts (topological neighbour) where the two amino acids are non-consecutive. The pseudocode in Figure 11 presents the algorithm of calculating the free energy of a given conformation. Note that energy value is negation of the H-H contact count.

Figure 11
figure 11

Evaluation algorithm. Spiral Search framework: pseudocode of Procedure evaluate.

Results and discussion

In our experiment, the protein instances (as shown in Table 1), F180 and R instances are taken from Peter Clote laboratory website (bioinformatics.bc.edu/clotelab/FCCproteinStructure). Cebrian et al. [9], Dotu et al. [10], and Shatabda et al. [8] used these instances in evaluating their algorithms. We also use six more larger sequences that are taken from the CASP (predictioncenter.org/casp9/targetlist.cgi) competition. The corresponding CASP target IDs for proteins 3mse, 3mr7, 3mqz, 3no6, 3no3, and 3on7 are T0521, T0520, T0525, T0516, T0570, and T0563. These CASP targets are also used in [8]. To fit in the HP model, the CASP targets are converted to HP sequences based on the hydrophobic properties of the constituent amino acids. The lower bounds of the free energy values (in Column LB-FreeE of Table 1) are obtained from [8, 9]; however, there are some unknown values (presented as ?) of lower bounds of free energy for large sequences.

Table 1 Experimental results of LS-Mem, LS-Tabu, and SS-Tabu

In Table 1, the Size column presents the number of amino acids in the sequences, and LB-FreeE column shows the known lower bounds of free energy for the corresponding protein sequences in Column ID. However, lower bound of free energy for protein 3on7 is unknown. The best and average free energy for three different algorithms are also present in the table. The bold-faced values indicate better performance in comparison to the other algorithms for corresponding proteins. The experimental results show that our SS-Tabu wins over LS-Mem and LS-Tabu over the 21 proteins with a significant margin on average search results.

Relative improvement

The difficulty to improve energy level is increased as the predicted energy level approaches to the lower bound. For example, if the lower bound of free energy of a protein is -100, the efforts to improve energy level from -80 to -85 is much less than that to improve energy level from -95 to -100 though the change in energy is the same (-5). Relative Improvement (RI) explains how close our predicted results to the lower bound of free energy with respect to the energy obtained from the state-of-the-art approaches.

In Table 2, we present a comparison of improvements (%) on average conformation quality (in terms of free energy levels). We compare SS-Tabu (target) with LS-Tabu and LS-Mem (references). For each protein, the RI of the target (t) w.r.t. the reference (r) is calculated using the formula in Equation 5, where E t and E r denote the average energy values achieved by target and reference respectively, and E1 is the lower bound of free energy for the protein in the HP model. We present the relative improvements only for the proteins having known lower bound of free energy values. We test our new algorithm on 21 different proteins of various length. The bold-faced values are the minimum and the maximum improvements for the same column.

Table 2 Relative improvement by SS-Tabu w.r.t. LS-Mem and LS-Tabu
RI = E t - E r E 1 - E r * 100 %
(5)

Improvement w.r.t. LS-Mem

The experimental results in Table 2, at column RI (relative improvement) under LS-Mem shows that our SS-Tabu is able to improve the search quality in terms of minimizing the free energy level over all 21 proteins. The relative improvements with respect to LS-Mem range from 12.20% to 37.68%.

Improvement w.r.t. LS-Tabu

The experimental results in Table 2, at column RI under LS-Tabu shows that our SS-Tabu is able to improve the search quality in terms of minimising the free energy level over all 21 proteins. The relative improvements with respect to LS-Tabu range from 21.95% to 75.00%.

Effectiveness of relay-restart

In Table 3, we present another set of experimental results to show the effectiveness of relay-restart in the spiral search framework. The results under the headings Target and Reference are obtained by running SS-Tabu respectively with and without relay-restart. The relative improvements on average search results are presented in the last column of the table. The relative improvements after including relay-restart in our SS-Tabu, are as minimum as 1.39% and as maximum as 23.08%.

Table 3 Effectiveness of relay-restart in SS-Tabu

Simplified structure

In Figure 12, we show the best structures found by SS-Tabu, LS-Mem and LS-Tabu for protein R 1. Each algorithm runs over a period of 5 hours to achieve the results.

Figure 12
figure 12

Structure comparison. The 3D structures of protein R1 obtained by a) LS-Tabu, b) LS-Mem, and c) SS-Tabu.

Search progress

We compare the search progresses of different variants of local search; LS-Tabu, LS-Mem, and SS-Tabu over time. Figure 13 shows the average energy values obtained with times by the algorithms for protein R1. We observe that all of the algorithms achieve very good progress initially, but with time increasing, our spiral search SS-Tabu makes more progress than LS-Tabu and LS-Mem.

Figure 13
figure 13

Search progress. Search progress for protein R1 with time for different approaches. The results are calculated over 50 different runs with identical settings for each algorithm.

Conclusion

In this paper, we present a new spiral search (SS-Tabu) under the local search framework for simplified protein structure prediction on 3D face-centred-cubic lattice. We use a new search guiding heuristic, which is the distance of a hydrophobic amino acid from a dynamic hydrophobic-core centre. We also use a novel relay-restart technique to break the stagnation. We compare our results with two other local search algorithms: LS-Tabu and LS-Mem, which achieved the state-of-the-art results for similar models. We found that our SS-Tabu significantly outperforms both LS-Mem and LS-Tabu. We aim to apply our algorithm in high resolution protein structure prediction in future.

Declarations

NICTA, the sponsor of the article for publication, is funded by the Australian Government as represented by the Department of Broadband, Communications and the Digital Economy and the Australian Research Council through the ICT Centre of Excellence program.

This article has been published as part of BMC Bioinformatics Volume 14 Supplement 2, 2013: Selected articles from the Eleventh Asia Pacific Bioinformatics Conference (APBC 2013): Bioinformatics. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/14/S2.

References

  1. Smith Adam: Protein misfolding. Nature Reviews Drug Discovery. 2003, 426 (6968): 78-102.

    Google Scholar 

  2. Dobso CM: Protein folding and misfolding. Nature. 2003, 426 (6968): 884-890. 10.1038/nature02261.

    Article  Google Scholar 

  3. The Science Editorial: So much more to know. The Science. 2005, 309 (5731): 78-102.

    Google Scholar 

  4. Bonneau R, Baker D: Ab initio protein structure prediction: progress and prospects. Annual Review of Biophysics and Biomolecular Structure. 2001, 30: 173-89. 10.1146/annurev.biophys.30.1.173.

    Article  CAS  PubMed  Google Scholar 

  5. Rohl C, Strauss C, Misura K, Baker D: Protein structure prediction using ROSETTA. Methods in Enzymology. 2004, 383: 66-93.

    Article  CAS  PubMed  Google Scholar 

  6. Lee J, Wu S, Zhang Y: Ab initio protein structure prediction. From Protein Structure to Function with Bioinformatics. 2009, 3-25.

    Chapter  Google Scholar 

  7. Xia Y, Huang ES, Levitt M, Samudrala R: Ab initio construction of protein tertiary structures using a hierarchical approach. Journal of Molecular Biology. 2008

    Google Scholar 

  8. Shatabda S, Newton M, Pham DN, Sattar A: Memorybased local search for simplified protein structure prediction. Proceedings of the ACM Conference on Bioinformatics, Computational Biology and Biomedicine. 2012, ACM, 345-352.

    Chapter  Google Scholar 

  9. Cebrián M, Dotú I, Van Hentenryck P, Clote P: Protein structure prediction on the face centered cubic lattice by local search. Proceedings of the Conference on Artificial Intelligence. 2008, 1: 241-246.

    Google Scholar 

  10. Dotu I, Cebrián M, Van Hentenryck P, Clote P: On lattice protein structure prediction revisited. IEEE Transactions on Computational Biology and Bioinformatics. 2011

    Google Scholar 

  11. Hoque MT, Chetty M, Sattar A: Protein folding prediction in 3D FCC HP lattice model using genetic algorithm. IEEE Transactions on Computational Biology and Bioinformatics. 2007, IEEE Congress on Evolutionary Computation, 2007: 4138-4145.

    Google Scholar 

  12. Böckenhauer HJ, Ullah AZMD, Kapsokalivas L, Steinhöfel K: A local move set for protein folding in triangular lattice models. WABI. 2008, Lecture Notes in Computer Science, Springer, 5251: 369-381.

    Google Scholar 

  13. Rashid MA, Shatabda S, Newton M, Hoque MT, Pham DN, Sattar A: Random-walk: a stagnation recovery technique for simplified protein structure prediction. Proceedings of the ACM Conference on Bioinformatics, Computational Biology and Biomedicine. 2012, ACM, 620-622.

    Chapter  Google Scholar 

  14. Levinthal C: Are there pathways for protein folding?. Journal of Medical Physics. 1968, 65: 44-45.

    Google Scholar 

  15. Anfinsen CB: The principles that govern the folding of protein chains. Science. 1973, 181 (4096): 223-230. 10.1126/science.181.4096.223.

    Article  CAS  PubMed  Google Scholar 

  16. Berger B, Leightont T: Protein folding in the hydrophobic-hydrophilic (HP) model is NP-complete. Journal of Computational Biology. 1998, 5: 27-40. 10.1089/cmb.1998.5.27.

    Article  CAS  PubMed  Google Scholar 

  17. Yue K, Fiebig KM, Thomas PD, Chan HS, Shakhnovich EI, Dill KA: A test of lattice protein folding algorithms. Proceedings of the National Academy of Sciences of the United States of America. 1995, 92: 325-10.1073/pnas.92.1.325.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Glover F, Laguna M: Tabu search. 1998, Kluwer Academic Pub, 1:

    Google Scholar 

  19. Glover F: Tabu search - part I. ORSA Journal on Computing. 1989, 1 (3): 190-206. 10.1287/ijoc.1.3.190.

    Article  Google Scholar 

  20. Hales T: A proof of the kepler conjecture. The Annals of Mathematics. 2005, 162 (3): 1065-1185. 10.4007/annals.2005.162.1065.

    Article  Google Scholar 

  21. Dill KA: Theory for the folding and stability of globular proteins. Biochemistry. 1985, 24 (6): 1501-1509. 10.1021/bi00327a032.

    Article  CAS  PubMed  Google Scholar 

  22. Lau KF, Dill KA: A lattice statistical mechanics model of the conformational and sequence spaces of proteins. Macromolecules. 1989, 22 (10): 3986-3997. 10.1021/ma00200a030.

    Article  CAS  Google Scholar 

  23. Thachuk C, Shmygelska A, Hoos HH: A replica exchange monte carlo algorithm for protein folding in the HP model. BMC Bioinformatics. 2007, 8: 342-10.1186/1471-2105-8-342.

    Article  PubMed Central  PubMed  Google Scholar 

  24. Tantar AA, Melab N, Talbi EG: A grid-based genetic algorithm combined with an adaptive simulated annealing for protein structure prediction. Soft Computing - A Fusion of Foundations, Methodologies and Applications. 2008

    Google Scholar 

  25. Unger R, Moult J: A genetic algorithm for 3D protein folding simulations. Soft Computing - A Fusion of Foundations, Methodologies and Applications. 1993, Morgan Kaufmann Publishers, The 5th International Conference on Genetic Algorithms, 581-

    Google Scholar 

  26. Hoque MT: Genetic algorithm for ab initio protein structure prediction based on low resolution models. PhD thesis. 2007, Gippsland School of Information Technology, Monash University, Australia

    Google Scholar 

  27. Klau GW, Lesh N, Marks J, Mitzenmacher M: Humanguided tabu search. Proceedings of the Conference on Artificial Intelligence. 2002

    Google Scholar 

  28. Blum C: Ant colony optimization: introduction and recent trends. Physics of Life Reviews. 2005, 2 (4): 353-373. 10.1016/j.plrev.2005.10.001.

    Article  Google Scholar 

  29. Cutello V, Nicosia G, Pavone M, Timmis J: An immune algorithm for protein structure prediction on lattice models. IEEE Transaction on Evolutionary Computing. 2007, 11: 101-117.

    Article  Google Scholar 

  30. Patton AL, Punch WF III, Goodman ED: A standard GA approach to native protein conformation prediction. IEEE Transaction on Evolutionary Computing. 1995, International Conference on Genetic Algorithms

    Google Scholar 

  31. Hoque MT, Chetty M, Lewis A, Sattar A, Avery VM: DFS-generated pathways in GA crossover for protein structure prediction. Neurocomputing. 2010, 73 (13-15): 2308-2316. 10.1016/j.neucom.2010.02.021.

    Article  Google Scholar 

  32. Hoque MT, Chetty M, Lewis A, Sattar A: Twin removal in genetic algorithms for protein structure prediction using low-resolutionmodel. IEEE Transactions on Computational Biology and Bioinformatics. 2011, 8: 234-245.

    Article  PubMed  Google Scholar 

  33. Yue K, Dill KA: Sequence-structure relationships in proteins and copolymers. Phys Rev E Stat Phys Plasmas Fluids Relat Interdiscip Topics. 1993, 48 (3): 2267-2278. 10.1103/PhysRevE.48.2267.

    CAS  PubMed  Google Scholar 

  34. Lesh N, Mitzenmacher M, Whitesides S: A complete and effective move set for simplified protein folding. Research in Computational Molecular Biology (RECOMB). 2003, 188-195.

    Google Scholar 

Download references

Acknowledgements

We would like to express our great appreciation to the people managing the Cluster Computing Services at National ICT Australia (NICTA) and Griffith university. They helped a lot in preparing this article on time by taking care of our submitted jobs in clusters.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Mahmood A Rashid.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

MAR conceived the idea of Spiral Search algorithm. MAHN, MTH, SS, DNP, and AS helped MAR modeling, implementing, and testing the algorithm. All authors equally participated in analysing the test results to improve the algorithm and were significantly involved in the process of writing and reviewing the manuscript. SS also provided experimental data from his memory based local search (LS-Mem).

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Rashid, M.A., Newton, M.H., Hoque, M.T. et al. Spiral search: a hydrophobic-core directed local search for simplified PSP on 3D FCC lattice. BMC Bioinformatics 14 (Suppl 2), S16 (2013). https://doi.org/10.1186/1471-2105-14-S2-S16

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-S2-S16

Keywords