Next Article in Journal
Engaging with Raman Spectroscopy to Investigate Antibody Aggregation
Next Article in Special Issue
Molecular Recognition between Aβ-Specific Single-Domain Antibody and Aβ Misfolded Aggregates
Previous Article in Journal / Special Issue
In Silico Methods in Antibody Design
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

OptMAVEn-2.0: De novo Design of Variable Antibody Regions against Targeted Antigen Epitopes

by
Ratul Chowdhury
1,†,
Matthew F. Allan
1,2,† and
Costas D. Maranas
1,*
1
Department of Chemical Engineering, The Pennsylvania State University, State College, PA 16802, USA
2
Computational and Systems Biology Initiative, Massachusetts Institute of Technology, Cambridge, MA 02139, USA
*
Author to whom correspondence should be addressed.
These authors contributed equally to this work.
Antibodies 2018, 7(3), 23; https://doi.org/10.3390/antib7030023
Submission received: 20 May 2018 / Revised: 28 June 2018 / Accepted: 29 June 2018 / Published: 30 June 2018
(This article belongs to the Collection Computational Antibody and Antigen Design)

Abstract

:
Monoclonal antibodies are becoming increasingly important therapeutic agents for the treatment of cancers, infectious diseases, and autoimmune disorders. However, laboratory-based methods of developing therapeutic monoclonal antibodies (e.g., immunized mice, hybridomas, and phage display) are time-consuming and are often unable to target a specific antigen epitope or reach (sub)nanomolar levels of affinity. To this end, we developed Optimal Method for Antibody Variable region Engineering (OptMAVEn) for de novo design of humanized monoclonal antibody variable regions targeting a specific antigen epitope. In this work, we introduce OptMAVEn-2.0, which improves upon OptMAVEn by (1) reducing computational resource requirements without compromising design quality; (2) clustering the designs to better identify high-affinity antibodies; and (3) eliminating intra-antibody steric clashes using an updated set of clashing parts from the Modular Antibody Parts (MAPs) database. Benchmarking on a set of 10 antigens revealed that OptMAVEn-2.0 uses an average of 74% less CPU time and 84% less disk storage relative to OptMAVEn. Testing on 54 additional antigens revealed that computational resource requirements of OptMAVEn-2.0 scale only sub-linearly with respect to antigen size. OptMAVEn-2.0 was used to design and rank variable antibody fragments targeting five epitopes of Zika envelope protein and three of hen egg white lysozyme. Among the top five ranked designs for each epitope, recovery of native residue identities is typically 45–65%. MD simulations of two designs targeting Zika suggest that at least one would bind with high affinity. OptMAVEn-2.0 can be downloaded from our GitHub repository and webpage as (links in Summary and Discussion section).

1. Introduction

Antibodies are versatile molecules produced in B-cells and have become the basis of many therapeutics [1,2,3] and diagnostics [4,5,6] for cancers [6,7,8], infectious diseases [9], and autoimmune disorders [10]. They are affinity proteins that are crucial for humoral immunity and are able to bind to foreign proteins with high specificity [11]. Administration of serum from survivors to treat patients during infectious disease outbreaks such as the 1918 influenza pandemic [12] marks the early years of antibody-mediated therapeutics. The first monoclonal antibodies were developed by immunizing mice with a target antigen [6]. However, high immunogenicities of murine antibodies limit their efficacies in humans [6]. Subsequent efforts have resulted in chimeric constructs [6] of murine variable domains grafted onto human constant domains. Although chimeras exhibit less immunogenicity relative to fully murine antibodies [6], they are not entirely human [6] and may still cause adverse reactions. Methods such as phage display [13] and yeast display [14] have been able to create high-affinity, completely humanized antibodies. However, all experimental methods antibody development are time-consuming [15], and none offers a general approach to target a specific antigen epitope, increase affinity without increasing immunogenicity, and categorize designs based on the primary sequence of the variable domain and the binding pose of the antigen [16].
Computational methods of antibody design have addressed these limitations. Software exists for designing stable antibody-antigen complexes [17,18,19], predicting the immunogenicities of antibody sequences [20,21], and predicting stabilizing mutations to the antibody complimentary determining regions (CDRs) [17,22,23,24]. Before our work, we knew of no software that could design antibodies de novo—that is, without an initial structure of an antibody bound to the antigen [17,18,19]. To this end, we first developed OptCDR [17], which designed de novo CDRs of high affinities but not low immunogenicities. This limitation was addressed in the following effort, OptMAVEn [16], which designs full antibody variable domains. Two subsequent efforts at antibody design were AbDesign [18] by Lapidoth et al. and Rosetta Antibody Design (RAbD) [19] by Adolf-Bryfogle et al. However, both of these tools build upon existing antibodies and thus require an initial structure of the antigen-antibody complex.
In addition to designing antibodies without an input structure, OptMAVEn-2.0 performs computational affinity maturation while avoiding sequences likely to trigger an immune response. During affinity maturation, OptMAVEn mimics natural mutation preferences by mutating residues in the CDRs with three times the frequency compared to residues in the framework regions. OptMAVEn screens a large set of antigen poses, designs antibodies for each pose, and outputs the designs with the most favorable antigen-antibody interaction energies. However, OptMAVEn’s large computational time and storage requirements limit sampling of antigen poses, which reduces the likelihood of finding designs with favorable interaction energies.
Here, we introduce OptMAVEn-2.0, which is capable of sampling a larger set of antigen poses within roughly one day, while OptMAVEn required over one week. Each antibody variable region comprises a heavy (H) and a light (L, or kappa-K) chain. An end to end joined variable (V), a complimentarity determining region (CDR3), and a joining (J) region constitutes each heavy and light chain. We have retained the mixed-integer linear programming (MILP) core module, which identifies six optimal parts from the Modular Antibody Parts (MAPs) database [25] (HV, HCDR3, HJ, L/KV, L/KCDR3, and L/KJ) that constitute the variable domain. While OptMAVEn requires excessive disk storage by storing each antigen pose as a separate Protein Data Bank (PDB) file, OptMAVEn-2.0 alleviates this problem by storing only one reference pose and using transformation matrices to generate other poses as needed.
OptMAVEn-2.0 introduces a systematic procedure to classify antibody designs. Each MAPs part is assigned a three-dimensional coordinate that depends on the sequence similarity to other MAPs parts of the same type (HV, HCDR3, and so on). We compute a matrix of pairwise sequence similarity scores for each type of MAPs parts and then convert similarities into metric distances using Stojmirovic’s method [26]. We use Distance Geometry Optimization Software (DGSOL 1.3, Argonne National Laboratory, Lemont, IL, USA) [27] to embed these distances in 3D-Euclidean space, yielding a 3D-coordinate for each MAPs part [28]. After relaxing all designs, OptMAVEn-2.0 creates for each design a 23-dimensional vector consisting of the 3D-coordinates of its six MAPs parts (18 dimensions), the epitope centroid (three dimensions), and the sine and cosine of the antigen z angle (two dimensions). A Principal Component Analysis (PCA) step transforms these 23-dimensional vectors into three-dimensional vectors, which are then used in k-means clustering of the designs. OptMAVEn-2.0 then ranks the designs from most to least promising by cycling through the clusters and selecting the top design from each cluster until all designs have been selected.
After ranking these germline designs (so named because they are assembled from MAPs parts that correspond to germline genes), the user has the option of assessing the stability of the germline designs bound to the epitope of interest using short (25 ns) molecular dynamics (MD) trajectories (using QwikMD [29]) and/or subjecting the designs for in silico affinity maturation while ensuring that the immunogenicity scores are reduced. The MD step assesses the stability of the most promising designs over 50 ns, ensuring that the best antibody designs bind stably to the antigen. Affinity maturation is implemented within Iterative Protein Redesign and Optimization (IPRO) software [30] and optimizes affinities of germline designs while ensuring that their immunogenicity does not increase. The immunogenicity of each design is assessed using the “human string content” (HSC) [20], which estimates the potential of a sequence to elicit a T cell response when presented on Major Histocompatibility Complex (MHC)-II. HSC is used to calculate a “humanization score” (HScore) [16]: an antibody with a low HScore is relatively humanized and thus has low potential to trigger an immune response in the human body.
We used OptMAVEn-2.0 to design antibodies targeting five epitopes of Zika envelope (E) protein and three of hen egg white lysozyme. We assessed the stability of two designs from one of the Zika cases using short MD simulations. Recovery of epitope-binding residues and sequence similarities are reported for the top five designs for all the other cases.

2. Methods

2.1. Overview

OptMAVEn-2.0 (Figure 1) is de novo antibody design software that extends OptMAVEn [16]. OptMAVEn-2.0 is fully automated (unlike OptMAVEn), requires less CPU time and disk storage, and features a novel clustering algorithm to increase the diversity of antibody designs raised against a specific antigen epitope. Both versions assemble antibodies from the MAPs database of antibody parts [25], which contains variable (V), CDR3, and joining (J) regions for the heavy (H), lambda (L), and kappa (K) chains. First, the user specifies the antigen and its epitope. As in OptMAVEn, the antigen is rotated such that its epitope faces a framework antibody, and then an ensemble of antigen positions is generated by translating and rotating the antigen within a user-defined antigen binding site. Positions in which the antigen clashes with the framework antibody are discarded. At each remaining antigen position, the interaction energy between the antigen and each part in the MAPs database is calculated, and a set of six non-clashing MAPs parts is selected so as to minimize the sum of the interaction energies between the parts and the antigen. These associations of an antigen position with a set of MAPs parts (i.e., designs) are clustered using a k-means approach. OptMAVEn-2.0 sequentially scans through all clusters, generating a Protein Data Bank (PDB) and FASTA file of the design with the most negative interaction energy in each cluster, repeating until files have been created for all designs. These designs can then undergo further validation (e.g., QwikMD [29]) or sequence optimization (e.g., affinity maturation and reduction of HScore [16]) to yield a set of designs for experimental validation or optimization (e.g., with phage display [13]).

2.2. Design and Implementation

OptMAVEn-2.0 runs continuously from the initial step (starting an experiment) to the output of germline designs. This feature reduces the effort on the part of the user and also makes OptMAVEn-2.0 easier to use than OptMAVEn, which required manual initiation of each step in the workflow. OptMAVEn-2.0 is currently supported on UNIX platforms with Python 2.7 [31], NumPy [32], SciPy [33], and BioPython 1.7 [34]. Within its main directory, OptMAVEn-2.0/, are subdirectories src/(source modules written in Python and Tool Command Language (TCL) scripts), experiments/(all experiment directories), and data/(files of antigen structures, topologies, and parameters). If the directory experiments/ does not exist, it is created automatically when the first experiment is started. The data/directory contains three subdirectories: (1) pdbs/stores structures of antigens, which may be in either PDB or mmCIF format; (2) input_files/stores topology and parameter files needed for energy calculations in CHARMM (Chemistry at Harvard Molecular Mechanics) [35]; and (3) antibodies/stores framework antibody structures and the MAPs database. Before an experiment can be started, the structure of the antigen and all required topology and parameter files must be located in pdbs/and input_files/, respectively. OptMAVEn-2.0 is pre-installed with default CHARMM topology (top_all27_prot_na.rtf) and parameter (par_all27_prot_na.prm) files. The user may add additional files to support a wider range of antigens (or small drug molecules) that characterize these molecules’ types of bonds, angles, dihedrals and improper dihedral angles. An ./OptMAVEn-2.0 executable is also present in the OptMAVEn-2.0/main directory and is used to initiate an experiment.

2.3. Starting an Experiment

To start an experiment, the user enters ./OptMAVEn-2.0 into a UNIX terminal from the main directory of OptMAVEn-2.0. First, the user names the experiment. OptMAVEn-2.0 creates a directory named OptMAVEn-2.0/experiments/name to hold all of the experiment’s results and temporary files. The user may customize the configuration of the experiment (e.g., by specifying topology and parameter files) or use the default configuration, defined in OptMAVEn-2.0/src/standards.py. The user then specifies the file containing the antigen’s structure, the chains that constitute the antigen, heteroatoms to exclude, and the residues of each chain that constitute the epitope region for which the antibody is to be designed. For each antigen chain, at least one epitope residue must be selected.
OptMAVEn-2.0 preprocesses the user-specified antigen structure file by automatically removing heteroatoms and chains that are not part of the antigen but are present in the crystal structure obtained from the Protein Data Bank (PDB). This feature makes initiating an experiment simpler. Unlike OptMAVEn-2.0, in the older OptMAVEn, the user must remove these chains and heteroatoms manually and create a file listing the epitope residues; OptMAVEn does not check that these residues actually exist, but OptMAVEn-2.0 does. In OptMAVEn-2.0, users select antigen chains, heteroatoms, and epitope residues using a simple, single-line syntax. Ranges are indicated with hyphens, while individual items are delimited with commas: for example, A–C, E specifies chains A, B, C, and E of a certain molecule. Furthermore, OptMAVEn-2.0 makes it simpler for the user by listing the available chains of the antigen molecule to choose from. Overall, unlike in OptMAVEn, the user needs to know only the antigen PDB accession ID and the residues that constitute the epitope of interest. OptMAVEn-2.0 automatically downloads the molecule from the Protein Data Bank using a package in BioPython [34] and then performs the remaining steps.

2.4. Antigen Positioning

OptMAVEn-2.0 begins by adding missing atoms (e.g., hydrogens) to the antigen as necessary and performing an energy relaxation in CHARMM [35]. The user may configure this relaxation when starting the experiment by indicating the number of CHARMM relaxation iterations. Following the relaxation, the antigen is rotated to minimize the z-coordinate of the epitope’s centroid (i.e., the mean of the coordinates of the epitope’s Cα atoms, neglecting atomic masses). This step orients the epitope towards the ensemble of MAPs parts that will be assembled into the variable domain, thus ensuring that the antibody will bind to the intended epitope. The implementation of a similar antigen rotation step in OptMAVEn has two significant limitations, which are corrected in OptMAVEn-2.0. First, OptMAVEn uses an exhaustive search of rotations around the x and y axes in discrete increments of 3° (i.e., 120 angles per axis yielding 1202 = 14,400 rotations) to minimize the z-coordinate of the epitope’s centroid. This search requires extensive sampling and typically lasts several minutes. Second, the search has a finite resolution (3° in each axis): the desired rotation may lie between two search points and thus may not be sampled. To illustrate, let the desired rotation θopt = (θx,opt, θy,opt) consist of a rotation around the x axis by θx,opt followed by a rotation around the y axis by θy,opt. The discrete search will identify a point θopt’ = (θx,opt’, θy,opt’) such that θx,opt’, θy,opt’ ∈ {0°, 3°, 6°, … , 357°}. The maximum difference between θopt and θopt’ (for instance, if θopt = (1.5°, 1.5°)) is thus θ opt θ opt = 1.5 ° 2 + 1.5 ° 2 = 1.5 ° 2 2.1 ° . Thus, the final rotated antigen conformation in OptMAVEn may be up to 2.1° off with respect to the desired rotation.
OptMAVEn-2.0 corrects both problems by using a single matrix to perform the rotation. First, the centroids of the antigen ( c A ¯ ) and epitope ( c E ¯ ), and the vector between them d = c E ¯ c A ¯ are computed. Because the rotation does not change interatomic distances, d 2 = d x 2 + d y 2 + d z 2 remains unchanged during the rotation. Likewise, because c A ¯ is the center of rotation, c A ¯ must also remain unchanged. Thus, the rotation minimizes the z coordinate of the epitope’s centroid ( c E ¯ z ) subject to holding d 2 and c A ¯ constant. Because d x 2 + d y 2 0 , it must be true that 0 d z 2 d 2 . Because d z 2 = ( c E ¯ z c A ¯ z ) 2 and c A ¯ z is a constant, c E ¯ z may be decreased until the point at which ( c E ¯ z c A ¯ z ) 2 = d 2 , d x 2 = d y 2 = 0 . Thus, the solution that minimizes c E ¯ z is c E ¯ x = c A ¯ x , c E ¯ y = c A ¯ y , c E ¯ z = c A ¯ z d . This rotation is implemented using the trans procedure within Visual Molecular Dynamics (VMD) [36] software. If d = 0 (e.g., if all antigen residues are part of the epitope), no rotation is performed. This procedure outperforms OptMAVEn in that it requires no exhaustive search and yields an error of less than 0.01° in rotating the antigen such that the sum of the z-coordinates of its epitope is minimized.
Following the rotation, OptMAVEn-2.0 generates an ensemble of antigen positions using a grid search (Figure 2). This step has been made significantly more efficient relative to OptMAVEn. An antigen-binding site is defined as the virtual box (obtained by inspecting 750 antigen-antibody binding regions) in which the x, y, and z coordinates of the epitope’s centroid are within the ranges [−10 Å, 5 Å], [−5 Å, 10 Å], and [3.75 Å, 16.25 Å], respectively. This box is partitioned into a grid (default x, y, and z intervals are 2.5, 2.5, and 1.25 Å, respectively). Furthermore, the antigen is rotated around the z axis to increase conformational sampling (the default is 6 rotations in increments of 60°). Hence, each antigen position can be represented as a so-called position vector consisting of the epitope centroid (x, y, and z coordinates) and the rotation angle around the z axis ( θ z ). The default settings lead to 6 × 7 × 7 × 11 = 3234 positions. OptMAVEn-2.0 introduces a precise definition of θ z for peptide antigens, which was missing in OptMAVEn. Let d 1 = c 1 c A ¯ be the vector extending from the centroid of the antigen to the coordinate c 1 of the Cα atom of the first residue in the antigen. Then θ z is defined as the angle between the positive x-unit vector ( ı ) and the projection of d 1 onto the x-y plane. Using the relationship between angle and dot product, ı proj x , y ( d 1 ) cos θ z = ı · proj x , y ( d 1 ) , which leads to θ z = sign ( proj x , y ( d 1 ) y ) · cos 1 ( ı · proj x , y ( d 1 ) ı proj x , y ( d 1 ) ) = sign ( proj x , y ( d 1 ) y ) · cos 1 ( proj x , y ( d 1 ) x proj x , y ( d 1 ) ) .
As in OptMAVEn, OptMAVEn-2.0 screens out antigen positions that will inevitably lead to steric clashes with the representative structure of the antibody framework regions. Thus, antigen positions that clash with the framework will clash with any designed antibody and will yield energetically unfavorable designs. Herein, a position is defined as clashing if any atom of the antigen is within 1.25 Å of any atom in the framework. For each antigen position, the number of clashes is counted. While OptMAVEn tolerates up to two clashes, OptMAVEn-2.0 tolerates no clashes, as the former often resulted in interlocked aromatic side chains between residues of the epitope and the designed antibody structure.
OptMAVEn-2.0 significantly reduces disk storage requirements for antigen positioning by saving all non-clashing positions in a single text file (of a few kilobytes) and representing each as its position vector. Meanwhile, OptMAVEn saves each antigen conformation as its own PDB file. Since PDB files of large antigens can be of the order of several megabytes, alleviating the requirement to save thousands of PDB files could save gigabytes of storage. This choice contributes in large part to reducing the average maximum disk usage by 84%.

2.5. MAPs Interaction Energy Calculations

At each non-clashing antigen position, the interaction energy between the antigen and each MAPs part is calculated. OptMAVEn uses C++ modules that require a separate PDB file for each antigen position. However, OptMAVEn-2.0 implements the energy calculations by calling the NAMDEnergy [37] module of VMD, which is able to translate and rotate the antigen after loading its initial structure. Thus, we are able to generate all antigen positions using only a reference (starting) structure of the antigen and a second file of position vectors (prepared during the ‘Antigen positioning’ step), which together typically require only a few hundred kilobytes of disk space.
Both OptMAVEn and OptMAVEn-2.0 use electrostatic and van der Waals energy terms for choosing the optimal antibody parts during the MILP step. Full antibody variable domain designs emerging from the optimal MAPs parts selection step are re-optimized using an energy function that accounts for solvation effects. The binding scores thus calculated are now used to rank all the designs.

2.6. Optimal Selection of MAPs Parts

For each antigen position, OptMAVEn-2.0 selects one set of V, D, and J parts from the H locus and one set from either the K or L locus. It thereafter minimizes the sum of the interaction energies of the six parts using a mixed-integer linear program (MILP). In this program we define, set I = {i | HV, HCDR3, HJ, LV, LCDR3, LJ, KV, KCDR3, and K} that contains the nine categories of MAPs parts. Each category i has a set of part indexes Pi = {p | 1, 2, …, Ni}, where Ni is the number of parts listed in category i. Each MAPs part is represented as a tuple (i, p) of a category and a serial index of that category. Further, the set IPclash = {((i1, p1), (i2, p2)), … ((im, pm), (in, pn))} is the set of all pairs of parts that sterically clash. The parameter Ei,p is the interaction energy between the antigen and MAPs part (i, p). The parameters Hd and Ld are set to 1 if the heavy and light variable domains, respectively, are being designed, and 0 otherwise. This allows the option of designing both domains (a full antibody) or a single domain (a nanobody). Finally, the binary variable Xi,p is equal to 1 if part (i, p) is chosen by the MILP to be a part of the final antibody design and is 0 otherwise. The optimization protocol uses an objective function subject to a set of five constraints as described below. The formulation is the same as that of OptMAVEn [16].
M i n i m i z e i = 1 9 p = 1 N i X i , p E i , p
subject to
X i 1 , p 1 + X i 2 , p 2 1   { ( i 1 , p 1 ) , ( i 2 , p 2 ) } I P c l a s h
p = 1 N i X i , p = H d ,   i { H V , H C D R 3 , H J }
p = 1 N K V X K V , p + p = 1 N L V X L V , p = L d
p = 1 N K V X K V , p = p = 1 N K C D R 3 X K C D R 3 , p = p = 1 N K J X K J , p
p = 1 N L V X L V , p = p = 1 N L C D R 3 X L C D R 3 , p = p = 1 N L J X L J , p
The objective function minimizes the interaction energy between the antigen and the set of MAPs parts that are selected. Constraint 1 prevents sterically clashing MAPs parts being chosen. Constraint 2 ensures that while a heavy chain is being designed, exactly one HV, HCDR3, and HJ part is selected, and that no heavy chain parts are selected if the heavy chain is not being designed (Hd = 0). Constraint 3 is analogous to constraint 2 and ensures that if a KV part is selected, no LV parts are selected and vice versa. Constraint 4 ensures that if a KV part is chosen by constraint 3, one each of KCDR3 and KJ parts are also chosen, else no K chain parts should be chosen. Constraint 5 enforces the same for the L chain MAPs parts during the design. Together, constraints 3, 4, and 5 ensure that if a light chain is being designed, exactly one V, CDR3, and J part is selected for the light chain and prevent choosing a mix of kappa and lambda parts.
OptMAVEn-2.0 improves upon the design step of OptMAVEn in two ways. First, the IPclash set of OptMAVEn (48,800 pairs) was found to be incomplete, sometimes leading to designs with steric clashes between residues within the antibodies. Thus, despite having favorable interaction energies, these antibodies were structurally unstable. The current IPclash set has been updated to contain 66,604 additional pairs of MAPs parts and now identifies all pairs of parts for which any atom in one part is within 1 Å of any atom in the other (excluding pairs that cannot be selected simultaneously, such as HJ-1 and HJ-2 or LV-1 and KJ-1). A second improvement is that OptMAVEn-2.0 designs only one antibody for each antigen position, while OptMAVEn designed five. As the additional four antibodies designed by OptMAVEn were always sub-optimal to the first design, eliminating them would not eliminate the optimal design for each position. Moreover, the subsequent clustering step would likely cluster together designs at the same position but ultimately choose only or two designs from each cluster design, and so the last three or four designs at each position would very seldom, if at all, appear on the final list of the best designs. Thus, OptMAVEn-2.0 expends roughly one fifth of the effort during the design step without compromising the quality of the designs.

2.7. Antibody Assembly

OptMAVEn-2.0 creates a PDB file for each design by assembling the MAPs parts and positioning the antigen. These designs then undergo a structural relaxation (in CHARMM [35]) that first relieves any potential steric clashes and then uses van der Waals, electrostatics, and Generalized-Born solvation energy terms to calculate the antigen-antibody interaction energy. These interaction energies are used for the clustering step and subsequent ranking of all the designs.

2.8. Clustering the Antibody Designs

2.8.1. Pre-Processing Step

OptMAVEn-2.0 clusters the antibody designs based on both their antigen positions (which are Euclidean coordinates) and the sets of MAPs parts they comprise (which are not Euclidean coordinates). To simultaneously cluster by position and MAPs parts, a Euclidean coordinate was generated for each MAPs part. Methods exist to compute distances between two biological sequences (e.g., the amino acid sequences of MAPs parts) [25] and to convert pairwise distance matrices into Euclidean coordinates only if (but not necessarily if) these distances satisfy the four criteria of a metric distance d [26]:
d ( x , y ) 0     x , y M
d ( x , y ) = 0 x = y     x , y M
d ( x , y ) = d ( y , x )     x , y M
  d ( x , y ) + d ( y , z ) d ( x , z )     x , y , z M
where x, y, and z are sequences, M is a category of MAPs parts, and d is the function that computes a distance between two sequences. The first condition requires that all distances be positive, the second that two sequences have distance of zero if and only if they are identical, the third that the distance function is symmetric, and the fourth that the triangle inequality holds.
The method of Stojmirovic [26] is particularly well-suited to this task because it yields metric distances from biological sequences in the following manner. Let s(x, y) be a similarity score between sequences x and y, such that s(x, y) is greater if x and y are more similar. The associated quasi-metric distance q of the similarity score s is q(x, y) = s(x, x) − s(x, y). Finally, the distance d(x, y) = max{q(x, y), q(y, x)} is a metric, provided that s satisfies the following conditions [26]:
s ( x , x ) s ( x , y )     x , y M
s ( x , x ) = s ( x , y ) s ( y , x ) = s ( y , y ) x = y     x , y M
s ( x , y ) + s ( y , z ) s ( x , z ) + s ( y , y )     x , y , z M
where x, y, and z are sequences and M is a category of MAPs parts. Most protein alignment scoring systems satisfy these conditions. Because the MAPs parts follow the international ImMunoGeneTics database (IMGT) numbering system [38], amino acids that have aligned with each other have the same residue number. Therefore, the similarity score between two sequences is the sum over all residue numbers of the alignment scores of the pair of aligned amino acids, or of a gap penalty if one sequence lacks a residue number.
s ( x , y ) = i A B s ( x i , y i )
where A and B are the sets of residue numbers in sequences x and y, respectively; x i denotes the amino acid of number i in sequence x (or x i is a gap if i A ); and s ( x i , y i ) is the similarity score between amino acids x i and y i in the BLOSUM62 matrix [39] if i A B or a gap penalty g otherwise. The optimal value of g was not known a priori, and so five levels (4, 6, 8, 10, and 12) were tested. For each level, we computed the similarity scores between all pairs of MAPs parts within every category and verified that they satisfied the conditions for s. Five violations of condition 2 revealed that there were five pairs of identical parts in the MAPs database: (HV-135, HV-136), (KV-2, KV-3), (KV-25, KV-26), (KV-41, KV-42), and (LV-5, LV-6). After removing the higher-numbered of the two parts from the database, all three conditions were satisfied.
Although the resulting pairwise distance matrix for each MAPs category satisfied the conditions for a metric, all such matrices possessed negative eigenvalues, indicating that they could not be embedded in Euclidean space [40]. Therefore, we devised a method to approximate a Euclidean embedding of these distances (Figure 3). Several programs—including MD-jeep [41], Xplor-NIH [42], TINKER [43], and DGSOL [27]—create approximate embeddings in 3D space. Although representing high-dimensional space in three dimensions causes the loss of some information, reducing the dimensionality helps to mitigate the so-called “curse of dimensionality” in the subsequent clustering step [44]. An attractive feature of DGSOL is that it accepts a lower and upper bound for each pairwise distance, enabling multiple sets of bounds to be tested. DGSOL computes a penalty function that depends on the extent to which the distances between embedded coordinates lie outside of the bounds; distances within the bounds are not penalized. The lower and upper bounds L B i j and U B i j , respectively, were computed as L B i j = ( 1 w ) × d ( x i , x j ) and U B i j = ( 1 + w ) × d ( x i , x j ) respectively, where x i and x j are two MAPs parts from the same category, d is the distance function, and w is a bound width parameter that was varied from 0.0 to 0.5 in increments of 0.05. For each level of w and of gap penalty g, DGSOL was used to generate an embedded coordinate c i for each MAPs part i. For each category of MAPs parts, the pairwise distances c i j = c i c j between every pair of parts ( i j ) in the category were compared to the alignment distances from the d i j = d ( x i , x j ) function. Specifically, the Spearman rank correlation ρ between C = { c i j | i j } and D = { d i j | i j } was calculated, as was the root mean square error R M S E = i j ( c i j d i j ) 2 N , where N = card(C) = card(D) is the number of pairs of parts. The optimal w was chosen such that ρ was maximized. In the case of a tie, the w that minimized root mean squared error (RMSE) was chosen from among those w values that maximized ρ .
The gap penalty g is used to compute sequence alignment distances d i j , which are embedded and used to compute pairwise distances c i j . Thus, ρ and RMSE (which depend on d i j and c i j ) depend on g. A ρ close to unity indicates that the relative order of distances was preserved during the embedding, and a RMSE close to zero indicates that the distances themselves were minimally perturbed. The optimal gap penalty (g) would maximize ρ and minimize RMSE for each MAPs category. To identify this optimal g, we tested five values of g: 4, 6, 8, 10, and 12. Each g was used to generate a similarity matrix S and an alignment matrix Dalign for each category of parts. The distances in Dalign were embedded with DGSOL, and pairwise distances Dembed between the embedded coordinates were computed. Then, ρ (Figure 4a and Supplementary Table S1) and RMSE (Figure 4b and Supplementary Table S2) were computed using Dalign and Dembed. For each MAPs part category (HV, LV, and so on), we ranked the different g values in terms of the corresponding ρ (highest ρ yields rank 1 for the corresponding g and vice-versa) and of RMSE (lowest RMSE yields rank 1 for the corresponding g and vice-versa) (Table 1). Therefore, the rank of each g indicates how well the distances in Dalign could be embedded while preserving both relative and absolute distances. HJ, LJ, and KJ were excluded from this analysis because these parts contain no residue number gaps in the IMGT numbering; for these parts, Dalign and Dembed do not depend on g. We found that g = 8 had the best average rank (2.1) (Figure 4c) and thus used g = 8 hereafter. However, the user has the option of selecting a different g from among the levels tested.
For g = 8, ρ was highest (ρ > 0.982) for the HJ, LJ, KJ and KV categories, showing that Euclidean coordinates recapitulated the relative ranks of the distances in Dalign. The CDR3 regions had the lowest values (0.851 < ρ < 0.932), indicating that the optimal Euclidean approximations swapped the ranks of a greater number of distances. Lower ρ values can presumably be attributed to the greater number of structures N in each CDR3 set (39 ≤ N ≤ 428) than in each J set (5 ≤ N ≤ 7). In the distance geometry problem, a set of pairwise distances between N points can be embedded into a Euclidean space of at most N–1 dimensions. Thus, the maximum potential dimensions of the spaces in which the CDR3 parts could be embedded are greater those of the spaces in which the J parts could be embedded. Projecting higher-dimensional coordinates onto 3 dimensions crushes more dimensions and thus causes more pairs of points that are far apart in high-dimensional space to become close together in three-dimensional space. Dimension crushing would create parts with large aligned distances but small embedded distances. Such parts appear most in the sets with the largest number of members (i.e., CDR3), less often in the medium-sized sets (i.e., V), and never in the smallest sets (i.e., J) (Figure 5).

2.8.2. k-means Clustering

Each antigen position and its associated optimal set of MAPs parts is converted into a 23-dimensional vector by concatenating the x, y, and z coordinates of the epitope’s centroid; the sine and cosine of θ z ; and the 3D coordinates representing the six MAPs parts. Clustering algorithms often fail to cluster high-dimensional data well due to the so-called “curse of dimensionality” [44]. Thus, the 23-dimensional vectors are normalized such that each dimension has unit variance (if the original variance is not zero), and PCA is performed to reduce the dimensionality of each vector to 3. Because the optimal number of clusters k is unknown prior to clustering, the clustering procedure initializes k to 1 and increments k after each round of clustering. During each round, the k clusters are initialized by randomly selecting (without replacement) one vector as the centroid for each cluster. Each vector is assigned to the cluster with the nearest centroid (measured by Euclidean distance). If any cluster is empty, a vector selected randomly from another cluster is moved to the empty cluster. Each cluster centroid is then moved to the geometric mean of the vectors in the cluster; the root mean square (RMS) movement is computed. The assignment and movement steps are repeated until the RMS movement falls below a threshold (default 0.01) or an iteration limit is reached (default 1000). For each cluster, the mean squared distance (MSD) between the centroid and the cluster members in computed; the maximum of these MSD values is assigned to the k value. For each k, the ratio of the MSD to the MSD for k = 1 is computed. The k value is incremented until this ratio falls below a threshold (default 0.2).

2.9. Ranking the Antibody Designs

OptMAVEn-2.0 ranks the designs using their clusters and their antigen-antibody interaction energies, ensuring that the highest-ranked designs are both structurally diverse and predicted to have high affinities.
Progressing from the cluster with the lowest to the cluster with the highest minimum energy, it collects the design with the minimum solvated interaction energy from each cluster and cycles back until all designs have been chosen. In this way, the most optimal design from every cluster is selected first, followed by the second-, third- and so forth most optimal designs.
The relaxed structure of each design is output as a PDB and a FASTA file in the directory OptMAVEn-2.0/experiments/name/antigen-antibody-complexes/Result_#. OptMAVEn-2.0 generates two additional files in the experiment’s directory. Summary.txt gives information about the experiment (e.g., antigen file, epitope). Results.csv lists all designs in descending order by rank and gives, for each, the antigen position, MAPs parts, antibody sequences, cluster number, and MILP, unrelaxed, and relaxed interaction energies.

3. Results

We first benchmarked OptMAVEn-2.0 against OptMAVEn with a set of 10 antigens and subsequently used 54 additional antigens to assess the performance of the current algorithm. We then used OptMAVEn-2.0 to design antibody variable fragments against two sets of Zika envelope proteins reported by Wang et al. [45] (PDB: 5GZN) and Zhao et al. [46] (5KVD, 5KVE, 5KVF, and 5KVG). We ranked our de novo designs along with the native antibody reported for 5GZN; 12 of 77 designs showed enhanced binding relative to the native. MD simulations performed on two out of these 12 designs showed that one design is stably bound to the antigen. Finally, we identified the key stabilizing antigen-antibody interactions in these two designs and the native antibody. Results from the second set of runs led to good native sequence recovery, with 55% of the top five de novo designed chains showing at least 50% identity and 40% of them showing 75% similarity.
Thereafter, we used OptMAVEn-2.0 to design antibodies against three lysozyme structures (1BVK [47], 4TSB [48], and 4PGJ [49]) for each of which there exists an experimentally reported humanized antibody that binds to it. We analyze the native sequence recovery from the top five best binding designs and also investigate the number of native epitope binding contacts that were also seen in the top five designs.

3.1. Computational Benchmarking of OptMAVEn and OptMAVEn-2.0 on 10 Antigens

OptMAVEn and OptMAVEn-2.0 were each used to design antibodies for a benchmarking set of 10 antigens (PDB codes: 1NSN, 2IGF, 2R0W, 2VXQ, 2ZUQ, 3BKY, 3FFD, 3G5V, 3L5W, and 3MLS). These antigens were selected randomly from the 120 antigens used to benchmark OptMAVEn [16]. The antigen chains and epitopes are given in Supplementary Table S3. Benchmarking was performed on a Linux InfiniBand cluster. We measured the amount of time taken for the steps of Antigen Positioning (Tpos), MAPs Interaction Energy Calculations (Tener), and Optimal Selection of MAPs Parts (TMILP); as well as the maximum disk usage of the experiment directory (Dmax) for OptMAVEn (Table 2) and OptMAVEn-2.0 (Table 3). Time taken for the k-means clustering step could not be compared because this step is unique to OptMAVEn-2.0. Thus, total CPU time (TCPU) for purposes of comparison was defined as TCPU = Tpos + Tener + TMILP. We also recorded the number of positions that did not clash with the framework antibody (Npos) and the interaction energy (including Generalized Born solvation) of the most optimal antigen-antibody complex after structural relaxation with CHARMM (Emin).
One potential confounding factor was that we used a different antigen binding site for OptMAVEn and OptMAVEn-2.0 during the antigen positioning step. In previous work [16], we used 750 antigen-antibody complexes from the Protein Data Bank to identify an antigen binding site of x: [−10 Å, 5 Å], y: [−5 Å, 10 Å], and z: [3.75 Å, 16.25 Å]. This binding site was used for OptMAVEn. During benchmarking of OptMAVEn-2.0, we interchanged the x and y dimensions of the binding site, that is x: [−5 Å, 10 Å], y: [−10 Å, 5 Å]. This change is not likely to have significantly affected TCPU, Dmax, or Npos because it did not change the total number of grid points sampled (3234). However, this change would have affected Emin if the best design from OptMAVEn-2.0 was not within the original binding site of OptMAVEn—that is, if OptMAVEn could not have created the design. This was the case for only one antigen (2R0W) among the 10 tested; thus, we excluded 2R0W from the analysis of Emin. There is no evidence that the difference in antigen binding sites confounded the results of OptMAVEn and OptMAVEn-2.0.

OptMAVEn-2.0 Reduces Time and Disk Requirements by 74% and 84%, Respectively

OptMAVEn-2.0 ran significantly faster than OptMAVEn in terms of TCPU (mean 74% faster, p < 0.001), Tpos (mean 99.8% faster, p < 0.001), Tener (mean 64% faster, p = 0.006), and TMILP (mean 84% faster, p < 0.001). Additionally, average Dmax was 84% lower for OptMAVEn-2.0 than for OptMAVEn (p < 0.001). These substantial improvements in performance did not compromise design quality: there was no significant difference in Emin between the two programs (p = 0.62) (Table 4). Because all quantities but Emin were ratios between OptMAVEn and OptMAVEn-2.0, we computed their p values using two-tailed ratio t-tests of log10(Q/O), where Q and O are the values for OptMAVEn-2.0 and OptMAVEn, respectively. The p-value for Emin was computed using a standard paired t-test of QO. We verified our assumptions of normality using Shapiro-Wilk tests: all p-values were >0.05.

3.2. Test of OptMAVEn-2.0 on 54 Additional Antigens Reveals Sub-Linear Scaling

In order to more fully analyze the relations between the performance metrics, we used OptMAVEn-2.0 to design antibodies (see Supplementary Table S4) for an additional 54 antigens (Table 5) that we selected randomly from the 120 antigens used to benchmark OptMAVEn. We found that Npos correlated with both TCPU (r = 0.663) and Dmax (r = 0.954) more strongly than any other feature of the antigen correlated with these performance metrics. The number of residues (Nres) or atoms (Natom) correlated only weakly with TCPU (r = 0.083, r = 0.075, respectively). Nres and Natom correlated moderately well with Dmax (r = −0.472, r = −0.482, respectively) but, as larger antigens should require larger files, the negative sign was unexpected. Given the strong negative correlation between Npos and Natom (r = −0.650), it seems that larger antigens (measured by Natom) unsurprisingly tend to clash with the framework antibody in a larger number of positions and thus have lower Npos values. Because Npos is also the number of antibodies designed, decreasing Npos reduces the number of files associated with antibody designs, decreasing Dmax. These results show that the computational resource requirements of OptMAVEn-2.0 scale in a sub-linear manner with the size of the antigen, ceteris paribus. Due to this feature, OptMAVEn-2.0 (unlike OptMAVEn) is capable of designing antibodies for very large antigens, e.g., Zika E protein (Natom = 6801).

3.3. Test Cases on Zika E Protein

We used OptMAVEn-2.0 to design antibodies targeting epitopes of Zika E protein that we identified in the PDB entries 5GZN [45], 5KVD [46], 5KVE [46], 5KVF [46], and 5KVG [46]. While the antibodies in 5GZN are from a human, those in 5KVD, 5KVE, 5KVF, and 5KVG were raised in mice. The reported native antibody in each PDB binds Zika E protein with an affinity in the low nanomolar to low micromolar range. Unfortunately, we could not rank our de novo designs with respect to the native antibodies in 5KVD, 5KVE, 5KVF, and 5KVG because the native complexes are of poor quality, such that large steric clashes could not be alleviated even after several rounds of structural relaxations.

3.3.1. Setup for the Test Cases on Zika E Protein

We defined an epitope residue such that at least one heavy atom of the residue was within 4 Å of at least one heavy atom of the antibody. The epitope residues are given in Supplementary Table S3. Note that if no structures of Zika in complex with an antibody had been available, we could have predicted these epitopes using existing software such as those described in Soria-Gurerra et al. [50]. We used the default settings for OptMAVEn-2.0 and defined the antigen binding box with the following bounds x: [−5 Å, 10 Å], y: [−10 Å, 5 Å], and z: [3.75 Å, 16.25 Å].

3.3.2. Recovery of Native Residues in the Test Cases on Zika E Protein

We assessed the recovery of native residues by aligning each of the top five designs with the native sequence and computing % identity (identical residues) and % similarity (residues with similar properties) using EMBL EMBOSS Needle [51]. Native sequence recovery was reasonable (see Supplementary Table S1). Out of the 40 chains (20 heavy and 20 light chains from the top five designs of four cases), 22 (55%) chains were at least 50% identical, and 16 (40%) were at least 75% similar. Recovery of native L sequences was higher on average than that of H sequences: of the 22 chains that were at least 50% identical, 15 (68%) were L chains; and of the 16 chains that were at least 75% similar, 14 (88%) were L chains. This result likely arises because CDR-H3 is more diverse than CDR-L3.

3.3.3. Humanization Scores in the Test Cases on Zika E Protein

We assessed the HScores of the top five designs and compared them to those of the native structure (see Table 6). The HScores of the de novo designs were consistently lower than those of the native antibody in all but two cases (5GZN light chain, 5KVF light chain, highlighted in bold). This result is unsurprising because all native antibodies but 5GZN are murine. Even relative to a human antibody (5GZN), the heavy chain HScores for the top five designs are consistently lower, which compensates for the relatively larger HScores of the light chains. The HScores suggest that OptMAVEn-2.0 can design antibodies with immunogenicities similar to those of human antibodies, although these predictions do not have experimental confirmation.

3.3.4. Molecular Dynamics Simulations

We performed fast MD simulations using the QwikMD [29] protocol in VMD on three antibody-antigen complexes for 5GZN: the native complex, the top design (5gzn_R27, with the lowest interaction energy), and the design with the lowest MILP energy, which excludes solvation (5gzn_R0). The QwikMD trajectories were set up for 25 ns each of equilibration and production, with a time step of 2 fs; trajectory snapshots were kept every 1000 steps (2 ps). The simulations were run at 310 K with water as the implicit solvent.
We assessed the long-term stability of each of the three antigen-antibody complexes by calculating, once every 2.5 ns, the RMSD of the antigen with respect to the antigen at the beginning of the production run (i.e., time 0 ns). In order to analyze the stability of the antigen-antibody complex for the de novo designed antibody, we first identified the binding interface residues and tracked their fluctuations during the course of the 25 ns production run. Residues distal to the interface were neglected because unordered loop regions would contribute to larger root mean square deviations (RMSDs) even though the interface might be fairly stable. The antibody residues that are a part of the binding interface were aligned to their starting conformation (at 0 ns) at the end of every 2.5 ns of the 25 ns run. Then the heavy-atom RMSD of the antigen residues within the interface was computed (Figure 6). RMSDs of the native complex and 5 gzn_R0 were similar and remained below 6 Å in every frame examined, indicating that these complexes were stable throughout the entire simulations, according to a previous definition of stable binding by Poosarla et al. [52]. RMSD of 5gzn_R27 exceeded 6 Å but did not exceed 12 Å, indicating that the antigen remained partially bound [52]. Figure 7 shows the key electrostatic interactions (polar and salt bridge) seen in the 5gzn_native, 5gzn_R0, and 5gzn_R27 designs.

3.4. Test Cases on Hen Egg White Lysozyme

We identified three epitopes of hen egg white lysozyme from the PDB entries 1BVK [47], 4PGJ [49], and 4TSB [48]. The native antibodies in all three structures are human or humanized, though 4PGJ contains only the heavy chain in complex with lysozyme.

3.4.1. Setup for the Test Cases on Lysozyme

We used the same definition of epitope residues as was used for Zika (see Table 2) and the default OptMAVEn-2.0 settings.

3.4.2. Recovery of Native Residues and Contacts in the Test Cases on Lysozyme

For each test case, the sequences of the top five designs are given in Supplementary Figure S2. We assessed the recovery of native residues for these designs. Of the 20 chains designed for 1BVK and 4TSB, 18 (90%) are more than 65% similar and 9 (45%) are more than 75% similar. For 4PGJ, we found lower similarities in the range of 37–46%, likely because the native antibody was engineered using phage display with a library of humanized sequences, rather than isolated directly from a human. Excluding 4PGJ, 15 (75%) of the designed chains were at least 50% identical; the lowest identity observed was 40.7%, the highest 85.6%. These results show that OptMAVEn-2.0 can recover a high fraction of the residues in native human antibodies. We also report the percentage recovery of native antigen-antibody contacts in these top five designs (see Supplementary Figure S2) and their HScores in comparison to those of the native structures (see Table 7).

4. Summary and Discussion

OptMAVEn, an extension of the OptCDR framework, was the first software capable of designing entire variable domains de novo. However, OptMAVEn requires gigabytes of disk storage and weeks of CPU time, making it computationally intensive to target large antigens. We have developed OptMAVEn-2.0, which designs antibodies of equivalent affinities using significantly reduced disk storage (84% less) and CPU time (74% less). These improvements reduce the time needed to design germline antibodies from over a week to roughly one day and enable OptMAVEn-2.0 to handle large antigens, such as Zika E protein (407 residues) [45].
Due to its increased speed, OptMAVEn-2.0 could now be integrated into laboratory-based workflows for designing antibodies. The most common technologies for antibody development in the laboratory are animal immunization and phage display [13]. Immunization can yield low-affinity antibodies de novo in 1–2 weeks [53], while phage display can in some cases design high-affinity but non-specific antibodies in under one week and also requires an initial library of antigen binding fragments [54]. An integrated workflow would take advantage of the high affinities reached by phage display, as well as OptMAVEn-2.0′s speed (typically <24 h to design hundreds of variable domains) and abilities to minimize immunogenicity and target a specific epitope. Thus, we believe OptMAVEn-2.0 could enable the rapid design of candidate antibodies for experimental validation using only the antigen structure, unlike all other computational methods to our knowledge [16,17,18,19,55].
OptMAVEn-2.0 introduces a new clustering step that retains designs with high (unfavorable) interaction energies if they are the best designs among those with similar antigen poses and antibody sequences. Following the generation of germline designs, the designs can be validated with MD simulations (e.g., in QwikMD [29]). Designs that are likely to bind with high affinity according to the MD simulations can be further optimized using affinity maturation in IPRO [30], which increases affinity while lowering immunogenicity.
Despite these promising results, there are several limitations of OptMAVEn-2.0 on which we are currently working. As in OptMAVEn, the MILP step of OptMAVEn-2.0 still uses a simplified energy function that poorly estimates the chemical potential near the binding site; estimates worsen as the number of charged interactions increases. We have partially addressed this limitation by considering solvation when relaxing, clustering, and ranking the designs after the MILP based rotamer optimization step. Future work involves improving estimates of chemical potentials by incorporating solvation and entropy terms. Checa et al. [56] and Lazaridis and Karplus [57] have found that solvation energy contributions to protein-protein interactions are important. Solvation energy calculations could be further augmented by accounting for intramolecular self-solvation terms, as described by Choi et al. [58]. Additionally, incorporating the conformational entropy of the antigen would capture effects of unordered loops and binding site rotamers which are not held in place by a stable interaction with another residue, thereby providing meaningful insights about antigen-antibody binding biophysics [59].
Another limitation of OptMAVEn is that it does not explicitly consider the stability of the antibody itself. Antibodies are complex molecules and are prone to failure in multiple ways [60]. Aggregation of antibodies is a particular problem: when antibodies aggregate, they lose their ability to bind to the target ligand and increase the risk of becoming immunogenic [22], even for fully human antibodies [60]. Several methods have been developed to predict (e.g., Spatial Aggregation Propensity [22]) or remove (e.g., Rosetta Supercharge [23,24]) aggregation-prone regions of antibodies. Potentially, these tools or similar methods could be incorporated into the affinity maturation step of future versions of OptMAVEn. These methods would ensure that the aggregation risk did not increase during affinity maturation, just as the current implementation imposes a similar constraint on the HScore. Antibodies may also degrade chemically, such as through separation of the chains, oxidation, hydrolysis, or deamidation [60]. Future versions of OptMAVEn could include measures to reduce the risk of such degradation, thereby increasing shelf life or the tolerance of antibodies to a variety of conditions.
Currently, OptMAVEn-2.0 runs on the Institute of Cyber Science-Advanced CyberInfrastructure (ICS-ACI) cluster at Pennsylvania State University. In order to make it available to everyone without a CHARMM license, we plan to implement a web server on which users may submit jobs to be run. Like the command-line OptMAVEn-2.0 interface, this web server will prompt users for a structure file upload (or a PDB ID), the chain(s) in the antigen, and the epitope residues, as well as provide options to customize the settings of OptMAVEn-2.0. OptMAVEn-2.0 is freely available for download from both.

5. Conclusions

In this work, we have outlined an efficient protocol for rapid de novo design of antibody variable domains for specific antigen epitopes. OptMAVEn-2.0 is capable of designing and clustering antibodies under five hours for most antigen epitopes just using a single node and a single processor per node in ICS-ACI. A Humanizer module can be employed post OptMAVEn-2.0 to reduce immunogenicity with the objective of in silico affinity maturation. The Humanizer module can also be independently used for humanizing murine antibodies without having to go through the OptMAVEn-2.0 cascade. Both OptMAVEn-2.0 and Humanizer are freely available for download from both https://github.com/maranasgroup and http://www.maranasgroup.com/software.htm. We are currently working towards making both of these as web-based tools. However, currently a user can request for OptMAVEn-2.0 and Humanizer runs (http://www.maranasgroup.com/software.htm).

Supplementary Materials

The following are available online at https://www.mdpi.com/2073-4468/7/3/23/s1, Figure S1: Sequence alignments of the native heavy and light chain antibody sequences with the top five de novo designed sequences for (a) 5KVD, (b) 5KVE, (c) 5KVF, and (d) 5KVG respectively, have been represented, Figure S2: Sequence alignments of the native heavy and light chain antibody sequences with the top five de novo designed sequences for (a) 1BVK, (b) 4TSB, and (c) 4PGJ have been represented, Table S1: The Spearman rank correlation coefficient (ρ) for each MAPs part category at each gap penalty g, Table S2: The root mean squared error (RMSE) for each MAPs part category at each gap penalty g, Table S3: The antigen chain, heavy chain, light chain, and epitope residues from each of the 64 antigens used for testing OptMAVEn-2.0, Table S4: The antigen chains and epitope residues of the designs used in the test cases.

Author Contributions

R.C., M.F.A., and C.D.M. conceived the study. R.C. and M.F.A. performed all the simulations and analyzed the results.

Funding

This research received no external funding.

Acknowledgments

All simulations were performed using the Lion-XF InfiniBand and ICS-ACI cyberinfrastructure comprising dual 12-core Xeon E5-2680 processors, operated by Red Hat Enterprise Linux 6.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Ecker, D.M.; Jones, S.D.; Levine, H.L. The therapeutic monoclonal antibody market. mAbs 2015, 7, 9–14. [Google Scholar] [CrossRef] [PubMed]
  2. Mahmuda, A.; Bande, F.; Al-Zihiry, K.J.K.; Abdulhaleem, N.; Majid, R.A.; Hamat, R.A.; Abdullah, W.O.; Unyah, Z. Monoclonal antibodies: A review of therapeutic applications and future prospects. Trop. J. Pharm. Res. 2017, 16, 713–722. [Google Scholar] [CrossRef]
  3. Shepard, H.M.; Phillips, G.L.; Thanos, C.D.; Feldmann, M. Developments in therapy with monoclonal antibodies and related proteins. Clin. Med. J. R. Coll. Physicians 2017, 17, 220–232. [Google Scholar] [CrossRef] [PubMed]
  4. Schirrmann, T.; Meyer, T.; Schütte, M.; Frenzel, A.; Hust, M. Phage display for the generation of antibodies for proteome research, diagnostics and therapy. Molecules 2011, 16, 412–426. [Google Scholar] [CrossRef] [PubMed]
  5. Byrne, H.; Conroy, P.J.; Whisstock, J.C.; O’Kennedy, R.J. A tale of two specificities: Bispecific antibodies for therapeutic and diagnostic applications. Trends Biotechnol. 2013, 31, 621–632. [Google Scholar] [CrossRef] [PubMed]
  6. Weiner, G.J. Building better monoclonal antibody-based therapeutics. Nat. Rev. Cancer 2015, 15, 361–370. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  7. Weiner, L.M.; Surana, R.; Wang, S. Monoclonal antibodies: Versatile platforms for cancer immunotherapy. Nat. Rev. Immunol. 2010, 10, 317–327. [Google Scholar] [CrossRef] [PubMed]
  8. Rudnick, S.I.; Adams, G.P. Affinity and Avidity in Antibody-Based Tumor Targeting. Cancer Biother. Radiopharm. 2009, 24, 155–161. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  9. Irani, V.; Guy, A.J.; Andrew, D.; Beeson, J.G.; Ramsland, P.A.; Richards, J.S. Molecular properties of human IgG subclasses and their implications for designing therapeutic monoclonal antibodies against infectious diseases. Mol. Immunol. 2015, 67, 171–182. [Google Scholar] [CrossRef] [PubMed]
  10. Simpson, E.L.; Bieber, T.; Guttman-Yassky, E.; Beck, L.A.; Blauvelt, A.; Cork, M.J.; Silverberg, J.I.; Deleuran, M.; Kataoka, Y.; Lacour, J.-P.; et al. Two Phase 3 Trials of Dupilumab versus Placebo in Atopic Dermatitis. N. Engl. J. Med. 2016, 375, 2335–2348. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  11. Saper, C.B. A guide to the perplexed on the specificity of antibodies. J. Histochem. Cytochem. 2009, 57, 1–5. [Google Scholar] [CrossRef] [PubMed]
  12. Shriver, Z.; Trevejo, J.M.; Sasisekharan, R. Antibody-based strategies to prevent and treat influenza. Front. Immunol. 2015, 6, 315. [Google Scholar] [CrossRef] [PubMed]
  13. Saeed, A.F.; Wang, R.; Ling, S.; Wang, S. Antibody engineering for pursuing a healthier future. Front. Microbiol. 2017, 8, 495. [Google Scholar] [CrossRef] [PubMed]
  14. Boder, E.T.; Raeeszadeh-Sarmazdeh, M.; Price, J.V. Engineering antibodies by yeast display. Arch. Biochem. Biophys. 2012, 526, 99–106. [Google Scholar] [CrossRef] [PubMed]
  15. Leenaars, M.; Hendriksen, C.F.M. Critical steps in the production of polyclonal and monoclonal antibodies: Evaluation and recommendations. ILAR J. 2005, 46, 269–279. [Google Scholar] [CrossRef] [PubMed]
  16. Li, T.; Pantazes, R.J.; Maranas, C.D. OptMAVEn—A new framework for the de novo design of antibody variable region models targeting specific antigen epitopes. PLoS ONE 2014, 9. [Google Scholar] [CrossRef] [PubMed]
  17. Pantazes, R.J.; Maranas, C.D. OptCDR: A general computational method for the design of antibody complementarity determining regions for targeted epitope binding. Protein Eng. Des. Sel. 2010, 23, 849–858. [Google Scholar] [CrossRef] [PubMed]
  18. Lapidoth, G.D.; Baran, D.; Pszolla, G.M.; Norn, C.; Alon, A.; Tyka, M.D.; Fleishman, S.J. AbDesign: An algorithm for combinatorial backbone design guided by natural conformations and sequences. Proteins Struct. Funct. Bioinform. 2015, 83, 1385–1406. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  19. Adolf-Bryfogle, J.; Kalyuzhniy, O.; Kubitz, M.; Weitzner, B.D.; Hu, X.; Adachi, Y.; Schief, W.R.; Dunbrack, R.L., Jr. Rosetta Antibody Design (RAbD): A General Framework for Computational Antibody Design. PLoS Comput. Biol. 2018, 14, e1006112. [Google Scholar] [CrossRef] [PubMed]
  20. Lazar, G.A.; Desjarlais, J.R.; Jacinto, J.; Karki, S.; Hammond, P.W. A molecular immunology approach to antibody humanization and functional optimization. Mol. Immunol. 2007, 44, 1996–2008. [Google Scholar] [CrossRef] [PubMed]
  21. De Groot, A.S.; McMurry, J.; Moise, L. Prediction of immunogenicity: In silico paradigms, ex vivo and in vivo correlates. Curr. Opin. Pharmacol. 2008, 8, 620–626. [Google Scholar] [CrossRef] [PubMed]
  22. Chennamsetty, N.; Voynov, V.; Kayser, V.; Helk, B.; Trout, B.L. Design of therapeutic proteins with enhanced stability. Proc. Natl. Acad. Sci. USA 2009, 106, 11937–11942. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  23. Miklos, A.E.; Kluwe, C.; Der, B.S.; Pai, S.; Sircar, A.; Hughes, R.A.; Berrondo, M.; Xu, J.; Codrea, V.; Buckley, P.E.; et al. Structure-based design of supercharged, highly thermoresistant antibodies. Chem. Biol. 2012, 19, 449–455. [Google Scholar] [CrossRef] [PubMed]
  24. Der, B.S.; Kluwe, C.; Miklos, A.E.; Jacak, R.; Lyskov, S.; Gray, J.J.; Georgiou, G.; Ellington, A.D.; Kuhlman, B. Alternative Computational Protocols for Supercharging Protein Surfaces for Reversible Unfolding and Retention of Stability. PLoS ONE 2013, 8, e64363. [Google Scholar] [CrossRef] [PubMed]
  25. Pantazes, R.J.; Maranas, C.D. MAPs: A database of modular antibody parts for predicting tertiary structures and designing affinity matured antibodies. BMC Bioinform. 2013, 14, 168. [Google Scholar] [CrossRef] [PubMed]
  26. Stojmirovic, A. Quasi-metric spaces with measure. Topol. Proc. 2004, 28, 655–671. [Google Scholar]
  27. Moré, J.J.; Wu, Z. Distance Geometry Optimization for Protein Structures. J. Glob. Optim. 1999, 15, 219–234. [Google Scholar] [CrossRef]
  28. Stojmirovic, A.; Yu, Y. Information channels in protein interaction networks. arXiv, 2009; arXiv:0901.0287. [Google Scholar]
  29. Ribeiro, J.V.; Bernardi, R.C.; Rudack, T.; Stone, J.E.; Phillips, J.C.; Freddolino, P.L.; Schulten, K. QwikMD—Integrative Molecular Dynamics Toolkit for Novices and Experts. Sci. Rep. 2016, 6. [Google Scholar] [CrossRef] [PubMed]
  30. Pantazes, R.J.; Grisewood, M.J.; Li, T.; Gifford, N.P.; Maranas, C.D. The Iterative Protein Redesign and Optimization (IPRO) suite of programs. J. Comput. Chem. 2015, 36, 251–263. [Google Scholar] [CrossRef] [PubMed]
  31. Python Software Foundation. Python Language Reference, version 2.7; Python Software Foundation: Wilmington, DE, USA, 2013. [Google Scholar]
  32. Community, N. NumPy Reference. 2011. Available online: https://docs.scipy.org/doc/numpy-1.13.0/reference/ (accessed on 20 May 2018).
  33. Oliphant, T.E. SciPy: Open source scientific tools for Python. Comput. Sci. Eng. 2007. [Google Scholar] [CrossRef]
  34. Cock, P.J.A.; Antao, T.; Chang, J.T.; Chapman, B.A.; Cox, C.J.; Dalke, A.; Friedberg, I.; Hamelryck, T.; Kauff, F.; Wilczynski, B.; et al. Biopython: Freely available Python tools for computational molecular biology and bioinformatics. Bioinformatics 2009, 25, 1422–1423. [Google Scholar] [CrossRef] [PubMed]
  35. Brooks, B.R.; Brooks, C.L.; Mackerell, A.D.; Nilsson, L.; Petrella, R.J.; Roux, B.; Won, Y.; Archontis, G.; Bartels, C.; Boresch, S.; et al. CHARMM: The biomolecular simulation program. J. Comput. Chem. 2009, 30, 1545–1614. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  36. Humphrey, W.; Dalke, A.; Schulten, K. VMD: Visual molecular dynamics. J. Mol. Graph. 1996, 14, 33–38. [Google Scholar] [CrossRef]
  37. Phillips, J.C.; Braun, R.; Wang, W.; Gumbart, J.; Tajkhorshid, E.; Villa, E.; Chipot, C.; Skeel, R.D.; Kalé, L.; Schulten, K. Scalable molecular dynamics with NAMD. J. Comput. Chem. 2005, 26, 1781–1802. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  38. Lefranc, M.-P. IMGT Unique Numbering for the Variable (V), Constant (C), and Groove (G) Domains of IG, TR, MH, IgSF, and MhSF. Cold Spring Harb. Protoc. 2011, 2011, 633–642. [Google Scholar] [CrossRef] [PubMed]
  39. Henikoff, S.; Henikoff, J.G. Amino acid substitution matrices from protein blocks. Proc. Natl. Acad. Sci. USA 1992, 89, 10915–10919. [Google Scholar] [CrossRef] [PubMed]
  40. Havel, T.; Kuntz, I.; Crippen, G. The theory and practice of distance geometry. Bull. Math. Biol. 1983, 45, 665–720. [Google Scholar] [CrossRef]
  41. Mucherino, A.; Liberti, L.; Lavor, C. MD-jeep: An implementation of a Branch and Prune algorithm for distance geometry problems. In Mathematical Software—ICMS 2010; Lecture Notes in Computer Science; Springer: Berlin/Heidelberg, Germany, 2010; pp. 186–197. [Google Scholar]
  42. Schwieters, C.D.; Kuszewski, J.J.; Tjandra, N.; Clore, G.M. The Xplor-NIH NMR molecular structure determination package. J. Magn. Reson. 2003, 160, 65–73. [Google Scholar] [CrossRef]
  43. Pappu, R.V.; Hart, R.K.; Ponder, J.W. Tinker: A package for molecular dynamics simulation. J. Phys. Chem. B 1988, 102, 9725–9742. [Google Scholar] [CrossRef]
  44. Marimont, R.B.; Shapiro, M.B. Nearest neighbour searches and the curse of dimensionality. IMA J. Appl. Math. 1979, 24, 59–70. [Google Scholar] [CrossRef]
  45. Wang, Q.; Yang, H.; Liu, X.; Dai, L.; Ma, T.; Qi, J.; Wong, G.; Peng, R.; Liu, S.; Li, J. Molecular determinants of human neutralizing antibodies isolated from a patient infected with Zika virus. Sci. Transl. Med. 2016, 8. [Google Scholar] [CrossRef] [PubMed]
  46. Zhao, H.; Fernandez, E.; Dowd, K.A.; Speer, S.D.; Platt, D.J.; Gorman, M.J.; Govero, J.; Nelson, C.A.; Pierson, T.C.; Diamond, M.S. Structural Basis of Zika Virus-Specific Antibody Protection. Cell 2016. [Google Scholar] [CrossRef] [PubMed]
  47. Holmes, M.A.; Buss, T.N.; Foote, J. Conformational correction mechanisms aiding antigen recognition by a humanized antibody. J. Exp. Med. 1998, 187, 479–485. [Google Scholar] [CrossRef] [PubMed]
  48. Wensley, B. Structure of a Lysozyme Antibody Complex. Available online: https://www.rcsb.org/structure/4TSB (accessed on 20 May 2018).
  49. Rouet, R.; Dudgeon, K.; Christie, M.; Langley, D.; Christ, D. Fully human VH single domains that rival the stability and cleft recognition of camelid antibodies. J. Biol. Chem. 2015. [Google Scholar] [CrossRef] [PubMed]
  50. Soria-Guerra, R.E.; Nieto-Gomez, R.; Govea-Alonso, D.O.; Rosales-Mendoza, S. An overview of bioinformatics tools for epitope prediction: Implications on vaccine development. J. Biomed. Inform. 2015, 53, 405–414. [Google Scholar] [CrossRef] [PubMed]
  51. Rice, P.; Longden, L.; Bleasby, A. EMBOSS: The European Molecular Biology Open Software Suite. Trends Genet. 2000. [Google Scholar] [CrossRef]
  52. Poosarla, V.G.; Li, T.; Goh, B.C.; Schulten, K.; Wood, T.K.; Maranas, C.D. Computational de novo design of antibodies binding to a peptide with high affinity. Biotechnol. Bioeng. 2017, 114, 1331–1342. [Google Scholar] [CrossRef] [PubMed]
  53. Foote, J.; Eisen, H.N. Kinetic and affinity limits on antibodies produced during immune responses. Proc. Natl. Acad. Sci. USA 1995, 92, 1254–1256. [Google Scholar] [CrossRef] [PubMed]
  54. Fellouse, F.A.; Esaki, K.; Birtalan, S.; Raptis, D.; Cancasci, V.J.; Koide, A.; Jhurani, P.; Vasser, M.; Wiesmann, C.; Kossiakoff, A.A.; et al. High-throughput Generation of Synthetic Antibodies from Highly Functional Minimalist Phage-displayed Libraries. J. Mol. Biol. 2007. [Google Scholar] [CrossRef] [PubMed]
  55. Entzminger, K.C.; Hyun, J.M.; Pantazes, R.J.; Patterson-Orazem, A.C.; Qerqez, A.N.; Frye, Z.P.; Hughes, R.A.; Ellington, A.D.; Lieberman, R.L.; Maranas, C.D.; et al. De novo design of antibody complementarity determining regions binding a FLAG tetra-peptide. Sci. Rep. 2017, 7, 10295. [Google Scholar] [CrossRef] [PubMed]
  56. Checa, A.; Ortiz, A.R.; De Pascual-Teresa, B.; Gago, F. Assessment of solvation effects on calculated binding affinity differences: Trypsin inhibition by flavonoids as a model system for congeneric series. J. Med. Chem. 1997, 40, 4136–4145. [Google Scholar] [CrossRef] [PubMed]
  57. Lazaridis, T.; Karplus, M. Effective energy function for proteins in solution. Proteins 1999, 35, 133–152. [Google Scholar] [CrossRef] [Green Version]
  58. Choi, H.; Kang, H.; Park, H. New solvation free energy function comprising intermolecular solvation and intramolecular self-solvation terms. J. Cheminform. 2013, 5, 8. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  59. Duan, L.; Liu, X.; Zhang, J.Z.H. Interaction Entropy: A New Paradigm for Highly Efficient and Reliable Computation of Protein-Ligand Binding Free Energy. J. Am. Chem. Soc. 2016, 138, 5722–5728. [Google Scholar] [CrossRef] [PubMed]
  60. Kumar, S.; Singh, S.K.; Wang, X.; Rup, B.; Gill, D. Coupling of aggregation and immunogenicity in biotherapeutics: T- and B-cell immune epitopes may contain aggregation-prone regions. Pharm. Res. 2011, 28, 949–961. [Google Scholar] [CrossRef] [PubMed]
Figure 1. The workflow of OptMAVEn-2.0. First, the initial epitope positioning step rotates the antigen such that its epitope points downward with epitope centroid at the origin. The grid search step generates an ensemble of antigen positions, followed by the mixed-integer linear programming (MILP) step, where the six lowest interaction energy Modular Antibody Parts (MAPs) are chosen to construct the variable antibody fragment. A Euclidean coordinate for each part in the MAPs database was generated using the embedder module. The k-means protocol uses these and the epitope centroid coordinates and rotation angle to cluster the antibodies. The antibodies with the most negative MILP energy in each cluster are then subjected to structural relaxation and a short molecular dynamics (MD) routine to verify their high affinities. Stable designs emerging from this step could be affinity matured with the dual objective of enhancing their antigen-antibody affinities and lowering their immunogenic potentials.
Figure 1. The workflow of OptMAVEn-2.0. First, the initial epitope positioning step rotates the antigen such that its epitope points downward with epitope centroid at the origin. The grid search step generates an ensemble of antigen positions, followed by the mixed-integer linear programming (MILP) step, where the six lowest interaction energy Modular Antibody Parts (MAPs) are chosen to construct the variable antibody fragment. A Euclidean coordinate for each part in the MAPs database was generated using the embedder module. The k-means protocol uses these and the epitope centroid coordinates and rotation angle to cluster the antibodies. The antibodies with the most negative MILP energy in each cluster are then subjected to structural relaxation and a short molecular dynamics (MD) routine to verify their high affinities. Stable designs emerging from this step could be affinity matured with the dual objective of enhancing their antigen-antibody affinities and lowering their immunogenic potentials.
Antibodies 07 00023 g001
Figure 2. The grid search procedure. The antigen is first positioned such that (1) the centroid of its epitope is at the origin with the centroid of the antigen directly above it and (2) the z-rotation angle of the antigen (the angle between P0 and the positive x axis) is zero. An ensemble of positions of the antigen is generated by translating the centroid of the epitope or rotating the antigen around the z axis or both.
Figure 2. The grid search procedure. The antigen is first positioned such that (1) the centroid of its epitope is at the origin with the centroid of the antigen directly above it and (2) the z-rotation angle of the antigen (the angle between P0 and the positive x axis) is zero. An ensemble of positions of the antigen is generated by translating the centroid of the epitope or rotating the antigen around the z axis or both.
Antibodies 07 00023 g002
Figure 3. The steps involved in the embedder module. Actual values for HJ parts are provided as an example. First, the sequences are used to compute pairwise sequence similarity scores Sxy using the BLOSUM62 matrix and a gap penalty g. From Sxy, quasi-metric distances Qxy and their associated metric distances Dxy are computed (e.g., DHJ-1,HJ-2 = 4). Dxy can be visualized as a matrix or as a set of points and pairwise distances that cannot be embedded in Euclidean space. DGSOL generates Euclidean 3D coordinates for the points and computes the distances Dembed between every pair of parts (e.g., Dembed: HJ-1,HJ-2 = 4.06). It minimizes the sum of squared differences between corresponding aligned (Dxy) and embedded (Dembed) distances (e.g., [DHJ-1,HJ-2Dembed: HJ-1,HJ-2]2 = 0.0036). The Spearman rank correlation between Dalign and Dembed is used to assess the quality of the embedding. If it is an abbreviation, please define.
Figure 3. The steps involved in the embedder module. Actual values for HJ parts are provided as an example. First, the sequences are used to compute pairwise sequence similarity scores Sxy using the BLOSUM62 matrix and a gap penalty g. From Sxy, quasi-metric distances Qxy and their associated metric distances Dxy are computed (e.g., DHJ-1,HJ-2 = 4). Dxy can be visualized as a matrix or as a set of points and pairwise distances that cannot be embedded in Euclidean space. DGSOL generates Euclidean 3D coordinates for the points and computes the distances Dembed between every pair of parts (e.g., Dembed: HJ-1,HJ-2 = 4.06). It minimizes the sum of squared differences between corresponding aligned (Dxy) and embedded (Dembed) distances (e.g., [DHJ-1,HJ-2Dembed: HJ-1,HJ-2]2 = 0.0036). The Spearman rank correlation between Dalign and Dembed is used to assess the quality of the embedding. If it is an abbreviation, please define.
Antibodies 07 00023 g003
Figure 4. The optimal gap penalty (g) is 8. For each category of MAPs parts and each gap penalty g (4 to 12), pairwise aligned (Dalign) and embedded (Dembed) distances were generated. (a,b) The z-score of RMSE between these distances the values of ρ were computed. Progressively increasing g led to a higher (desired) ρ and a higher (undesired) RMSE z-score with the exception of g = 10, which showed lower ρ and higher RMSE z-score than did g = 8; (c) The average rank of each g level for ρ and RMSE reveals g = 8 to be the best with an average rank 2.1.
Figure 4. The optimal gap penalty (g) is 8. For each category of MAPs parts and each gap penalty g (4 to 12), pairwise aligned (Dalign) and embedded (Dembed) distances were generated. (a,b) The z-score of RMSE between these distances the values of ρ were computed. Progressively increasing g led to a higher (desired) ρ and a higher (undesired) RMSE z-score with the exception of g = 10, which showed lower ρ and higher RMSE z-score than did g = 8; (c) The average rank of each g level for ρ and RMSE reveals g = 8 to be the best with an average rank 2.1.
Antibodies 07 00023 g004
Figure 5. A 3D coordinate was computed for each MAPs part. For each pair of MAPs parts within each category, the two parts’ embedded distance in Euclidean space was plotted against their sequence alignment distance.
Figure 5. A 3D coordinate was computed for each MAPs part. For each pair of MAPs parts within each category, the two parts’ embedded distance in Euclidean space was plotted against their sequence alignment distance.
Antibodies 07 00023 g005
Figure 6. The native and 5gzn_R0 antigens remained stably bound (RMSD < 6 Å), while the 5gzn_R27 antigen remained partially bound (6 Å < RMSD < 12 Å) throughout the MD simulations. Heavy-atom RMSDs of antigen residues within a box at the antigen-antibody interface were computed after aligning the antibody residues within the box. The RMSDs for each complex are relative to the first frame (time 0 ns) of the production run.
Figure 6. The native and 5gzn_R0 antigens remained stably bound (RMSD < 6 Å), while the 5gzn_R27 antigen remained partially bound (6 Å < RMSD < 12 Å) throughout the MD simulations. Heavy-atom RMSDs of antigen residues within a box at the antigen-antibody interface were computed after aligning the antibody residues within the box. The RMSDs for each complex are relative to the first frame (time 0 ns) of the production run.
Antibodies 07 00023 g006
Figure 7. The key interactions at the antigen-antibody interface post-MD simulations for native, 5gzn_R0, and 5gzn_R27 have been depicted. The light and heavy chain residues are shown as magenta and cyan sticks, respectively, while antigen residues are depicted as green sticks.
Figure 7. The key interactions at the antigen-antibody interface post-MD simulations for native, 5gzn_R0, and 5gzn_R27 have been depicted. The light and heavy chain residues are shown as magenta and cyan sticks, respectively, while antigen residues are depicted as green sticks.
Antibodies 07 00023 g007
Table 1. For each category of MAPs parts, the levels of the gap penalty g were ranked from 1 to 5 on the basis of ρ (highest ρ is rank 1) and RMSE (lowest RMSE is rank 1). J parts were excluded because for the J parts, ρ and RMSE are independent of g, as their sequences are devoid of residue gaps.
Table 1. For each category of MAPs parts, the levels of the gap penalty g were ranked from 1 to 5 on the basis of ρ (highest ρ is rank 1) and RMSE (lowest RMSE is rank 1). J parts were excluded because for the J parts, ρ and RMSE are independent of g, as their sequences are devoid of residue gaps.
CategoryCriterionGap Penalty (g)
Rank 1Rank 2Rank 3Rank 4Rank 5
HVρ1286104
HCDR3ρ1286410
KVρ1286410
KCDR3ρ1281064
LVρ1286410
LCDR3ρ1286410
HVRMSE4681012
HCDR3RMSE6812410
KVRMSE4861210
KCDR3RMSE8612410
LVRMSE4861210
LCDR3RMSE4681210
Table 2. The performance of OptMAVEn on 10 antigens for benchmarking.
Table 2. The performance of OptMAVEn on 10 antigens for benchmarking.
AntigenTposTenerTMILPTCPUDmaxEminNpos
1NSN32.7214.226.8273.71004−658.72428
2IGF2.120.026.448.4820−76.43023
2R0W2.017.820.240.0779−277.0 *2955
2VXQ26.1174.419.6220.1970−174.52711
2ZUQ41.6290.918.8351.41094−346.02645
3BKY5.054.833.793.5824−216.13035
3FFD5.335.019.559.8657+576.62347
3G5V22.033.120.875.9808−309.92976
3L5W29.6173.924.4227.91008−281.42798
3MLS5.853.021.980.7809−249.62903
Tpos, Tener, TMILP, and TCPU are in hours; Dmax is in megabytes; Emin is the CHARMM binding energy score. * 2R0W was excluded from analysis of Emin.
Table 3. The performance of OptMAVEn-2.0 on 10 antigens for benchmarking.
Table 3. The performance of OptMAVEn-2.0 on 10 antigens for benchmarking.
AntigenTposTenerTMILPTCPUDmaxEminNpos
1NSN0.03622.31.824.2142.4−438.1442
2IGF0.00926.15.631.7169.7−118.51374
2R0W0.01022.44.927.4152.9−127.9 *1204
2VXQ0.03333.73.637.4135.4−235.3893
2ZUQ0.04640.43.243.6167.3−131.3774
3BKY0.01133.96.740.6197.4−208.41647
3FFD0.01410.92.013.083.8+92.6492
3G5V0.01221.04.225.2137.6−458.51035
3L5W0.03336.43.840.2144.7−394.0910
3MLS0.00918.03.321.3114.7−171.2807
Tpos, Tener, TMILP, and TCPU are in hours; Dmax is in megabytes; Emin is the CHARMM binding energy score. * 2R0W was excluded from analysis of Emin.
Table 4. Comparison of the performances of OptMAVEn and OptMAVEn-2.0 on 10 antigens.
Table 4. Comparison of the performances of OptMAVEn and OptMAVEn-2.0 on 10 antigens.
AntigenTposTenerTMILPTCPUDmaxEminNpos
1NSN−2.96−0.982−1.162−1.053−0.848+220.6−0.740
2IGF−2.35+0.116−0.674−0.184−0.684−42.1−0.342
2R0W−2.29+0.102−0.613−0.165−0.707+149.1 *−0.390
2VXQ−2.90−0.714−0.732−0.770−0.855−60.8−0.482
2ZUQ−2.95−0.857−0.774−0.906−0.815+214.6−0.534
3BKY−2.65−0.208−0.700−0.362−0.620+7.7−0.265
3FFD−2.58−0.505−0.984−0.663−0.895−484.0−0.679
3G5V−3.27−0.198−0.698−0.479−0.769−148.6−0.459
3L5W−2.95−0.680−0.806−0.753−0.843−112.6−0.488
3MLS−2.80−0.469−0.823−0.578−0.848+78.4−0.556
Shapiro P6.0 × 10−15.8 × 10−11.0 × 10−18.2 × 10−11.8 × 10−13.6 × 10−19.4 × 10−1
mean−2.77−0.440−0.797−0.591−0.788−36.3−0.494
s. d.0.3030.3830.1640.2960.090213.20.145
p-value3.5 × 10−105.5 × 10−39.2 × 10−81.4 × 10−45.0 × 10−106.2 × 10−11.9 × 10−6
mean (ratio)0.0020.3630.1600.2560.163n/a0.321
% reduction99.863.784.074.483.7n/a67.9
Tpos, Tener, TMILP, TCPU, Dmax, and Npos report the log10 of the ratios of the corresponding OptMAVEn-2.0 and OptMAVEn values. Emin reports the difference of the corresponding OptMAVEn-2.0 and OptMAVEn values. The Shapiro-Wilk test shows that every set of values is close to normal (p > 0.05). OptMAVEn-2.0 performed significantly better (p-value < 0.05) in Tpos, Tener, TMILP, TCPU, and Dmax and yielded designs of equivalent Emin (p-value = 0.79). The mean (ratio) gives, for the quantities reported as log10 ratios, the value of the mean ratio (i.e., 10mean). The % reduction is 100%–mean (ratio). * 2R0W was excluded from analysis of Emin.
Table 5. OptMAVEn-2.0 was tested on 54 antigens in addition to those used for benchmarking against OptMAVEn.
Table 5. OptMAVEn-2.0 was tested on 54 antigens in addition to those used for benchmarking against OptMAVEn.
AntigenNresNatomNposTCPUDmaxEmin
1ACY10156155840.9188.3−370.6
1CE1893169444.3200.9−513.3
1CFT584155438.9187.9−253.5
1DZB129195874942.2136.3−775.8
1EGJ101164365034.1106.9−618.6
1F909156132835.0165.8−377.5
1FPT11162147838.4180.0−455.6
1HH61115971820.8104.6−385.5
1I8I9142148038.4179.7−350.8
1JHL129196298553.7132.3−766.6
1JRH95149139721.999.6−541.4
1KC58119129936.8162.1−376.1
1KIQ129196873041.4119.1−750.1
1MLC129196861835.9111.2−752.0
1N641624199028.1132.9−386.6
1NAK10166119241.5154.1−393.3
1OBE1319541713.577.9−397.0
1ORS1322146100155.7162.4−625.5
1PZ58124134834.1167.4−419.5
1QNZ1830157518.591.4−367.3
1SM39126135434.8167.9−454.2
1TQB102165948926.8104.1−534.6
1V7M145225858837.5115.4−561.0
1XGY685181145.4212.8−293.1
1ZA3911346717.591.8−758.7
2A6I9136109329.1141.8−365.2
2BDN68110681035.2115.1−740.6
2DQJ129196859034.0111.6−852.4
2FJH98156531218.499.7−528.8
2H1P1118256117.090.4−355.0
2HH09151106228.6140.0−282.7
2HRP10177101327.9135.4−366.5
2IFF129196659533.9126.7−594.4
2JEL85129359628.1101.9−539.5
2OR91118173421.1106.7−387.8
2QHR1118576120.3111.3−340.2
2R2997155364133.2105.3−698.4
3AB0136195538023.9107.8−765.0
3BDY95152177936.3133.9−439.7
3CVH8142116830.7149.6−333.7
3D85133207444127.9109.8−717.0
3E8U11136148138.1180.8−431.4
3ETB144233229621.8111.3−898.6
3F5811136131734.6168.5−322.6
3G6D106166741824.2103.2−876.8
3GHB10146134133.5166.7−383.4
3GHE1525577326.9112.2−430.1
3HR59142134038.4166.5−478.7
3KS0921443114854.3148.0−578.5
3MLX1423562120.594.7−367.7
3NFP124190929219.7104.5−771.6
3P30841437324.765.2−714.9
3QG66105142536.1175.2−362.4
3RKD146218577646.1124.5−793.7
TCPU is in hours, Dmax is in megabytes, and Emin is the CHARMM binding energy score.
Table 6. Comparison of HScores of the top five de novo designs with the HScores of the native antibodies.
Table 6. Comparison of HScores of the top five de novo designs with the HScores of the native antibodies.
AccessionAntibody Name (from Paper)Native Heavy Chain HScoreDesigned Heavy Chain HScoresNative Light Chain HScoreDesigned Light Chain HScores
5GZNZ3L15217–36416–41
5KVDZV-21526–59560–31
5KVEZV-4812821–68591–27
5KVFZV-6410721–442222–30
5KVGZV-6713310–3911110–25
Table 7. Comparison of HScores of the top five de novo designs with the HScores of the native antibodies.
Table 7. Comparison of HScores of the top five de novo designs with the HScores of the native antibodies.
AccessionNative Heavy Chain HScoreDesigned Heavy Chain HScoresNative Light Chain HScoreDesigned Light Chain HScores
1BVK8510–37577–27
4TSB2612–322116–38
4PGJ8720–49N/A5–39

Share and Cite

MDPI and ACS Style

Chowdhury, R.; Allan, M.F.; Maranas, C.D. OptMAVEn-2.0: De novo Design of Variable Antibody Regions against Targeted Antigen Epitopes. Antibodies 2018, 7, 23. https://doi.org/10.3390/antib7030023

AMA Style

Chowdhury R, Allan MF, Maranas CD. OptMAVEn-2.0: De novo Design of Variable Antibody Regions against Targeted Antigen Epitopes. Antibodies. 2018; 7(3):23. https://doi.org/10.3390/antib7030023

Chicago/Turabian Style

Chowdhury, Ratul, Matthew F. Allan, and Costas D. Maranas. 2018. "OptMAVEn-2.0: De novo Design of Variable Antibody Regions against Targeted Antigen Epitopes" Antibodies 7, no. 3: 23. https://doi.org/10.3390/antib7030023

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

Article Metrics

Back to TopTop