Next Article in Journal
A New and Efficient Synthesis of 6-O-Methylscutellarein, the Major Metabolite of the Natural Medicine Scutellarin
Next Article in Special Issue
Computational Studies of Benzoxazinone Derivatives as Antiviral Agents against Herpes Virus Type 1 Protease
Previous Article in Journal
Isolation of an Angiotensin I-Converting Enzyme Inhibitory Protein with Antihypertensive Effect in Spontaneously Hypertensive Rats from the Edible Wild Mushroom Leucopaxillus tricolor
Previous Article in Special Issue
DockBench: An Integrated Informatic Platform Bridging the Gap between the Robust Validation of Docking Protocols and Virtual Screening Simulations
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Solving Molecular Docking Problems with Multi-Objective Metaheuristics

Khaos Research Group, Departament of Computer Sciences, University of Málaga (UMA), ETSI Informática, Campus de Teatinos, Málaga 29071, Spain
*
Author to whom correspondence should be addressed.
Molecules 2015, 20(6), 10154-10183; https://doi.org/10.3390/molecules200610154
Submission received: 30 March 2015 / Accepted: 21 May 2015 / Published: 2 June 2015
(This article belongs to the Special Issue Molecular Docking in Drug Design)

Abstract

:
Molecular docking is a hard optimization problem that has been tackled in the past with metaheuristics, demonstrating new and challenging results when looking for one objective: the minimum binding energy. However, only a few papers can be found in the literature that deal with this problem by means of a multi-objective approach, and no experimental comparisons have been made in order to clarify which of them has the best overall performance. In this paper, we use and compare, for the first time, a set of representative multi-objective optimization algorithms applied to solve complex molecular docking problems. The approach followed is focused on optimizing the intermolecular and intramolecular energies as two main objectives to minimize. Specifically, these algorithms are: two variants of the non-dominated sorting genetic algorithm II (NSGA-II), speed modulation multi-objective particle swarm optimization (SMPSO), third evolution step of generalized differential evolution (GDE3), multi-objective evolutionary algorithm based on decomposition (MOEA/D) and S-metric evolutionary multi-objective optimization (SMS-EMOA). We assess the performance of the algorithms by applying quality indicators intended to measure convergence and the diversity of the generated Pareto front approximations. We carry out a comparison with another reference mono-objective algorithm in the problem domain (Lamarckian genetic algorithm (LGA) provided by the AutoDock tool). Furthermore, the ligand binding site and molecular interactions of computed solutions are analyzed, showing promising results for the multi-objective approaches. In addition, a case study of application for aeroplysinin-1 is performed, showing the effectiveness of our multi-objective approach in drug discovery.

Graphical Abstract

1. Introduction

Molecular docking is a hard optimization problem, which consists of predicting the orientation of a small molecule (ligand) to a receptor (macromolecule) when they are bound to each other to form an energetically-stable complex. The main goal is to find an optimal conformation between the ligand and receptor with a minimum binding energy, which is evaluated by an energy function. This problem has been tackled in the past with metaheuristics and other nature-inspired computational methods, demonstrating new and challenging results when looking for the minimum binding energy [1]. However, only a few papers can be found in the literature that deal with this problem by means of multi-objective approaches. The first attempt was carried out in 2006 by Oduguwa et al. [2], in which three evolutionary multi-objective optimization algorithms (non-dominated sorting genetic algorithm II (NSGA-II), the Pareto Archived Evolution Strategy algorithm (PAES) and the Strength Pareto Evolutionary algorithm (SPEA)) were evaluated on three molecular complexes. Grosdidier et al. [3] proposed a new hybrid evolutionary algorithm for docking (EADock), which was interfaced with the CHARMM package. In 2008, Janson et al. [4] designed a parallel multi-objective optimization algorithm based on PSO (Particle Swarm Optimization) using AutoDock energy function Version 3.05, called ClustMPSO, that used K-means to guide the migration strategy when dealing with six molecular complexes. Furthermore, in 2008, Boisson et al. [5] implemented a parallel evolutionary bi-objective model using ParadisEO platform and GOLD docking software for the docking of six instances. Recently, Sandoval-Perez et al. [6] used the implementation of NSGA-II provided by the jMetal framework [7] to optimize bound and non-bound energy terms as objectives applied to four docking instances. These publications, although proposing different approaches, performed only limited comparisons with other current multi-/single-objective techniques. Furthermore, a low number of molecular instances were used in these studies, and their complexities were also moderate in terms of flexibility. In the area of ligand design, there have been several studies that apply the multi-objective approach. Sanchez-Faddeev et al. [8] proposed a bi-objective optimization approach using the S-metric evolutionary multi-objective optimization (SMS-EMOA) to solve the problem of finding a peptide ligand. The results obtained show the possibility to design a peptide ligand of the γ1 isoform of the 14-3-3 protein with predicted selectivity over the ɛ1 isoform. Van der Horst et al. [9] used the multi-objective evolutionary algorithm (MOEA) for a de novo ligand design applied to the new adenosine receptor antagonists. The selection of the candidate A1 adenosine receptor antagonists was based on multiple criteria and several objectives, such as the high predicted affinity and the selectivity of the ligands for the receptors, and properties, like the ADMET (Absorption, Distribution, Metabolism, Elimination and Toxicity) score.
In this paper, our motivation is to compare and analyze the performance of six multi-objective metaheuristics when solving flexible molecular docking complexes. These algorithms are: the non-dominated sorting genetic algorithm II (NSGA-II) [10] and its steady-state version (ssNSGA-II) [11], speed modulation multi-objective particle swarm optimization (SMPSO) [12], third evolution step of generalized differential evolution (GDE3) [13], multi-objective evolutionary algorithm based on decomposition (MOEA/D) [14] and S-metric evolutionary multi-objective optimization (SMS-EMOA) [15]. We have selected these algorithms as they constitute a varied set of modern multi-objective techniques in the state-of-the-art, performing different learning procedures and, therefore, inducing different behaviors in terms of convergence, diversity and scalability. These algorithms have been shown to obtain successful performances on a wide variety of optimization problems [16,17]; however, they have not been previously used to solve the molecular docking problem, with the exception of the NSGA-II algorithm [6]. The application of these algorithms constitutes an additional contribution of this study. We use the implementation of these algorithms provided by jMetalCpp [18], the C++ version of the jMetal framework [7], to carry out a rigorous experimental study.
In order to assess the performance of these algorithms, we have used a benchmark of 11 complexes based on the HIV-protease receptors and ligands with different ligand sizes. This benchmark is a set of complexes used by [19] to prove that the energy function of AutoDock Version 4.2 allows one to perform docking simulations with flexible portions of the receptor. According to this, it is worth noting that it has been reported that the use of rigid macromolecules in docking simulations leads to inaccurate ligand binding estimations [20]. Therefore, we have opted to work with flexible macromolecule docking instances, instead of using rigid macromolecule instances, as is usually the case in the current literature [4,5]. The optimization approach followed in this study was proposed in [4], which has been focused on minimizing two contradictory objectives: intermolecular (Einter) and intramolecular energies (Eintra). Moreover, the AutoDock energy function Version 4.2.3 [21] has been used in this study to evaluate the new solutions generated by the multi-objective solvers.
The resulting optimization strategy consists of a software package that integrates AutoDock + jMetal [18], in such a way that the algorithms available in jMetal can be used to optimize the energy function of AutoDock. The experimentation methodology performed in this paper consists of preparing the instances of the problem to be docked and computing a pre-fixed number of function evaluations. The results obtained have been statistically compared by considering two different quality indicators to measure the convergence and diversity of the obtained Pareto front approximations. Additionally, a comparison with the mono-objective approach has been performed, using as a base algorithm the Lamarckian genetic algorithm (LGA) [1], commonly used in AutoDock studies. Following this line of this comparison, an analysis of the ligand binding sites and the molecular interactions of two instances has been carried out with regard to the crystallographic structure.
The remainder of this study is organized as follows. Section 2 describes the molecular docking problem from a multi-objective formulation. A review of the metrics and algorithms studied is provided in Section 3. Section 4 describes the results obtained and the molecular docking analyses. Section 5 reports the experimentation methodology. Section 6 contains concluding remarks and future work.

2. Multi-Objective Molecular Docking

Before introducing the optimization strategy followed for molecular docking, a series of background concepts regarding the multi-objective optimization are formally defined in this section.

2.1. Multi-Objective Optimization

In current practice, many academic and industrial optimization problems need to address the resolution of a task where two or more objective functions are to be optimized, these all being equally important. A formal definition of a multi-objective optimization problem (MOP) is provided in the following formulation (Definition 1). Without loss of generality, we assume that minimization is the goal for all the objectives.

Definition 1 (MOP)

Find a vector x * = [ x 1 * , x 2 * , , x n * ] that satisfies the m inequality constraints gi (x⃗) ≥ 0, i = 1, 2, . . . ,m, the p equality constraints hi (x⃗) = 0, i = 1, 2, . . . , p and minimizes the vector function f⃗ (x⃗) = [f1(x⃗), f2(x⃗), . . . , fk(x⃗)]T, where x⃗ = [x1, x2, . . . , xn]T is the vector of decision variables.
The set of all values satisfying the constraints defines the feasible region Ω, and any point x⃗ ∈ Ω is a feasible solution. We seek the Pareto optima. More formally:

Definition 2 (Pareto optimality).

A point x⃗* ∈ Ω is Pareto optimal if for every x⃗ ∈ Ω and I = {1, 2, . . . , k}, eitheri∈I (fi (x⃗) = fi(x⃗*)) or there is at least one iI, such that fi (x⃗) > fi (x⃗*).
This definition states that x⃗* is Pareto optimal if no other feasible vector x⃗ exists that would improve some criteria without causing a simultaneous worsening of at least one other criterion. Other important nomenclature associated with Pareto optimality is defined below:

Definition 3 (Pareto dominance).

A vector u⃗ = (u1, . . . , uk) is said to dominate v⃗ = (v1, . . . , vk) (denoted by u⃗v⃗) if and only if u⃗ is partially less than v⃗, i.e.,i ∈ {1, . . . , k} , uivi ∧ ∃i ∈ {1, . . . , k} : ui < vi.

Definition 4 (Pareto optimal set).

For a given MOP f⃗(x⃗), the Pareto optimal set is defined as* = {x⃗ ∈ Ω|¬∃x⃗′ ∈ Ω, f⃗(x⃗′) ≼ f⃗(x⃗)}.

Definition 5 (Pareto front).

For a given MOP f⃗(x⃗) and its Pareto optimal set*, the Pareto front is defined as* = {f⃗(x⃗), x⃗ ∈ ℘*}.
Obtaining the Pareto front of a MOP is the main goal of multi-objective optimization. In theory, a Pareto front could contain a large number (or even infinitely many) points. In practice, a usable approximate solution will only contain a limited number of them; thus, an important goal is that they should be as close as possible to the exact Pareto front (convergence) and uniformly spread (diversity); otherwise, they would not be very useful to the decision maker. Closeness to the Pareto front ensures that we are dealing with optimal solutions, while a uniform spread of the solutions means that we have made a good exploration of the search space and no regions are left unexplored.
The use of Pareto optimality-based techniques means dealing with a set of non-dominated solutions, which requires some specific mechanisms to handle them. Additionally, this set must be diverse enough to cover the whole front. Although depending on the algorithm, there are many different issues to deal with: fitness function, diversity management and constraint handling mechanisms. During the iteration of any metaheuristic algorithm, there always exists a phase in which all of the solutions must be sorted to pick one (or more) of them. Examples of these phases are the selection and replacement mechanisms in EAs. In single-objective optimization, the fitness is a single (scalar) value, and thus, the sorting is done according to it. However, in the multi-objective domain, the fitness consists of a vector of values (one value per objective function), and as a consequence, the sorting is not straightforward.

2.2. Molecular Docking Optimization Strategy

In a multi-objective optimization problem, it is necessary to define two spaces: the decision and the objective spaces. The decision space involves all sets of solutions, and the objective space includes the fitness (scoring) values of the objectives to be optimized.
The main objective in the molecular docking problem is to find an optimized conformation between the ligand (L) and the receptor (R) that results in a minimum energy that binds to a particular protein of interest. A formal definition of the molecular docking problem is as follows [22]:

Definition 6 (Docking optimization).

Let A and B be the ligand and protein molecule, respectively. Let f be a scoring (energy) function that ranks solutions with regards to binding energy, and let C be the conformational (decision) search space of all possible conformations (docking solutions) between A and B. Then, the docking problem is an optimization problem aimed at finding a x⃗C satisfying f(x⃗) ≤ f(y⃗)∀y⃗C (minimization).
Despite great efforts in computational algorithmics, molecular docking remains a challenging problem generally considered to be NP-Hard (although, no formal proof exists, to the best of our knowledge) [22]. Therefore, to deal with a docking flexibility search space in an efficient manner, modern search techniques, such as metaheuristics, are highly recommendable. In this study, our aim is also to take advantage of the specific learning procedure induced by multi-objective (metaheuristics) approaches to tackle molecular docking.

Decision space

The interaction between ligand and receptor can be described by an energy function calculated through three components representing degrees of freedom: (1) the translation of the ligand molecule, involving the three axis values (x, y, z) in Cartesian coordinate space; (2) the ligand orientation, modeled as a four-variable quaternion, including the angle slope (ω); and (3) the flexibilities, represented by the free rotation of torsion (dihedral angles) of the ligand and side chains of the receptor. Therefore, each problem solution for AutoDock and jMetal (the tools we have used) is encoded by a real-value vector of 7 + n variables (illustrated in Figure 1), in which the first three values correspond to the ligand translation, the next four values correspond to the ligand and/or macromolecule orientation and the remaining n values are the ligand torsion dihedral angles. Nevertheless, in order to reduce the computational cost, a grid-based methodology has been implemented where the protein active site is embedded in a 3D rectangular grid, and at each point of the grid, the electrostatic interaction energy and the Van der Waals terms for each ligand atom type are pre-computed and stored, taking into account all of the protein atoms [23]. In this way, the protein contribution at any given point is obtained by tri-linear interpolation in each grid cell. This interpolation leads to a range of translation variables (x, y, z) of a 120-grid spacing point dimension. The values of these variables are delimited between the range of the coordinates of the grid space that has been set for each problem. In the case of orientation (quaternion) and torsion variables, they are measured in radians and encoded in the range of [−π, π].

Objective space

From a mono-objective optimization perspective, the objective to be optimized is the free energy of binding, which is calculated as shown in Equation (1). However, this goal can be formulated as a bi-objective optimization problem by taking into account the Einter and Eintra, respectively. These energy terms are given by the AutoDock energy function [19] (see Equation (1)), being opposite from each other [4] and, therefore, giving rise to a multi-objective approach of this problem as follows:
  • Objective 1: the Eintra energy (Equation (2)) of the ligand and receptor is estimated by the difference between the bound and unbound states of the ligand and receptor.
  • Objective 2: the Einter energy (Equation (3)) is estimated by the difference of the bound and unbound states of the ligand-macromolecule complex.
    Δ G = E i n t r a + E i n t e r + Δ S c o n f
    E i n t r a = ( Q b o u n d L - L - Q u n b o u n d L - L ) + ( Q b o u n d R - R - Q u n b o u n d R - R )
    E i n t e r = ( Q b o u n d R - L - Q u n b o u n d R - L )
Each pair of energetic evaluation terms in Einter and Eintra includes evaluations (Q) of dispersion/repulsion forces (vdw), hydrogen bonds (hbond), electrostatics (elec) and desolvation (sol). Weights Wvdw, Whbond, Wconf, Welec and Wsol of Equation (4) are constants for Van der Waals, hydrogen bonds, torsional forces, electrostatic interactions and desolvation, respectively. rij represents the interatomic distance; Aij and Bij in the first term are Lennard–Jones parameters taken from the Amber force field. Similarly, Cij and Dij in the second term are Lennard–Jones parameters for the maximum well depth of potential energies between two atoms, and E(t) represents the angle-dependent directionality. The third term uses a Coulomb approach for electrostatics. Finally, the fourth term is calculated from the volume (V ) of the atoms that are surrounding a given atom weighted by S and an exponential term, which involves atom distances. An extended explanation of all of these variables can be found in [19].
Q = W v d w i , j ( A i j r i j 12 - B i j r i j 6 ) + W h b o n d i , j E ( t ) ( C i j r i j 12 - D i j r i j 10 ) + W e l e c i , j q i q j ɛ ( r i j ) r i j + W s o l i , j ( S i V j + S j V i ) e ( - r i j 2 / 2 σ 2 )

3. Metrics and Algorithms

Once the optimal docking problem has been defined, this section provides a summarized description of selected multi-objective approaches for this study. Before, the scoring metrics used to evaluate these algorithms are included.

3.1. Metrics

Contrary to single/mono-objective optimization, where assessing the performance of a metaheuristic mainly requires observing the best value yielded by an algorithm (i.e., the lower the better, in the case of minimization), in multi-objective optimization, this is not applicable. Instead, an approximation set to the optimal Pareto front of the problem is computed. Two properties are usually required: convergence and a uniform diversity. A number of quality indicators for measuring these two criteria have been proposed in the literature [17].
In this work, we have concentrated on two quality indicators: the hyper-volume (IHV ) and unary additive epsilon indicators (Iɛ+) [17]. The first indicator takes into account both convergence and diversity, whereas the second one (Iɛ+) is used more to validate the convergence behavior.
  • IHV : This indicator calculates the n-dimensional space covered by members of a non-dominated set of solutions Q, e.g., the region enclosed by the discontinuous line in Figure 2, Q = {A,B,C}, for problems where all objectives are to be minimized. Mathematically, for each solution iQ, a hypercube vi is constructed with a reference point W and the solution i as the diagonal corners of the hypercube. The reference point can simply be found by constructing a vector of worst objective function values. Thereafter, a union of all hypercubes is found, and its hyper-volume (IHV ) is calculated:
    I H V = volume  ( i = 1 Q v i )
    Solution fronts with larger values of IHV are desirable.
  • Iɛ+: Given a computed front for a problem, A, this indicator is a measure of the smallest distance one would need to translate every solution in A, so that it dominates the optimal Pareto front of this problem. More formally, given z 1 = ( z 1 1 , , z n 1 ) and z 2 = ( z 1 2 , , z n 2 ), where n is the number of objectives:
    I ɛ + 1 ( A ) = i n f ɛ { z 2 P F * z 1 A : z 1 ɛ z 2 }
    where z 1 ɛ z 2 if and only if 1 i n : z i 1 < ɛ + z i 2. In this case, solution fronts with lower values of Iɛ+ are desirable.

3.2. Algorithms

We have selected these six algorithms, which are representative of the state-of-the-art in the multi-objective optimization field. These techniques consists of: the most widely-used MO algorithm in the field (NSGA-II) [10], a steady-state variant of it (ssNSGA-II) [11], a swarm intelligence-based approach (SMPSO) [12], a solver based in differential evolution (GDE3) [13], an algorithm representative of decomposition-based techniques (MOEA/D) [14] and an algorithm representing indicator-based metaheuristics (SMS-EMOA) [15]. A brief description of these techniques is given next:
  • NSGA-II: NSGA-II [10] is the most widely-used multi-objective optimization algorithm. It is a genetic algorithm based on obtaining a new individual from the original population by applying the typical genetic operators (selection, crossover and mutation). A ranking procedure is applied to promote convergence, while a density estimator (the crowding distance) is used to enhance the diversity of the set of found solutions.
  • ssNSGA-II: The steady-state version of the NSGA-II was presented in [11]. This study showed that ssNSGA-II outperformed NSGA-II in a set of benchmark problems, although at the cost of increasing the running time with respect to the original algorithm.
  • SMPSO: SMPSO [12] is a multi-objective particle swarm optimization algorithm whose main characteristic is the use of a strategy to limit the velocity of the particles, in order to allow new effective particle positions to be produced in those cases where the velocity becomes too high. Furthermore, SMPSO includes the polynomial mutation as the turbulence factor and an external archive that stores the non-dominated solutions found during the search.
  • GDE3: The generalized differential evolution (GDE) algorithm [13] is based on NSGA-II, but the crossover and mutation variation operators are changed to use the differential evolution operator; concretely, it uses the rand/1/bin variant. Another difference is that GDE3 modifies the crowding distance of NSGA-II to generate a better distributed set of solutions.
  • MOEA/D: MOEA/D [14] is based on decomposing a multi-objective optimization problem into a number of scalar optimization subproblems, which are optimized simultaneously, only using information from their neighboring subproblems. We have used the variant MOEA/D-DE [24], which applies differential evolution instead of the genetic crossover and mutation operators used in the original algorithm. This algorithm also applies a mutation operator to the solutions.
  • SMS-EMOA: When comparing the results of evolutionary multi-objective optimization algorithms (EMOA), the hyper-volume measure quality (also called the S-metric) can be applied. The S-metric selection steady-state EMOA [15] uses a selection operator based on the hyper-volume measure combined with the concept of non-dominated sorting. Its main feature lies in making its population evolve to a well-distributed set of solutions, in order to focus on interesting regions of the Pareto front, at the cost of the high computing time of computing the hyper-volume. To cope with this issue, we have incorporated the WFG hyper-volume [25] into SMS-EMOA, which is very efficient in the case of bi-objective problems, as the one we are solving. In this approach, the reference point to measure the hyper-volume contribution is based on adding a constant offset to the maximum value of each objective.

4. Results and Discussion

In this section, a series of analyses in terms of algorithmic performance comparisons, mono/multi-objective approaches, ligand binding site and molecular interactions are reported. Furthermore, an actual case study based on aeroplysinin-1 compounds for a drug design application is described.

4.1. Performance Comparisons

Table 1 shows the median and interquartile range of the computed solutions for IHV and Iɛ+ quality indicators for the set of 11 docking instances and the six algorithms being compared: NSGA-II, ssNSGA-II, SMPSO, GDE3, MOEA/D and SMS-EMOA. In the case of IHV, the higher the median value, the better the result, whereas for Iɛ+, the lower the numerical values, the higher the quality of solutions.
The hyper-volume is a quality indicator that takes into account both convergence and diversity. According to the reported results, SMPSO achieves the best IHV values in seven out of the eleven considered problems; GDE3 is the second best performing technique. The Iɛ+ provides a measure of convergence, and the figures in Table 1 confirm SMPSO as the metaheuristic providing the best overall performance.
In order to present these results with statistical confidence (in this study, α = 0.05), a series of non-parametric statistical tests have been applied (in several cases, the distributions of the results did not follow the conditions of normality and homoscedasticity [26]). Therefore, the analyses and comparisons focus on the entire distribution of each of the two metrics studied. Specifically, Friedman’s ranking and Holm’s post hoc multi-comparison tests [26] have been applied in order to know which algorithms are statistically worse than the control one (the algorithm with the best ranking). This combination of Friedman’s ranking and post hoc Holm’s test has been shown to offer a well-balanced statistical framework, mostly on non-parametric distribution results [2628]. Friedman’s test establishes a first ranking of algorithms in order to choose a control sample (best ranked algorithm), which is used in Holm’s post hoc test for multi-comparison. This statistical framework has been recommended in the specialized literature [2628], as it is well adapted to compare stochastic based methods, such as metaheuristics. In this regard, as shown in Table 2, GDE3 reaches the best ranking value (Friedman) with 1.81 for the HV indicator, followed by SMPSO, MOEA/D, SMS-EMOA, NSGA-II and ssNSGA-II. Therefore, GDE3 is established as the control algorithm for HV in the post hoc Holm test, which is compared with the remaining algorithms. The adjusted p-values (HolmAp in Table 2) resulting from these comparisons are, for the last three algorithms (SMS-EMOA, NSGA-II and ssNSGA-II), lower than the confidence level, meaning that GDE3 is statistically better than these algorithms. In the case of Iɛ+, SMPSO is better ranked than MOEA/D and GDE3, although without statistical differences in these cases. SMPSO is statistically better than NSGA-II, SMS-EMOA and ssNSGA-II.
Broadly, summing up all ranking positions (as shown in the right-hand column of Table 2), we can observe that SMPSO shows the overall best balance for the two quality indicators. In addition, this algorithm obtained statistically better results than NSGA-II, SMS-EMOA and ssNSGA-II. GDE3 obtained the second best performance, followed by MOEA/D.
These results are graphically supported by two examples included in Figure 3, where the fronts having the highest hyper-volume values obtained by SMPSO, GDE3 and MOEA/D for instances 1BV9 and 1D4K are plotted against the reference front (RF black curve). In this figure, it is easily observable that SMPSO always obtains solutions in regions of the reference front where GDE3 and MOEA/D do not converge. These last two algorithms show a good spread of solutions in their Pareto front approximations, but with a limited convergence to only one region of the reference front. An interesting observation in this sense is that, for all studied molecular instances, SMPSO converges to the region biased towards the Einter objective (left-hand side of reference front), whereas GDE3 and MOEA/D generate their fronts of non-dominated solutions in a different region to the ones of SMPSO, therefore focused in this case on the intramolecular energy optimization (right-hand side of reference front).
We can state that the specific learning procedures induced by SMPSO and GDE3 lead these algorithms to search in different regions of the problem landscape, hence generating solutions in complementary parts of the reference front.

4.2. Comparison with a Mono-Objective Approach

To analyze the benefit of using the multi-objective formulation of the molecular docking from the decision-maker’s (i.e., a biologist) point of view, we have also solved the problem instances with the mono-objective LGA technique provided by AutoDock 4.2. In order to allow comparisons, we have used Equation (1) to recalculate the mono-objective fitness values of the Pareto front approximations yielded by SMPSO.
Table 3 shows a mono-objective comparison of the best solutions obtained (out of 30 independent runs) from both the SMPSO algorithm and the LGA for all of the instances. In general, we can observe that SMPSO outperforms LGA for almost all problem instances, but for 1HTF and 1HTG, although showing close binding energies in these cases. These results can be explained by the small size of the ligand in the case of the 1HTF complex. As was reported in [19,29], the experiments that involve small ligands and flexibility in the ARG-8 side chains of the macromolecule increase the size of the conformational space. This can explain the final binding energy results obtained by the SMPSO in comparison with the LGA algorithm. In the case of the 1HTG complex, this instance includes a larger HIV-protease inhibitor. Despite there being a difference between the results obtained by the SMPSO and the LGA algorithm, the difference of the final binding energy values obtained is smaller than the rest of the instances (except 1HTF). These results obtained can be explained due to the stochastic component of the algorithms used. Furthermore, it is worth mentioning that the 1HTG computed ligand conformation returned by the SMPSO is bound to the active site. Therefore, we have to note that even using the mono-objective formulation (as done in AutoDock), the multi-objective general purpose approach by SMPSO is able to provide experts with more optimized solutions than LGA, this last technique being specifically designed for the molecular docking problem.
Figure 4 shows the front that has the highest hyper-volume value obtained by SMPSO for the instance 1AJV. This instance involves a cyclic urea inhibitor and an HIV-protease macromolecule, a complex problem given the ligand features. The best LGA solution is presented as a point with a dashed vertical line, this solution being the sum of the Einter and Eintra resulting from the LGA algorithm. The front solutions to the left of the dashed vertical dominate the best LGA solution, while those to the right side have better energy values in the Eintra objective. In this regard, the selection of one energy or another depends on the biology expert. For example, the biologist can be interested in either a solution with a smaller Eintra and a more stable inhibitor conformation or a solution with a smaller Einter and a more stable ligand-macromolecule complex. Therefore, considering the mono-objective fitness function, the solutions obtained from the SMPSO generally show a more stable docking conformation than the ones of LGA.
In Figure 4, the inhibitor docked to the HIV-protease macromolecule of the instance 1AJV is also observable. The ligand-macromolecule complexes of this figure show the inhibitor conformation resulting from the SMPSO solution and the inhibitor conformation from LGA. The first complex is energetically more stable than the second one given the energy results obtained; the binding energy for the first one corresponds to −11.57 kcal/mol and the second one to −7.26 kcal/mol. Both inhibitors are docked to the active site of the HIV-protease macromolecule, but the SMPSO inhibitor conformation has a better docking position.

4.3. Analysis on Ligand Binding Site and Molecular Interactions

In addition to the analysis done in the previous subsection, we have carried out a new comparison of the SMPSO and LGA algorithms, but in terms of the resulting RMSD (Å) values. For this purpose, we have focused on instances 1DK4 and 1BV9 in this analysis, in order to extend our previous analyses concerning reference fronts in Figure 3. Figure 5 shows the reference fronts generated from all non-dominated solutions obtained through 30 runs of the SMPSO algorithm for instances 1DK4 and 1BV9. The colored vertical bars depict the RMSD values obtained for each solution. These RMSDs were calculated according to the average distance of the atomic coordinates between computed and reference ligands. As shown in this figure, the bars that represent better RMSD results (lower distance between computed and reference ligands) are darker than those bars that depict worse RMSD results. According to the solutions that are shown in Figure 5 for instances 1BV9 and 1D4K, the results with worse RMSD values correspond to solutions with higher Einter and lower Eintra. In contrast, those solutions with better RMSD show lower Einter and higher Eintra values.
In order to perform an analysis based on the ligand binding site of the 1DK4 and 1BV9 instances and the molecular interactions, we have selected a solution for each instance from the non-dominated solution fronts of Figure 5. The criteria followed in choosing these two solutions was achieving a balance between the RMSDs, the Einter and Eintra. For the LGA algorithm, we have selected the two best solutions for 1D4K and 1BV9, obtained in terms of the binding energy. The ligand conformations from the SMPSO and LGA algorithms and the reference ligand are compared in Figures 6 and 7.
In Figure 6, image (A) shows the best energy solution (the ligand in green) obtained by the LGA algorithm for instance 1D4K and the reference ligand (in orange). Image (B) shows the solution selected from the non-dominated solution fronts and the reference ligand. As shown, the inhibitor in (B) has a better conformation than in (A) given that the ligand conformation obtained by the SMPSO is closer to the tunnel-shaped active site of the HIV-protease receptor, this portion being very similar to the reference ligand. The RMSD scores of the ligand conformations by the LGA and SMPSO algorithms are 6.03 Å and 0.79 Å, respectively. Image (C) shows the H-bonding interactions between the ligand conformation returned by the SMPSO and the receptor. The ASP29 interacts with the ligand through a hydrogen bond in the same way as has been reported for the reference ligand, in line with other authors’ conclusions [30] with respect to the resulting conformations of SMPSO solutions found in the literature.
In Figure 7, (A) and (B) show the best energy solution by the LGA and the solution selected from the non-dominated solution fronts for instance 1BV9. As in the 1D4K example, the best ligand conformation corresponds to the solution returned by the SMPSO. The ligand conformation computed by the SMPSO is better positioned in the active site of the HIV-protease and, therefore, with respect to the reference ligand. The RMSD scores obtained for the LGA and the SMPSO are 8.79 Å and 0.59 Å. Figure (C) shows the H-bonds between the inhibitor and the receptor. The ASP30, GLY48 and ILE50 interact with the ligand through a hydrogen bond. In fact, it was shown that these amino acids are involved in the interaction between the reference ligand and the receptor [31].

4.4. Application of Multi-Objective Docking in Drug Discovery: A Use Case Based on the Aeroplysinin-1 Compound and EGFR

In this section, we move a step forward by presenting a case study applying our multi-objective docking approach in drug discovery. We have selected three non-dominated solutions (encoding docking conformations) from several executions of SMPSO, as it has been the best performing algorithm in our previous comparisons. Therefore, once we have tested SMPSO on an academic benchmark of chemical compounds related to the HIV-protease (which was used for AutoDock 4 studies to test the new force field), we apply this technique here in the scope of a real study case with the aeroplysinin-1 and EGFR (epidermal growth factor receptor) for drug discovery.
It is worth mentioning that aeroplysinin-1 is a bromo-compound produced by Verongia sponges as a chemical defense to protect them from bacterial pathogens, such as Staphylococcus albus, Bacillus cereus and Bacillus subtilis [32,33]. Aeroplysinin-1 has been extracted in vitro [34], and several analogues have been synthesized from this compound given its inhibitory activity against tyrosine kinases [35]. As growth factors, like EGF (epidermal growth factor) and VEGF (vascular epidermal growth factor), are involved in the regulation of the cell growth and proliferation, the targets of these factors are mostly receptors with tyrosine kinase activity (TKA), so aeroplysinin-1 is a candidate TKA receptor inhibitor for testing in silico and in vitro. Therefore, anti-tumoral action has been reported in several in vitro studies in which aeroplysinin-1 has a cytotoxic effect against tumoral cells from different tissues [36] and also an anti-angiogenic effect in the previous phases of the angiogenesis process [37]. Other studies have reported that aeroplysin-1 inhibits the kinase activity of the EGFR and induces the accumulation of this receptor in human breast tumoral cells [38].
Accordingly, we have selected a use case based on a study in silico with the aeroplysinin-1 compound and the cellular ecto- and intra-domains of the EGFR using the proposed multi-objective approach in this paper. With this use case, we attempt to understand how aeroplysinin-1 interferes in the kinase activity of the EGFR given the in vitro studies that have been performed with this compound. In this regard, the multi-objective approach presented in this paper provides the expert with a tool for assisting them with the selection of specific docking solutions according to the weight of the Einter and Eintra. The selection of a specific docking solution would depend on the drug discovery problems of the expert.
In order to carry out the docking studies with the multi-objective technique presented, we obtained the crystallographic structures for the EGFR from the PDB database. For the EGFR intradomain of Homo sapiens, 1M17 has been used. This crystallographic structure presents the tyrosine domain kinase that includes residues 671 to 998 and the known anti-tumoral erlotinib drug (OSI-774, CP-358,774, TarcevaTM), which is an EGFR kinase-specific inhibitor. The 1YY9 crystal structure of Homo sapiens, which includes residues 25 to 642, has been selected for the EGFR ecto-domains. The aeroplysinin-1 (+) isomer was drawn using the ACD/ChemSketch software [39] given that the aeroplysinin-1 crystallographic structure has not been found.
Aeroplysinin-1 docking instance preparation: firstly, we used ADT to detect the four rotatable bounds, add the partial atomic charges and calculate the AutoDock atom types. For the preparation of the EGFR ecto- and endo-domains, the Chimera UCSF software was used to separate the intracellular kinase domain and the ecto-domains from their respective co-crystallized ligands and to remove all crystallographic molecules that are not involved in the ligand-receptor interaction, such as N-acetyl-glucosamine, alpha-mannose, etc. ADT was also used to add polar hydrogens and partial charges to the two EGFR macromolecules. To calculate the map, we established a grid that included all of the domains of both EGFR macromolecules with a grid spacing of 0.375 Å. The resulting files were used as inputs to run AutoGrid and AutoDock with jMetal. The SMPSO algorithm has been set with a population of 150 individuals, as done in our previous benchmark experiments. In this case, as we are dealing with real case studies, we set our algorithm with a larger number of energy evaluations (25,000,000) per run (30 independent runs), hence looking for optimized solutions with exhaustive experimentation.
Figure 8 shows the set of non-dominated solutions from two independent SMPSO runs of the EGFR kinase domain and the aeroplysinin-1 compound. In this instance, we have focused on those solutions (see the black points in Figure 8) with more negative Einter. The values of Einter of the solutions from Runs 7 and 23 are −5.4 and −6.13 kcal/mol, respectively. The Einter represents the binding affinity between the aeroplysinin-1 compound and the EGFR kinase domain. In this case, it is expected that the aeroplysinin-1 adopts an energetically-stable conformation to the cleft between the amino-terminal and carboxyl-terminal lobes of the EGFR domain kinase, as has been reported in the literature with other compounds, such as the Erlotinib (a 4-anilinoquinazoline inhibitor), ATP, ATP analogues and ATP-competitive inhibitors [40]. In Figure 9, (A) and (C) show how the aeroplysinin-1 compound is bound to the EGFR kinase domain. These results are in accordance with those reported for the Erlotinib drug that is bound to the same binding site in the 1M17 crystallographic structure. Images (B) and (D) show the molecular interactions between aeroplysinin-1 and the amino acids of the EGFR domain kinase cleft. Image (B) shows that the H17 of the -OH second group forms a H-bond with the MET-769 amide oxygen. In the case of the Erlotinib compound complexed with the EGFR kinase domain, the N1 accepts an H-bond from the MET-769 amide nitrogen [40]. Image (D) shows the H-bond created between the O14 and a hydrogen from the side chain of the LYS-721. In the studies with the kinase inhibitor Erlotinib, it was found that the THR-766, LYS-721 and LEU-764 are <4 Å from the acetylene moiety on the anilino ring [40]. The docking results obtained from the SMPSO can explain other enzymatic studies with semi-synthetic derivatives of aeroplysinin-1 that have an inhibitory activity against N+/K+ ATPase [41]. These results can clarify how this compound inhibits the EGFR enzymatic activity and show its possible applicability to targets, like other tyrosine kinase receptors involved in cell proliferation and growth. Furthermore, the multi-objective approach makes the selection of those solutions with different weights of Einter and Eintra easier, as mentioned.
Figure 10 shows the set of non-dominated solutions of the SMPSO algorithm Run 5 of the aeroplysinin-1 and ecto-domain EGFR receptor use case. In this instance, the values of the Einter and Eintra of the selected solution (see the black point in Figure 10) are −3.46 and −0.78 kcal/mol, respectively. In this case, we have selected a solution not corresponding to the best Einter, but rather to the solution with a good balance between these two energies. As stated, Einter represents the binding affinity between ligand-receptor, whereas Eintra describes the energy associated with the ligand deformation in the docking process. In this case, this solution can be interesting given the type of interaction between aeroplysinin-1 and the ecto-domains of the EGFR receptor that is represented and described below.
Image (A) in Figure 11 shows that the aeroplysinin-1 compound of the solution selected is bound to domain II of the EGFR ectodomains. This domain plays an important role in the EGFR receptor activation based on monomer-monomer interactions, as has been reported in previous studies [42]. This mechanism is based on the binding between the EGF (epidermal growth factor) and the EGFR domains I and III, deactivating the EGFR receptor autoinhibition. This conformational change of the receptor leads to the exposition of domains II and IV. Domain II is more involved in the monomer-monomer interaction than domain IV. All of the solutions of the runs preformed by SMPSO have demonstrated that aeroplysinin-1 tends to bind to domain II in terms of the final binding energy. In a more detailed view of the interaction of aeroplysin-1/EGFR ecto-domains, image (B) in Figure 11 shows that an H-bond is formed between the hydrogen of the ARG-285 and H17 of aeroplysinin-1. Such a solution selected with a low Eintra can be useful in cases in which it is necessary to have a more energetic stability of the ligand, like the use case presented in which the aeroplysinin-1 compound interferes in the EGFR dimerization through domain II and requires a more stable docked ligand conformation.

5. Experimental Section

In this study, the benchmark of molecular instances used comprises 11 protein-ligand complexes with flexible ligands and receptors. All of these instances have been taken from the PDB (Protein Data Bank) database [43], and they are available online for experimental reproduction. These complexes have been previously selected in [19], where the macromolecule flexibility is included in the energy function of AutoDock 4.2. Table 4 summarizes the set of problems selected, showing the X-ray crystal structures, the PDB accession code and the structure resolution (Å). According to the size and type of ligand, 1D4K, 1HTG, 1HIV and 1HPX complexes include large ligands (the largest being the 1HPX ligand and the smallest 1D4K). The 1HTF complex includes a ligand that is categorized as a small ligand. The 1AJX, 1AJV, 1G2K, 1HVH and 2UPJ complexes include cyclic urea inhibitors. For all instances, according to the indications [19] for the preparation of the benchmark, the torsional degrees of freedom for ligands are limited to 10, selecting those torsions that allow the fewest number of atoms to move around the ligand core. For flexibility in the receptor, the same docking studies performed by [19], demonstrated that residue ARG-8 showed the highest number of bad contacts with the ligand. Therefore, the number of torsional degrees of freedom was limited to six, three torsional degrees for both side-chain of residue ARG-8 of the HIV-protease receptor. The total number of solution variables (n) is 23 (3 for translation, 4 for rotation quaternion and 16 for torsional degrees).
In order to solve the docking experiments with AutoDock and jMetal, a set of steps were carried out that consists of the preparation of the ligand and macromolecule, running Autogrid and, finally, running AutoDock and jMetal:
  • Preparation of the ligand and macromolecule: Chimera UCSF software [44] was used to separate the macromolecule and the ligand into two PDB files and to remove small molecules, such as solvent molecules, non-interacting ions, etc., from the crystal structure. The AutoDockTools (ADT) graphical interface suite [45] was used to prepare the macromolecule and ligand PDBQT (Protein Data Bank with partial chages and atom type) files. For the preparation of the ligand, partial atomic charges and AutoDock atom types are computed and assigned. For the macromolecule, atom partial charges and hydrogens were added by using the Gasteiger and Babel methods [45]. The rigid and flexible portions of the macromolecule were separately saved as PDBQT files.
  • For running AutoDock, calculation of the grid maps beforehand is necessary in order to reduce the acting area for ligand-macromolecule movements. These maps are calculated by Autogrid, once the coordinates have been established (120 Å ×120 Å ×120 Å) with 0.375 Å of grid spacing. Once Autogrid is executed and the output files obtained, a docking parameter file is configured to run AutoDock.
  • For running AutoDock + jMetal, calculation of the grid maps beforehand is necessary in order to reduce the acting area for ligand-macromolecule movements. These maps are calculated by Autogrid, once the coordinates have been established (120 Å ×120 Å ×120 Å) with 0.375 Å of grid spacing. Once Autogrid is executed and the output files obtained, a docking parameter file is configured to run AutoDock + jMetal.
  • Using the output files created in the previous steps, we have carried out a thorough experimentation consisting of 30 independent runs for each algorithm evaluated (see Section 3) and molecular instance. From the results of these executions, we have calculated the median and interquartile range (IQR) as measures of location (or central tendency) and statistical dispersion, respectively.
Moreover, to assess the actual performance of the algorithms, we have considered two quality indicators: the hyper-volume (IHV ) and unary additive epsilon indicators (Iɛ+) [17]. The first indicator takes into account both convergence and diversity, whereas the second one (Iɛ+) is used more to validate the convergence behavior. In this regard, it is worth noting that we are dealing with a real-world optimization problem, and therefore, the true Pareto front to calculate these two metrics is not known. To cope with this issue, we have generated a reference Pareto front for each problem instance, by using all of the non-dominated solutions computed from all execution results of all of the evaluated algorithms in this study. Figure 12 shows the resulting reference fronts for each molecular docking problem instance considered in Table 4, then constituting a common reference to calculate both, IHV and Iɛ+.
As mentioned, we have used the implementation of the six algorithms studied provided in the jMetalCpp framework (Version 1.5) [18] in combination with AutoDock 4.2 to evaluate the new generated solutions. It is possible to download a prepared version of AutoDock with the jMetalCpp algorithms (along with all of the instances used in this study) in order to reproduce the experiments [46]. To cope with the high computational requirements needed to carry out our experiments, we have used the Condor [47] middleware platform, managing a maximum number of 400 cores, which acts as a distributed task scheduler (each task dealing with one independent run).

5.1. Parameter Setup

All of the evaluated algorithms have been configured with a population size of 150 individuals (particles in the case of SMPSO) and a global number of 1,500,000 function evaluations as the stopping condition. These values were selected to be used as the default values by AutoDock algorithms, as in previous studies where the same docking problem instances were tested [48].
For each specific technique, we have used the parameter setup (see Table 5) as recommended in the research study in which the evaluated algorithm was proposed (also used as default parameters in the jMetal framework). In this way, we look to establish comparisons that are as fair as possible between these general purpose algorithms; so no extra parameter refinement has been performed for any technique in particular, and the same context of the preliminary parameter setup is used for all of them.
In particular, for the genetic algorithms NSGA-II and ssNSGA-II, as well as for SMS-EMOA, SBX crossover and polynomial mutation are used as operators for crossover and mutation, respectively. The distribution indexes for these two operators are ηc = 20 for crossover and ηm = 20 for mutation. The crossover probability is pc = 0.9 and the mutation probability is pm = 1=n, n being the number of decision variables of the tackled problem. NSGA-II and ssNSGA-II apply binary tournament selection, while SMS-EMOA uses random selection. In the case of GDE3 (variant rand/1/bin), both mutation constant μ and crossover probability Cr take a value of 0.5. In the case of MOEA/D, the mutation constant μ is set to 0.5, whereas the crossover probability Cr is 1.0. It also uses a polynomial mutation with values of ηm = 20 and pm = 1=n. The value of the offset for computing the reference point in SMS-EMOA is 20. Finally, for SMPSO, acceleration coefficients ϕ1 and ϕ2 are set to 1.5; the inertia weight is W = 0.9; and a polynomial mutation is applied to one sixth of the particles in the swarm with the same parameters used in the other algorithms.

6. Conclusions

The main motivation of this paper has been to carry out a comparative study using six modern multi-objective optimization algorithms and to apply them to the docking problem. The algorithms selected were NSGA-II, ssNSGA-II, SMPSO, GDE3, MOEA/D and SMS-EMOA. A heterogeneous set of 11 protein-ligand complexes with flexible ligands and receptors was selected in order to carry out the experiments.
The benefit of using a multi-objective approach to the molecular docking problem has been confirmed, allowing one to obtain solutions according to the weight of the Einter and Eintra energies, instead of obtaining just one solution from AutoDock.
In the context of the problems analyzed, the experimentation methodology followed and the chosen parameter settings, we can outline the following conclusions:
  • Using a multi-objective approach to solve the molecular docking problem could lead to a broad set of solutions, which can be selected according to the weight of the Einter and Eintra energies, instead of only getting one solution from AutoDock.
  • SMPSO provides the best overall performance according to the two quality indicators used and for the studied molecular instances.
  • GDE3 and MOEA/D also show a successful performance in terms of convergence and diversity.
  • For all studied molecular instances, SMPSO converges to the region biased towards the Einter objective, whereas GDE3 and MOEA/D generate their fronts of non-dominated solutions in a different region to the ones of SMPSO, thereby giving a clue to intramolecular energy optimization.
  • According to the mono-objective AutoDock 4.2 fitness function, the SMPSO algorithm found, in most of the cases, better solutions than the ones obtained by the LGA algorithm. This is a noticeable result, since SMPSO is a general purpose optimization technique in addition to having to distribute its resources to different parts of the Pareto front, whereas LGA is specifically adapted to deal with the molecular docking problem.
  • The analysis of the ligand binding site and the molecular interactions shows a better position for the ligand conformation computed by the SMPSO than the best energy binding solution returned by the LGA according to the obtained RMSD values. Furthermore, the molecular interactions between the ligand conformation obtained by the SMPSO are in accordance with the reference ligand interactions reported in the literature.
  • We have also provided a use case of drug discovery that involves the aeroplysinin-1 compound and the EGFR. The results have demonstrated that according to the use cases presented, it can be more interesting to select a specific docking solution with a balanced tradeoff between Einter and Eintra values. This approach can improve the way in which the expert can select a solution and contributes to the current methods of drug discovery.
A number of future lines of research can arise using the work presented here as a starting point. The most natural extension would be to design a hybrid algorithm combining search procedures from both the SMPSO and GDE3 algorithms in order to get solutions covering the full Pareto front. A sensitivity analysis of the parameter settings of the studied algorithms could be interesting to reinforce the presented results or to not discard the worst performing algorithms.
Furthermore, a greater number of molecular instances (with a greater number of torsional degrees of freedom for ligands) could be used, and the solutions obtained could be studied from a more biological point of view.

Acknowledgments

This work is partially funded by Grants TIN2014-58304-R (Ministerio de Ciencia e Innovación) and P11-TIC-7529 and P12-TIC-1519 (Plan Andaluz de Investigación, Desarrollo e Innovación).

Author Contributions

María Jesús García-Godoy selected the objectives to be optimized in the energy function, prepared the benchmark to be used, analyzed the results obtained and designed the experiments based on drug discovery. She also contributed to the draft edition. Esteban López-Camacho implemented the AutoDock-jMetal, analyzed the results obtained and contributed to the draft edition. José García-Nieto and Antonio J. Nebro analyzed the results and contributed to the draft edition. José F. Aldana-Montes contributed to the draft edition.

Conflicts of Interest

The authors declare no conflict of interest.
  • Sample Availability: Not available

References

  1. Morris, G.M.; Goodsell, D.S.; Halliday, R.S.; Huey, R.; Hart, W.E.; Belew, R.K.; Olson, A.J. Automated docking using a Lamarckian genetic algorithm and an empirical binding free energy function. J Comput Chem 1998, 19, 1639–1662. [Google Scholar]
  2. Oduguwa, A.; Tiwari, A.; Fiorentino, S.; Roy, R. Multi-objective optimisation of the protein-ligand docking problem in drug discovery. Proceedings of the 8th Annual Conference on Genetic and Evolutionary Computation, Seattle, WA, USA, 8–12 July 2006; pp. 1793–1800.
  3. Grosdidier, A.; Zoete, V.; Michielin, O. EADock: Docking of small molecules into protein active sites with a multi-objective evolutionary optimization. Proteins 2007, 67, 1010–1025. [Google Scholar]
  4. Janson, S.; Merkle, D.; Middendorf, M. Molecular docking with multi-objective Particle Swarm Optimization. Appl Soft Comput 2008, 8, 666–675. [Google Scholar]
  5. Boisson, J.C.; Jourdan, L.; Talbi, E.; Horvath, D. Parallel Multi-objective Algorithms for the Molecular Docking Problem. Proceedings of the 2008 IEEE Symposium on Computational Intelligence in Bioinformatics and Computational Biology (CIBCB ’08), Sun Valley, ID, USA, 15–17 September 2008; pp. 187–194.
  6. Sandoval-Perez, A.; Becerra, D.; Vanegas, D.; Restrepo-Montoya, D.; Niño, F. A Multi-Objective Optimization Energy Approach to Predict the Ligand Conformation in a Docking Process; EuroGP: Vienna, Austria, 2013; pp. 181–192. [Google Scholar]
  7. Durillo, J.J.; Nebro, A.J. jMetal: A Java framework for multi-objective optimization. Adv Eng Softw 2011, 42, 760–771. [Google Scholar]
  8. Sanchez-Faddeev, H.; Emmerich, M.; Verbeek, F.; Henry, A.; Grimshaw, S.; Spaink, H.; van Vlijmen, H.; Bender, A. Using Multiobjective Optimization and Energy Minimization to Design an Isoform-Selective Ligand of the 14-3-3 Protein. Lect Notes Comput Sci 2012, 7610, 12–24. [Google Scholar]
  9. Van der Horst, E.; Marqués-Gallego, P.; Mulder-Krieger, T.; van Veldhoven, J.; Kruisselbrink, J.; Aleman, A.; Emmerich, M.T.M.; Brussee, J.; Bender, A.; Ijzerman, A.P. Multi-Objective Evolutionary Design of Adenosine Receptor Ligands. J Chem Inf Model 2012, 52, 1713–1721. [Google Scholar]
  10. Deb, K.; Pratap, A.; Agarwal, S.; Meyarivan, T. A. Fast and Elitist Multiobjective Genetic Algorithm: NSGA-II. IEEE Trans Evol Comput 2002, 6, 182–197. [Google Scholar]
  11. Durillo, J.J.; Nebro, A.J.; Luna, F.; Alba, E. On the Effect of the Steady-State Selection Scheme in Multi-Objective Genetic Algorithms. In Evolutionary Multi-Criterion Optimization; Springer: Berlin/Heidelberg, Germany, 2009; Volume 5467, pp. 183–197. [Google Scholar]
  12. Nebro, A.J.; Durillo, J.J.; García-Nieto, J.; Coello Coello, C.A.; Luna, F.; Alba, E. SMPSO: A New PSO-based Metaheuristic for Multi-objective Optimization. Proceedings of the IEEE Symposium on Computational Intelligence in Multi-Criteria Decision-Making, Nashville, TN, USA, 30 March–2 April 2009; pp. 66–73.
  13. Kukkonen, S.; Lampinen, J. GDE3: The Third Evolution Step of Generalized Differential Evolution. Proceedings of the 2005 IEEE Congress on Evolutionary Computation, Edinburgh, UK, 5 September 2005; 1, pp. 443–450.
  14. Zhang, Q.; Li, H. MOEA/D: A Multiobjective Evolutionary Algorithm Based on Decomposition. IEEE Trans Evol Comput 2007, 11, 712–731. [Google Scholar]
  15. Beume, N.; Naujoks, B.; Emmerich, M. SMS-EMOA: Multiobjective selection based on dominated hypervolume. Eur J Oper Res 2007, 181, 1653–1669. [Google Scholar]
  16. Coello, C.; Lamont, G.B.; van Veldhuizen, D.A. Multi-Objective Optimization Using Evolutionary Algorithms, 2nd Ed ed; John Wiley & Sons, Inc: New York, NY, USA, 2007. [Google Scholar]
  17. Deb, K. Multi-Objective Optimization Using Evolutionary Algorithms; John Wiley & Sons, Inc: New York, NY, USA, 2001. [Google Scholar]
  18. López-Camacho, E.; García-Godoy, M.J.; Nebro, A.J.; Aldana-Montes, J.F. jMetalCpp: Optimizing molecular docking problems with a C++ metaheuristic framework. Bioinformatics 2014, 30, 437–438. [Google Scholar]
  19. Morris, G.M.; Huey, R.; Lindstrom, W.; Sanner, M.F.; Belew, R.K.; Goodsell, D.S.; Olson, A.J. AutoDock4 and AutoDockTools4: Automated docking with selective receptor flexibility. J Comput Chem 2009, 30, 2785–2791. [Google Scholar]
  20. Rastelli, G. Emerging Topics in Structure-Based Virtual Screening. Pharm Res 2013, 30, 1458–1463. [Google Scholar]
  21. Dallakyan, S.; Pique, M.E.; Huey, R. Autodock, version 4.2. Available online: http://autodock.scripps.edu/ (accessed on 25 May 2015).
  22. Thomsen, R. Flexible ligand docking using evolutionary algorithms: Investigating the effects of variation operators and local search hybrids. Biosystems 2009, 72, 57–73. [Google Scholar]
  23. Huey, R.; Morris, G.M.; Olson, A.J.; Goodsell, D.S. A semiempirical free energy force field with charge-based desolvation. J Comput Chem 2007, 28, 1145–1152. [Google Scholar]
  24. Li, H.; Zhang, Q. Multiobjective Optimization Problems With Complicated Pareto Sets, MOEA/D and NSGA-II. IEEE Trans Evol Comput 2009, 13, 229–242. [Google Scholar]
  25. While, L.; Bradstreet, L.; Barone, L. A. Fast Way of Calculating Exact Hypervolumes. Evol Comput IEEE Trans 2012, 16, 86–95. [Google Scholar]
  26. Sheskin, D.J. Handbook of Parametric and Nonparametric Statistical Procedures; Chapman & Hall/CRC: Boca Raton, FL, USA, 2007. [Google Scholar]
  27. García, S.; Molina, D.; Lozano, M.; Herrera, F. A study on the use of non-parametric tests for analyzing the evolutionary algorithms’ behavior: A case study on the CEC’2005 Special Session on Real Parameter Optimization. J Heuristics 2009, 15, 617–644. [Google Scholar]
  28. García, S.; Fernández, A.; Luengo, J.; Herrera, F. Advanced nonparametric tests for multiple comparisons in the design of experiments in computational intelligence and data mining: Experimental analysis of power. Inf Sci 2010, 180, 2044–2064. [Google Scholar]
  29. López-Camacho, E.; Godoy, M.J.G.; García-Nieto, J.; Nebro, A.J.; Aldana-Montes, J.F. Solving molecular flexible docking problems with metaheuristics: A comparative study. Appl Soft Comput 2015, 28, 379–393. [Google Scholar]
  30. Backbro, K.; Lowgren, S.; Osterlund, K.; Atepo, J.; Unge, T.; Hulten, J.; Bonham, N.M.; Schaal, W.; Karlen, A.; Hallberg, A. Unexpected binding mode of a cyclic sulfamide HIV-1 protease inhibitor. J Med Chem 1997, 40, 898–902. [Google Scholar]
  31. Ala, P.J.; Huston, E.E.; Klabe, R.M.; Jadhav, P.K.; Lam, P.Y.S.; Chang, C.H. Counteracting HIV-1 Protease Drug Resistance:? Structural Analysis of Mutant Proteases Complexed with XV638 and SD146, Cyclic Urea Amides with Broad Specificities. Biochemistry 1998, 37, 15042–15049. [Google Scholar]
  32. Fattorusso, E.; Minale, L.; Sodano, G. Aeroplysinin-1, an antibacterial bromo-compound from the sponge Verongia aerophoba. J Chem Soc Perkin Trans 1 1972, 1, 16–18. [Google Scholar]
  33. Thoms, C.; Ebel, R.; Proksch, P. Activated Chemical Defense in Aplysina Sponges Revisited. J Chem Ecol 2006, 32, 97–123. [Google Scholar]
  34. Nieder, M.; Hager, L. Conversion of alpha-amino acids and peptides to nitriles and aldehydes by bromoperoxidase. Arch Biochem Biophys 1985, 240, 121–127. [Google Scholar]
  35. Hinterding, K.; Knebel, A.; Herrlich, P.; Waldmann, H. Synthesis and biological evaluation of aeroplysinin analogues: A new class of receptor tyrosine kinase inhibitors. Bioorg Med Chem 1998, 6, 1153–1162. [Google Scholar]
  36. Ebel, R.; Brenzinger, M.; Kunze, A.; Gross, H.; Proksch, P. Wound Activation of Protoxins in Marine Sponge Aplysina aerophoba. J Chem Ecol 1997, 23, 1451–1462. [Google Scholar]
  37. Senthilkumar, K.; Venkatesan, J.; Manivasagan, P.; Kim, S.K. Antiangiogenic effects of marine sponge derived compounds on cancer. Environ Toxicol Pharmacol 2013, 36, 1097–1108. [Google Scholar]
  38. Kreuter, M.; Leake, R.; Rinaldi, F.; Muller-Klieser, W.; Maidhof, A.; Muller, W.; Schroder, H. Inhibition of intrinsic protein tyrosine kinase activity of EGF-receptor kinase complex from human breast cancer cells by the marine sponge metabolite (+)-aeroplysinin-1. Comp Biochem Physiol B Comp Biochem 1990, 97, 151–158. [Google Scholar]
  39. Chemsketch for Academics and Personal Usage. Available online: http://www.acdlabs.com/resources/freeware/chemsketch/ (accessed on 25 May 2015).
  40. Stamos, J.; Sliwkowski, M.X.; Eigenbrot, C. Structure of the Epidermal Growth Factor Receptor Kinase Domain Alone and in Complex with a 4-Anilinoquinazoline Inhibitor. J Biol Chem 2002, 227, 46265–46272. [Google Scholar]
  41. Gorshkov, B.; Gorshkova, I.; Makarieva, T. Inhibitory characteristics of 3,5-dibromo-1-acetoxy-4-oxo-2,5-cyclohexadien-1-acetonitrile, a semisynthetic derivative of aeroplysinin-1 from sponges (Aplysinidae), on Na+ - K+-ATPase. Toxicon 1984, 22, 441–449. [Google Scholar]
  42. Li, S.; Schmitz, K.R.; Jeffrey, P.D.; Wiltzius, J.J.; Kussie, P.; Ferguson, K.M. Structural basis for inhibition of the epidermal growth factor receptor by cetuximab. Cancer Cell 2005, 7, 301–311. [Google Scholar]
  43. Protein Data Bank Database. Available online: http://www.rcsb.org/pdb/home/home.do (accessed on 25 May 2015).
  44. Pettersen, E.F.; Goddard, T.D.; Huang, C.C.; Couch, G.S.; Greenblatt, D.M.; Meng, E.C.; Ferrin, T.E. UCSF Chimera—A visualization system for exploratory research and analysis. J Comput Chem 2004, 25, 1605–1612. [Google Scholar]
  45. AutoDockTools. Available online: http://autodock.scripps.edu/resources/adt (accessed on 29 May 2015).
  46. AutoDock-jMetal Framework. Available online: http://khaos.uma.es/autodockjmetal/ (accessed on 25 May 2015).
  47. HTCONDOR Software. Available online: http://research.cs.wisc.edu/htcondor/ (accessed on 25 May 2015).
  48. Norgan, A.P.; Coffman, P.K.; Kocher, J.P.A.; Katzmann, D.J.; Sosa, C.P. Multilevel Parallelization of AutoDock 4.2. J Cheminform 2011, 3, 12. [Google Scholar] [CrossRef]
Figure 1. Solution encoding in AutoDock 4.2 and jMetal. The first three values (translation) are the coordinates of the center of rotation of the ligand. The next four values (quaternion) are the unit vector describing the direction of rigid body rotation (x, y and z) and the rotation of the angle degrees (w) that are applied. The rest of the values holds the torsion angles in degrees, n being the number of torsions of the ligand and also the receptor. Movements concerning the Einter and Eintra calculation are also represented.
Figure 1. Solution encoding in AutoDock 4.2 and jMetal. The first three values (translation) are the coordinates of the center of rotation of the ligand. The next four values (quaternion) are the unit vector describing the direction of rigid body rotation (x, y and z) and the rotation of the angle degrees (w) that are applied. The rest of the values holds the torsion angles in degrees, n being the number of torsions of the ligand and also the receptor. Movements concerning the Einter and Eintra calculation are also represented.
Molecules 20 10154f1
Figure 2. The hyper-volume (delimited by the dotted line) enclosed by the non-dominated solutions. A, B, and C are non-dominated solutions in a set Q = {A,B,C}. For each solution iQ, a hypercube vi is constructed with a reference point W and the solution i as the diagonal corners of the hypercube. The reference point W can be found by constructing a vector of worst objective function values.
Figure 2. The hyper-volume (delimited by the dotted line) enclosed by the non-dominated solutions. A, B, and C are non-dominated solutions in a set Q = {A,B,C}. For each solution iQ, a hypercube vi is constructed with a reference point W and the solution i as the diagonal corners of the hypercube. The reference point W can be found by constructing a vector of worst objective function values.
Molecules 20 10154f2
Figure 3. Reference fronts and best hyper-volumes from SMPSO, GDE3 and MOEA/D for instances 1BV9 and 1D4K.
Figure 3. Reference fronts and best hyper-volumes from SMPSO, GDE3 and MOEA/D for instances 1BV9 and 1D4K.
Molecules 20 10154f3
Figure 4. Front having the best hyper-volume value from SMPSO with regards to instance 1AJV. The point on the dashed vertical line is the best solution found by LGA, the mono-objective algorithm from AutoDock. All solutions placed on the left-hand side dominate that of LGA for the two optimized objectives. The macromolecule-ligand complexes resulted from the SMPSO and the LGA algorithms are represented in A and B, respectively.
Figure 4. Front having the best hyper-volume value from SMPSO with regards to instance 1AJV. The point on the dashed vertical line is the best solution found by LGA, the mono-objective algorithm from AutoDock. All solutions placed on the left-hand side dominate that of LGA for the two optimized objectives. The macromolecule-ligand complexes resulted from the SMPSO and the LGA algorithms are represented in A and B, respectively.
Molecules 20 10154f4
Figure 5. Non-dominated solution fronts of SMPSO for instances 1BV9 and 1D4K. The vertical bars represent the RMSD values for each solution. The solutions with better RMSD values are darker, that is the lower the RMSD, the better the docking solution is.
Figure 5. Non-dominated solution fronts of SMPSO for instances 1BV9 and 1D4K. The vertical bars represent the RMSD values for each solution. The solutions with better RMSD values are darker, that is the lower the RMSD, the better the docking solution is.
Molecules 20 10154f5
Figure 6. (A,B) The ligand conformation for instance 1D4K that has been generated by the LGA and SMPSO algorithms, respectively. The computed ligand conformations are in green and the reference ligand in orange. (A,B) show the HIV-protease in 3D, in grey; (C) The molecular interactions between the ligand conformation returned by the SMPSO algorithm and the receptor. The H-bonds are represented by green spheres. The amino acids closest to the computed ligand have been labeled.
Figure 6. (A,B) The ligand conformation for instance 1D4K that has been generated by the LGA and SMPSO algorithms, respectively. The computed ligand conformations are in green and the reference ligand in orange. (A,B) show the HIV-protease in 3D, in grey; (C) The molecular interactions between the ligand conformation returned by the SMPSO algorithm and the receptor. The H-bonds are represented by green spheres. The amino acids closest to the computed ligand have been labeled.
Molecules 20 10154f6
Figure 7. (A,B) The ligand conformations for instance 1BV9 that have been generated by the LGA and SMPSO algorithms. The computed ligand conformations are in purple and the reference ligand in green. (A,B) show the HIV-protease in 3D, colored in grey; (C) The molecular interactions between the ligand conformation returned by the SMPSO algorithm and the receptor. The H-bonds are represented by green spheres. The amino acids closest to the computed ligand have been labeled.
Figure 7. (A,B) The ligand conformations for instance 1BV9 that have been generated by the LGA and SMPSO algorithms. The computed ligand conformations are in purple and the reference ligand in green. (A,B) show the HIV-protease in 3D, colored in grey; (C) The molecular interactions between the ligand conformation returned by the SMPSO algorithm and the receptor. The H-bonds are represented by green spheres. The amino acids closest to the computed ligand have been labeled.
Molecules 20 10154f7
Figure 8. (A,B) show the SMPSO fronts of non-dominated solutions of Runs 7 and 23 (out of 30) for the aeroplysinin-1 docking instance. The black points are the solutions selected from the set of solutions of each run. The final binding energy of the black point at left side of the front corresponds to −4.21 kcal/mol. The Einter and Eintra values are −5.4 and −0.05 kcal/mol, respectively. The final binding energy of the black point of the right boxplot corresponds to −4.93 kcal/mol. The Einter and Eintra equal −6.13 and −0.07 kcal/mol, respectively.
Figure 8. (A,B) show the SMPSO fronts of non-dominated solutions of Runs 7 and 23 (out of 30) for the aeroplysinin-1 docking instance. The black points are the solutions selected from the set of solutions of each run. The final binding energy of the black point at left side of the front corresponds to −4.21 kcal/mol. The Einter and Eintra values are −5.4 and −0.05 kcal/mol, respectively. The final binding energy of the black point of the right boxplot corresponds to −4.93 kcal/mol. The Einter and Eintra equal −6.13 and −0.07 kcal/mol, respectively.
Molecules 20 10154f8
Figure 9. (A,C) The tridimensional structure of the EGFR kinase domain with the alpha-helix structure in pink, the beta-strands in yellow and aeroplysinin-1 bound to the cleft between the NH2 and COOH terminal lobes. These aeroplysinin-1 conformations correspond to the results obtained by the SMPSO algorithm (Runs 7 and 23); (B,D) The molecular interactions between the aeroplysinin-1 compound and the EGFR receptor. The H-bonds are represented in green spheres. The amino acids of the interaction site and the ligand atoms have been labeled.
Figure 9. (A,C) The tridimensional structure of the EGFR kinase domain with the alpha-helix structure in pink, the beta-strands in yellow and aeroplysinin-1 bound to the cleft between the NH2 and COOH terminal lobes. These aeroplysinin-1 conformations correspond to the results obtained by the SMPSO algorithm (Runs 7 and 23); (B,D) The molecular interactions between the aeroplysinin-1 compound and the EGFR receptor. The H-bonds are represented in green spheres. The amino acids of the interaction site and the ligand atoms have been labeled.
Molecules 20 10154f9
Figure 10. The plot represents all sets of solutions obtained from the SMPSO algorithm from Run 5. The black point corresponds to the solution selected. The final binding energy of the conformation selected equals −2.27 kcal/mol. The Einter and Eintra values are −3.46 and −0.78 kcal/mol, respectively.
Figure 10. The plot represents all sets of solutions obtained from the SMPSO algorithm from Run 5. The black point corresponds to the solution selected. The final binding energy of the conformation selected equals −2.27 kcal/mol. The Einter and Eintra values are −3.46 and −0.78 kcal/mol, respectively.
Molecules 20 10154f10
Figure 11. (A) The tridimensional structure of EGFR receptor with the four domains labeled; (B) The molecular interaction between aeroplysinin-1 and the EGFR receptor. The H-bond is represented by green spheres. The amino acids of the binding site and the ligand atoms have been also labeled.
Figure 11. (A) The tridimensional structure of EGFR receptor with the four domains labeled; (B) The molecular interaction between aeroplysinin-1 and the EGFR receptor. The H-bond is represented by green spheres. The amino acids of the binding site and the ligand atoms have been also labeled.
Molecules 20 10154f11
Figure 12. Reference fronts of non-dominated solutions computed from all execution results of all of the evaluated algorithms in this study and for each molecular docking problem instance.
Figure 12. Reference fronts of non-dominated solutions computed from all execution results of all of the evaluated algorithms in this study and for each molecular docking problem instance.
Molecules 20 10154f12
Table 1. Median and interquartile range of IHV and Iɛ+ quality indicators, for each evaluated algorithm and docking instance. Best and second best median results have grey and clearer grey backgrounds, respectively.
Table 1. Median and interquartile range of IHV and Iɛ+ quality indicators, for each evaluated algorithm and docking instance. Best and second best median results have grey and clearer grey backgrounds, respectively.
IHVHyper-Volume

NSGA-IIssNSGA-IISMPSOGDE3MOEA/DSMS-EMOA
1AJV4.75×10−21.1×10−17.47×10−43.1×10−22.65×10−19.5×10−21.23×10−19.2×10−27.39×10−21.3×10−11.33×10−21.4×10−1
1AJX2.91×10−11.2×10−12.96×10−11.3×10−15.69×10−11.1×10−13.44×10−110−23.22×10−11.2×10−13.07×10−11.6×10−1
1BV91.33×10−11.3×10−11.17×10−11.1×10−15.41×10−13.7×10−11.79×10−11.9×10−21.81×10−11.2×10−11.34×10−11.1×10−1
1D4K2.38×10−11.3×10−12.54×10−11.2×10−15.09×10−11.5×10−13.79×10−110−22.76×10−17.8×10−22.62×10−19.6×10−2
1G2K8.06×10−21.5×10−16.11×10−21.0×10−15.74×10−12.0×10−11.62×10−16.4×10−21.13×10−11.2×10−15.69×10−21.0×10−1
1HIV7.12×10−29.0×10−25.39×10−28.0×10−27.61×10−28.5×10−21.10×10−17.8×10−27.78×10−28.8×10−25.80×10−29.5×10−2
1HPX5.77×10−21.3×10−12.09×10−26.8×10−23.06×10−13.8×10−19.50×10−24.2×10−28.69×10−29.7×10−24.93×10−21.1×10−1
1HTF2.80×10−12.8×10−12.85×10−12.0×10−15.29×10−21.3×10−14.03×10−11.3×10−14.98×10−11.8×10−12.95×10−12.1×10−1
1HTG9.20×10−21.0×10−19.08×10−28.5×10−23.68×10−32.7×10−21.80×10−11.6×10−21.62×10−13.3×10−21.47×10−18.8×10−2
1HVH2.10×10−11.5×10−19.27×10−21.1×10−15.04×10−12.9×10−13.28×10−11.0×10−11.78×10−11.9×10−19.22×10−22.2×10−1
2UPJ3.65×10−17.2×10−23.75×10−19.5×10−24.23×10−11.1×10−15.20×10−11.6×10−14.05×10−19.3×10−23.75×10−11.1×10−1

Iɛ+Epsilon

NSGA-IIssNSGA-IISMPSOGDE3MOEA/DSMS-EMOA

1AJV7.74×10+02.2×10+08.64×10+01.7×10+01.48×10+03.2×10−16.55×10+08.3×10−16.84×10+01.7×10+08.21×10+02.4×10+0
1AJX6.65×10+01.5×10+07.04×10+01.4×10+01.64×10+02.6×10−16.44×10+03.9×10−16.18×10+09.5×10−16.51×10+02.0×10+0
1BV91.11×10+11.8×10+01.15×10+12.0×10+01.09×10+08.7×10−11.15×10+13.7×10−11.03×10+11.6×10+01.15×10+12.0×10+0
1D4K1.15×10+12.5×10+01.17×10+12.4×10+02.45×10+06.7×10−11.06×10+11.3×10+01.11×10+11.7×10+01.14×10+12.5×10+0
1G2K7.55×10+02.4×10+07.81×10+01.7×10+09.30×10+05.1×10−16.13×10+01.0×10+06.99×10+01.7×10+07.88×10+01.8×10+0
1HIV8.85×10+01.7×10+09.49×10+01.5×10+03.11×10+03.4×10+08.75×10+01.2×10+07.88×10+01.8×10+09.36×10+02.0×10+0
1HPX6.98×10+01.7×10+07.28×10+01.2×10+02.60×10+06.0×10+06.93×10+03.6×10−16.04×10+01.4×10+07.18×10+01.2×10+0
1HTF5.26×10+02.0×10+05.23×10+01.5×10+06.93×10+01.4×10+04.37×10+09.4×10−13.65×10+01.3×10+05.16×10+01.6×10+0
1HTG2.23×10+12.9×10+02.23×10+12.3×10+03.57×10+03.8×10+01.97×10+18.8×10−11.86×10+11.2×10+02.09×10+12.6×10+0
1HVH8.56×10+02.5×10+09.92×10+02.1×10+03.08×10+02.2×10+07.54×10+01.2×10+07.53×10+02.2×10+01.01×10+13.3×10+0
2UPJ8.05×10+01.6×10+07.74×10+02.2×10+01.60×10+02.2×10−15.82×10+02.7×10+06.45×10+01.0×10+07.59×10+01.8×10+0
Table 2. Average Friedman’s rankings with Holm’s adjusted p-values (α = 0.05) of the compared algorithms (SMPSO, GDE3, MOEA/D, SMS-EMOA, ssNSGA-II and NSGA-II) for the test set of 11 docking instances.
Table 2. Average Friedman’s rankings with Holm’s adjusted p-values (α = 0.05) of the compared algorithms (SMPSO, GDE3, MOEA/D, SMS-EMOA, ssNSGA-II and NSGA-II) for the test set of 11 docking instances.
Hyper-Volume (IHV )Epsilon (Iɛ+)Metrics’ Hits

AlgorithmFriRankHolmApAlgorithmFriRankHolmApAlgorithmRanking
GDE3 *1.81-SMPSO *1.45-SMPSO(2 + 1 = 3)
SMPSO2.186.48×10−1MOEA/D2.273.05×10−1GDE3(1 + 3 = 4)
MOEA/D2.636.10×10−1GDE32.722.21×10−1MOEA/D(3 + 2 = 5)
SMS-EMOA4.502.32×10−3NSGA-II4.504.04×10−4NSGA-II(5 + 4 = 9)
NSGA-II4.631.64×10−3SMS-EMOA4.632.65×10−4SMS-EMOA(6 + 5 = 11)
ssNSGA-II5.229.62×10−5ssNSGA-II5.403.57×10−5ssNSGA-II(6 + 6 = 12)
*indicates the control algorithm, and the column at the right contains the overall ranking of positions with regards to IHV and Iɛ+.
Table 3. Best binding energy values (kcal/mol) calculated from all SMPSO solutions in comparison with the best values of LGA mono-objective solutions. The grey background represents the best solutions in terms of binding energy.
Table 3. Best binding energy values (kcal/mol) calculated from all SMPSO solutions in comparison with the best values of LGA mono-objective solutions. The grey background represents the best solutions in terms of binding energy.
Algorithms/Instance1AJV1AJX1BV91D4K1G2K1HIV1HPX1HTF1HTG1HVH2UPJ
SMPSO−12.56−11.22−17.07−18.67−12.83−13.89−10.34−6.83−31.66−15.59−10.91
LGA−7.26−6.20−7.62−11.25−7.19−9.06−5.70−7.30−31.79−9.39−5.90
Table 4. X-ray crystal structure coordinates taken from PDB database. Their accession codes from the PDB database and the resolution are also presented.
Table 4. X-ray crystal structure coordinates taken from PDB database. Their accession codes from the PDB database and the resolution are also presented.
Protein-Ligand ComplexesPDB CodeResolution (Å)
HIV-1 protease/AHA0061AJV2
HIV-1 protease/AHA0011AJX2
HIV-1 protease/α-D-glucose1BV92.20
HIV-1 protease/macrocyclic peptidomimetic inhibitor 81D4K1.85
HIV-1 protease/AHA0471G2K1.95
HIV-1 protease/U758751HIV2
HIV-1 protease/KNI-2721HPX2
HIV-1 protease/GR1260451HTF2.20
HIV-1 protease/GR1376151HTG2
HIV-1 protease/Q82611HVH1.80
HIV-1 protease/U1003132UPJ3
Table 5. Parameter settings of the compared algorithms. NSGA-II, non-dominated sorting genetic algorithm II; ssNSGA-II, steady-state NSGA-II; SMPSO, speed modulation multi-objective particle swarm optimization; GDE3, third evolution step of generalized differential evolution; MOEA/D, multi-objective evolutionary algorithm based on decomposition; SMS-EMOA, S-metric evolutionary multi-objective optimization.
Table 5. Parameter settings of the compared algorithms. NSGA-II, non-dominated sorting genetic algorithm II; ssNSGA-II, steady-state NSGA-II; SMPSO, speed modulation multi-objective particle swarm optimization; GDE3, third evolution step of generalized differential evolution; MOEA/D, multi-objective evolutionary algorithm based on decomposition; SMS-EMOA, S-metric evolutionary multi-objective optimization.
AlgorithmParameterValue
NSGA-IISelectionBinary Tournament
ssNSGA-IICrossoverSBX (pc = 0.9; ηc = 20)
MutationPolynomial (pm = 1=n; ηm = 20)

SMPSOArchive size150
Acceleration coefficientsϕ1 = 1, 5; ϕ2 = 1, 5
InertiaW = 0.9
MutationPolynomial (pm = 1=n; ηm = 20)

GDE3DE variantrand/1/bin
Mutationμ = 0.5
CrossoverCr = 0.5

MOEA/DDE variantrand/1/bin
CrossoverCr = 1.0
Mutationμ = 0.5; Polynomial (pm = 1=n; ηm = 20)

SMS-EMOASelectionRandom
CrossoverSBX (pc = 0.9; ηc = 20)
MutationPolynomial (pm = 1=n; ηm = 20)
Reference pointMaximum objective values plus offset=20

Common parametersPopulation size150 individuals (or particles)
Stopping condition1,500,000 function evaluations

Share and Cite

MDPI and ACS Style

García-Godoy, M.J.; López-Camacho, E.; García-Nieto, J.; Nebro, A.J.; Aldana-Montes, J.F. Solving Molecular Docking Problems with Multi-Objective Metaheuristics. Molecules 2015, 20, 10154-10183. https://doi.org/10.3390/molecules200610154

AMA Style

García-Godoy MJ, López-Camacho E, García-Nieto J, Nebro AJ, Aldana-Montes JF. Solving Molecular Docking Problems with Multi-Objective Metaheuristics. Molecules. 2015; 20(6):10154-10183. https://doi.org/10.3390/molecules200610154

Chicago/Turabian Style

García-Godoy, María Jesús, Esteban López-Camacho, José García-Nieto, Antonio J. Nebro, and José F. Aldana-Montes. 2015. "Solving Molecular Docking Problems with Multi-Objective Metaheuristics" Molecules 20, no. 6: 10154-10183. https://doi.org/10.3390/molecules200610154

Article Metrics

Back to TopTop