Skip to main content
PLOS Computational Biology logoLink to PLOS Computational Biology
. 2020 Jul 8;16(7):e1007970. doi: 10.1371/journal.pcbi.1007970

Real time structural search of the Protein Data Bank

Dmytro Guzenko 1, Stephen K Burley 1,2,3,4, Jose M Duarte 1,*
Editor: Charlotte M Deane5
PMCID: PMC7371193  PMID: 32639954

Abstract

Detection of protein structure similarity is a central challenge in structural bioinformatics. Comparisons are usually performed at the polypeptide chain level, however the functional form of a protein within the cell is often an oligomer. This fact, together with recent growth of oligomeric structures in the Protein Data Bank (PDB), demands more efficient approaches to oligomeric assembly alignment/retrieval. Traditional methods use atom level information, which can be complicated by the presence of topological permutations within a polypeptide chain and/or subunit rearrangements. These challenges can be overcome by comparing electron density volumes directly. But, brute force alignment of 3D data is a compute intensive search problem. We developed a 3D Zernike moment normalization procedure to orient electron density volumes and assess similarity with unprecedented speed. Similarity searching with this approach enables real-time retrieval of proteins/protein assemblies resembling a target, from PDB or user input, together with resulting alignments (http://shape.rcsb.org).

Author summary

Protein structures possess wildly varied shapes, but patterns at different levels are frequently reused by nature. Finding and classifying these similarities is fundamental to understand evolution. Given the continued growth in the number of known protein structures in the Protein Data Bank, the task of comparing them to find the common patterns is becoming increasingly complicated. This is especially true when considering complete protein assemblies with several polypeptide chains, where the large sizes further complicate the issue. Here we present a novel method that can detect similarity between protein shapes and that works equally fast for any size of proteins or assemblies. The method looks at proteins as volumes of density distribution, departing from what is more usual in the field: similarity assessment based on atomic coordinates and chain connectivity. A volumetric function is amenable to be decomposed with a mathematical tool known as 3D Zernike polynomials, resulting in a compact description as vectors of Zernike moments. The tool was introduced in the 1990s, when it was suggested that the moments could be normalized to be invariant to rotations without losing information. Here we demonstrate that in fact this normalization is possible and that it offers a much more accurate method for assessing similarity between shapes, when compared to previous attempts.

Introduction

Structure similarity searching within the growing PDB archive [1, 2] revolutionized our understanding of protein evolution [3, 4, 5]. Over billions of years organisms in the natural world have generated stable, functionally useful three-dimensional protein shapes, which have been repeatedly reused on scales ranging from short structural motifs to oligomeric complexes. With more than 150,000 publicly-available PDB structures, efficient methods for detecting and quantifying protein structure similarity are essential.

Structure superposition tools were initially developed in the 1970s [6, 7] and the first algorithms for general structural alignment came in the 1990s [8, 9, 10], with more advanced methods appearing over the following decade [11, 12, 13, 14]. As the PDB grew, efficient searching of the entire archive became both important and difficult. Archive wide retrieval was first addressed by the Dali server [15] and subsequently by PDBeFold [16] and TopSearch [17] (see Hasegawa and Holm [18] for a review of the field). With a few exceptions, these methods have focused on the task of aligning single polypeptide chains or parts thereof.

Protein functional units are, however, not necessarily confined to the boundaries of domains or individual chains. They are often oligomeric, sometimes with multiple distinct quaternary structures resulting in similar functional units. Today, approximately half of the structures in the PDB are oligomeric (as of April 2020). In the wake of the 3DEM “resolution revolution” the fraction of oligomeric structures represented in the archive is growing year-on-year.

The ever-increasing amount of structural data, combined with rising complexity of the structures, requires development of faster, more accurate methods to process and classify structure similarity. Traditional comparison methods use atom level information, which can be complicated by the presence of topological permutations within a polypeptide chain and/or subunit rearrangement(s) within an oligomeric assembly. While solutions that address these problems exist [14, 19, 20, 21], they are computationally expensive and will not necessarily scale with continued growth of the PDB.

Alternative approaches looking beyond purely atomic information have been explored. One utilizes geometric descriptors, e.g., interatomic distance distributions, yielding fast but less precise methods [22, 23]. Other related methods compare surface shapes. This research community has coalesced around the SHREC 3D shape retrieval contest [24], which occasionally features a protein track (most recently in [25]). For surface descriptor-based protein structure analysis, 3D-Surfer [26] has implemented a fast shape comparison service with numerous applications [27]. Surface descriptions of proteins, however, completely disregard information contained in the density distribution beneath the surface. These challenges can be circumvented by aligning and comparing electron density volumes. However, this has proven to result in a computationally-intensive search problem [28, 29, 30].

Herein, we exploit a 3D Zernike moment normalization procedure to implicitly orient electron density volumes and assess similarity in moment space with unprecedented speed. The general approach was suggested in [31] but has not been applied to date. Our normalization procedure produces rotation-invariant features that retain information about the shape of the original object. Differences in features can be readily visualized. This approach to shape retrieval is highly performant, yielding structure alignments as byproducts of the normalization procedure. Since the method uses electron density volumes, it is agnostic with respect to topological differences in either the tertiary or quaternary structures.

Based on these principles, we have developed a search system that enables real-time retrieval of similar protein assemblies to a target assembly, obtained from the PDB or uploaded by a user, together with their alignment (http://shape.rcsb.org). The system uses coarse grained volumes created out of atomic models, though the method presented here is applicable to any kind of volume, be it experimental or simulated. An exhaustive search of 600,000+ bioassemblies and chains in the PDB requires less than one second on a single core of a typical CPU (e.g., Intel Core i7-7567U), without precomputed clustering or results caching. The BioZernike software library used for normalizations and alignments is open source and freely available (https://github.com/biocryst/biozernike).

Methods

We follow the derivations by Canterakis in [31], who introduced 3D Zernike polynomial decomposition of an arbitrary volumetric function f(x) defined in the unit sphere (illustrated in Fig 1):

f(x)=n,l,mΩnlmZnlm(x), (1)

where

Znlm(x)=Rnl(|x|)Ylm(x|x|) (2)

are the (orthonormal in unit sphere) 3D Zernike polynomial functions, Ωnlm the corresponding moments, n ∈ [0, N] (with N the maximum polynomial order of the decomposition). l and m are the degree and order of the spherical harmonic functions Ylm, l ∈ [0, n] so that (nl) is even, and m ∈ [−l, l]. Rnl are the radius-dependent normalizing factors.

Fig 1. Electron density decomposition into 3D Zernike moments, using human deoxyhaemoglobin (PDB ID 4HHB).

Fig 1

Top Layer: values of weighted 3D Zernike functions of order n in gradient from red (negative) to blue (positive). Bottom Layer: reconstruction of order n obtained by summation of all values up to order n (only positive density is shown).

The moments can be expressed as a (2l + 1)-dimensional vector

Ωnl=(Ωnll,Ωnll-1,Ωnll-2,,Ωnl-l) (3)

whose norm corresponds to the trivial rotational invariant descriptor (3DZD) popularised by Novotni and Klein [32]:

Fnl=Ωnl (4)

Canterakis norms for complete 3D zernike moment invariants

As in [33], we use ζ-coding for 3D Zernike moment rotation. Briefly, given Cayley-Klein parameters a and b which define a rotation R(a, b):

R(a,b)=(R{a2+b2}-I{a2-b2}2I{ab}I{a2+b2}R{a2-b2}-2R{ab}2I{ab*}2R{ab*}aa*-bb*), (5)

where a,bC and

aa*+bb*=1, (6)

and the modified 3D Zernike moments

Ω^nlm=1clmΩnlm, (7)

where

clm=(2l+1)(l+m)!(l-m)!l!, (8)

the rotation can be expressed as:

(Ω^R)nl(ζ)=((a*ζ-b)(b*ζ+a)ζ)l·Ω^nl(a*ζ-bb*ζ+a) (9)

To obtain the rotated value for a particular (Ω^R)nlm, we expand expression 9 and collect coefficients for ζm. For example,

(Ω^R)222=a4Ω^222-a3b*Ω^221+a2(b*)2Ω^220+a(b*)3(Ω^221)*+(b*)4(Ω^222)* (10)

As the SO(3) group has three degrees of freedom and Zernike moments are complex numbers, we follow by setting one moment and the imaginary part of another to zeros (see Fig 2a). In terms of computation, this corresponds to solving a system of two polynomial equations.

Fig 2. Moment normalization.

Fig 2

(a) Rotational degrees of freedom are fixed by constraining values of chosen moments with respect to the 3D rotation group. The solution defines a rotation of the weighted 3D Zernike functions to a ‘standard’ position. (b) Alignment of two structures of human transportin 3: in unliganded form (4C0P) and in complex with ASF/SF2 (4C0O). Normalization order 2 is equivalent to alignment of the densities’ principal axes. Normalization order 6 matches finer detail in the density, such as α-helical bundles, at the expense of reduced overlap at the termini. (c) Multiple density alignment of 10 homologs of human transportin 3 as performed by the BioZernike library. Normalization order 4 is selected automatically with the alignment descriptor (see Methods).

Let us continue with the example 10 and fix the first two degrees of rotational freedom by setting (Ω^R)222=0. After substitution ab*t we obtain a 4th degree polynomial equation in t:

Ω^222t4-Ω^221t3+Ω^220t2+(Ω^221)*t+(Ω^222)*=0 (11)

that can be solved trivially using libraries of mathematical routines. (N.B. Both the coefficients of the polynomial and its roots are complex numbers).

Next, we fix one more degree of freedom by setting the imaginary part of another moment to 0. Let us choose I{Ω^311}=0 for this example. Following algebraic manipulations, we obtain a 2nd degree equation in I{b}R{b}s:

(I{t}(Ω^310-2R{Ω^311}R{t})+I{Ω^311}(-1+I{t}2-R{t}2))s2+2(R{t}*(Ω^310+2I{Ω^311}I{t})+R{Ω^311}(1+I{t}2-R{t}2))s+2R{Ω^311}I{t}R{t}-Ω^310I{t}+I{Ω^311}(1-I{t}2+R{t}2)=0 (12)

Assuming ℜ{b}>0 without loss of generality, solving Eqs 11 and 12, and using identity 6 provides eight pairs of values for a and b:

b=1+is(1+|t|2)(1+s2) (13)
a=1-is(1+|t|2)(1+s2)·t (14)

which correspond to eight rotations defined by matrix 5. (N.B. The form of Eqs 11 and 12 depends only on the indices l and m, and therefore can be derived analytically in advance for efficient computation at run-time.)

Finally, the rotated 3D Zernike moments can be obtained from:

(ΩR)nlm=clm(aa*)l(ab)mμ=-llΩ^nlμ(-ab*)μk(l-μk-μ)(l+μk-m)(-bb*aa*)k (15)

BioZernike descriptors

BioZernike descriptors include two rotation-invariant shape descriptors: one based on the Canterakis Norms (CNs) and one based on the simple geometric features (GEO). In addition, we provide a CN-based alignment descriptor (Fig 3).

Fig 3. BioZernike descriptors workflow.

Fig 3

Every atomic structure in the PDB (a) is converted to a volume by selecting representative atoms per residue (b) and placing a gaussian density in their place (c). The geometric features (GEO) can be calculated directly from the representative atoms coordinates, whilst the Zernike moments and their Canterakis Norms of various orders are calculated out of the volume (note that different normalizations are offset in y axis for clarity) (d). The vector of concatenated geometric features and CNs of selected orders constitute the composite BioZernike shape descriptor. The distance between descriptors (composing both GEO and CNs) is calculated by learning optimal weights on a training set (e). The alignment descriptor is obtained directly from the CNs.

For the 3D Zernike moments calculation, the structure coordinates are converted to the volumetric representation as follows. First, the grid width is chosen in the range 0.25Å–16Å to keep the volume’s average dimension between 50Å and 200Å, if possible. Subsequently, for every representative atom a Gaussian density is placed into the volume that corresponds to the amino acid/nucleotide weight and spherically averaged size. Representative atoms are defined as Cα for amino acids and backbone phosphate groups for nucleotides. The volume is scaled into a unit sphere centered at the volume’s center of mass with the scaling coefficient defined as 1.8 times the structure’s gyration radius. Zernike moments are calculated up to the order of 20. CNs of orders n = 2, 3, 4, 5 are computed by setting (Ω^R)n22=0 if n is even and (Ω^R)n33=0 if n is odd. As the absolute values of the multiple solutions are averaged in each case, the third degree of freedom is lost and choice of a particular I{Ω^nlm}=0 has no effect. Every such CN for order N = 20 yields a vector of size 946 (expansion of the 3 indices n, l, m with negative m indices omitted), as opposed to 121 parameters obtained for a 3DZD (where index m is not present). The final CN-based descriptor is a concatenation of the CNs of chosen orders and has 3784 components.

For the vector of geometric features GEO, we calculate the distance distribution from the center of mass of the structure to all its representative atoms. Next, we include in the vector moments of this distribution: standard deviation, skewness, kurtosis, as well as 10th, 20th, …90th percentiles. In addition, we include the structure radius of gyration, nominal molecular weight, and standard deviation of the coordinates along the principal axes, corresponding to the dimensions of the structure. The final GEO descriptor has 17 components.

The alignment descriptor consists of two components: complete 3D Zernike moments calculated up to the order of 6 and the coordinates of the structure’s center of mass (required because this information is not preserved by the volume scaling procedure). To perform structure alignment, we compute all possible CNs of the given moments and find a normalization Ropt (and the induced rotation) that minimizes distance D(s1, s2|R) between the rotated moments of the structures s1 and s2 as follows:

D(s1,s2|R)=nlm|(ΩR)nlm(s1)-(ΩR)nlm(s2)||(ΩR)nlm(s1)|+|(ΩR)nlm(s2)|+1 (16)

Then the optimal rotation Ropt is selected by

Ropt(s1,s2)=arg minRCND(s1,s2|R) (17)

The Eqs 16 and 17 generalize trivially to an arbitrary number of structures.

After applying the rotation, the structures are superposed using coordinates of their centers of mass.

Shape descriptors distance function

For the distance function training, we prepared a CATH-based dataset as follows: A non-redundant subset of CATH domains with up to 40% sequence identity was obtained from www.cathdb.info. Homologous super-families with fewer than 20 members were removed. Structures within each superfamily were superposed with TM-align using an all-versus-all strategy. A representative domain was selected for each superfamily with the maximal median TM-score of alignments to other members of the superfamily. The dataset was subsequently pruned so that the domains within each superfamily align with the representative domain with TM-score at least 0.75. Finally, we selected super-families starting from the most populous ones, which have TM-score between their representative domains at most 0.45. This procedure yielded 2685 structures (divided among 151 families). All-versus-all comparisons produced a training set with 46572 ‘positive’ (same super-family) and 3556698 ‘negative’ (different super-families) data points.

We defined the distance function for the composite BioZernike feature vectors as:

D(g1,m1,g2,m2)=i=1Ngwg(i)2|g1(i)-g2(i)|1+|g1(i)|+|g2(i)|+i=1Nmwm(i)|m1(i)-m2(i)|

where g1 and g2 are the geometric feature vectors being compared, m1 and m2 are the CN-based feature vectors, and wg and wm are the respective weights.

The weights were fitted to the training set using regularized logistic regression. 10-fold cross-validation was performed on the superfamily level. The regularization parameter that maximized the Matthews correlation coefficient of the predictions of the excluded data was used for the final training with the entire dataset. Learned weight coefficients were constrained to non-negative values, which led to sparse solutions (e.g., 1458 weights were non-zero after the final training on the CATH dataset).

Importantly, the obtained distance function is by no means definitive, but rather an illustration of a general approach. The procedure can (and should) be repeated with the problem-specific training sets, yielding appropriate functions based on the BioZernike descriptors.

Benchmarking

Domains

The domain test set was prepared based on the independent ECOD subset using the same procedure as for the CATH-based training set. Additionally, if an F-group representative domain could be aligned to any CATH superfamily representative domain with TM-score 0.75 or more, the group was excluded from the test set. Ultimately, 761 domain structures (divided among 34 families) remained. All-versus-all comparisons resulted in 13603 ‘positive’ and 275577 ‘negative’ data points.

Assemblies

500 biological assemblies were randomly selected from all PDB entries such that no two assemblies have density correlation score [34] larger than 0.5, to ensure distinct shapes. Afterwards, normal mode analysis from the ProDy package [35] was used to sample 4 additional conformations of each assembly, resulting in 2500 total structures evenly split into 500 classes. As in the domain set evaluation, all-versus-all comparisons were assessed, yielding 5000 ‘positives’ and 3118750 ‘negatives’.

Reference methods

3D-Surfer 3DZD descriptors were obtained directly from the web server using default parameters. During the course of this work, we discovered a bug in the original 3DZD library [32], which caused the invariants of the same order to be cumulative. For the sake of fairness, we corrected the descriptors obtained from the 3D-Surfer server for this bug and notified the server maintainers (the problem has since been solved). The correction somewhat improved the discrimination power (S1 Fig). Euclidean distance was used as the scoring function.

As Omokage score is not available for use with arbitrary structures, we implemented the procedure described in [23]. First, all structures were converted to representative point-sets with Situs v3.1 [36]. Second, we calculated the iDR profiles and implemented the Omokage score according to [23]. The implementation was independently validated using 1000 random comparisons between structures selected from PDB30. Comparisons were scored with our implementation and the PDBj omokage-pairwise web service. As shown in S2 Fig, scoring is consistent between the implementations and insignificant deviations are likely due to the different versions of the Situs package used.

Results

Protein superposition and similarity assessment with complete 3D Zernike moment invariants

We achieve fast similarity computation using protein structural descriptors. Robust descriptors must capture information relevant to their intended use (e.g., binding sites for virtual drug screening, solvent-accessible surfaces for protein docking, structural organization for establishing functional or evolutionary relationships) while being inexpensive to compute, quick to compare with other descriptors, and readily interpretable. Most high-throughput structure analysis pipelines involve balancing the tradeoff between speed and accuracy of the underlying representation.

3D Zernike moments, derived by Canterakis in [31], allow decomposition of an arbitrary volumetric function f(x) into a set of parameters Ωnlm (see Methods). These parameters are independent, insensitive to noise, and, importantly, embody a hierarchy of shape representation. The latter property is of particular significance, as it enables intuitive interpretation of the information content in the moments of certain order (Fig 1).

Limiting their use, 3D Zernike moments are not invariant under rotation. While special properties of the spherical harmonic functions can be exploited to align two sets of moments, the resulting procedure is slower than classical coordinate-based methods [30]. A popular software library [32] implemented the ‘trivial’ rotation invariant descriptors from 3D Zernike moments, i.e., norms of the vectors Ωnl=(Ωnll,Ωnll-1,...,Ωnl-l). We will refer to these descriptors as 3DZDs (3-Dimensional Zernike Descriptors) for consistency with prior work [27]. While this approach is straightforward and has proven to be widely applicable [26, 37], the information loss is obvious: every (2l + 1)-dimensional vector of parameters is reduced to a single invariant. These simpler 3DZD invariants are the base of 3D-surfer [26], the first widely available tool that made use of the Zernike moment decomposition for protein shape matching.

In his work Canterakis [33, 31] did derive a special normalization of the 3D Zernike moments, making them rotationally invariant. However, we found that this normalization does not perform well for the shapes of proteins and macromolecular complexes due to the abundance of symmetric oligomeric arrangements.

Here we generalize the approach of Canterakis by developing normalization routines with wider applicability. These routines yield complete, rotationally invariant 3D Zernike moments (referred to hereafter as Canterakis Norms or CNs). Conceptually, a CN rotates an object so that selected moments become equal to predefined values. This orients an object in a uniquely determined standard position (Fig 2a).

CNs immediately give rise to a computationally inexpensive global structure alignment. Indeed, if the same moments are normalized to their standard values for two objects, their induced standard positions are likewise equivalent (Fig 2a). By normalizing moments from various orders, we obtain alternative alignments that may be more or less suitable for a particular application (Fig 2b). Moreover, since the alignment is performed not between any two objects, but from every object to its standard position, an arbitrary number of structures may be aligned in linear time (Fig 2c).

It has to be noted that the system of polynomial equations mentioned above has multiple solutions. While there is a theoretically sound approach to break this ambiguity described in [33] (fixing signs of the selected moments), in practice it is not universally applicable because we calculate an approximation of the Zernike functions on a discrete volumetric grid. Thus, if the selected moment’s value is small at the outset, the gridding effect may lead to its sign changing randomly based on the initial orientation. Nevertheless, we found that for structure alignment, we can either choose the ambiguity-breaking rule at runtime, based on the observed moment magnitudes, or circumvent the problem entirely by testing all possibilities with negligible loss of performance.

Finally, but most importantly, the complete moments of objects oriented in the same standard position are comparable. This critical property underpins our novel search procedure presented below.

Search procedure and evaluation

Our search procedure is depicted schematically in Fig 3, and relies on the newly designed BioZernike descriptor, a composite descriptor based on several CNs augmented with geometric features.

The simpler 3DZD descriptors are usually calculated for an object surface, following the original implementation [32]. We reasoned that the density distribution contains valuable information for protein structure similarity retrieval. Therefore, we use simulated volumes (Fig 3c) as the basis for 3D Zernike moments calculation. Thus our newly introduced system has two important differences with 3D-Surfer [26]: use of full volumetric data instead of surface only and use of the complete CN invariants instead of the simpler 3DZD invariants.

CNs of different orders may be more or less appropriate for various shapes. Moreover, resolving ambiguity for multiple solutions depends on a particular symmetry that an object may possess. To make the CN-based descriptor versatile while retaining performance, we used several CNs of orders 2 to 5 and then average the absolute values of the solutions (Fig 3d).

The 3D Zernike moments are defined for objects scaled to a unit ball which loses size-related information. To compensate for this fact, we developed a geometry-based descriptor (GEO). It includes features that can be quickly obtained from the set of representative atoms, such as structure dimensions along its principal axes or statistical properties of the interatomic distance distribution (see Methods).

Together the CN-based and the GEO descriptors constitute what we term a BioZernike descriptor. In order to judge similarity of 2 structures, we developed a distance measure that compares their BioZernike descriptors. We hypothesized that the often-used Euclidean distance is suboptimal choice for comparing 3D Zernike moments-based descriptors, because of the hierarchical structure of the representation (Fig 1). Instead, we have followed a machine learning approach to determine weights for the descriptor components using a training set. We used a non-redundant subset of CATH [4] families for this purpose (see Methods).

Retrieval of similar structures was evaluated on a non-redundant subset of ECOD [5] and on a set of biological assemblies with distinct density shapes. 3D-Surfer [26] and Omokage [23] were selected for benchmarking purposes, as both operate on similar principles and represent the current state of the art. 3D-Surfer uses 3DZD descriptors and Euclidean distance to compare them, considering only the solvent-accessible surface of a protein. Omokage scoring utilizes properties of the interatomic distance distribution function (similar to our GEO score).

As shown in Fig 4, 3DZD descriptors applied directly to the density volume retain significantly more information pertaining to similarities and differences within the protein domain families. Retrieval performance is further improved by 1) using the custom distance function obtained via the training set, 2) using CNs instead of 3DZDs, and 3) augmenting CNs with GEO scoring. (AUCs for all evaluated methods are listed in Table 1).

Fig 4. Shape retrieval performance comparison of the BioZernike descriptors to the 3D-Surfer and Omokage descriptors.

Fig 4

Non-redundant sets of domains (a,b) and assemblies (c,d) were used for the evaluation. Receiver operating characteristic (a,c) and precision-recall (b,d) curves are shown. For the domain set, performance of the Canterakis norms (CNs) is plotted separately as well as in conjunction with the geometry descriptor (GEO). ‘3DZD (our implementation)’ corresponds to our implementation of the 3DZD descriptors that takes into account the whole density distribution, rather than the protein surface only.

Table 1. Area under curve (AUC) for receiver operating characteristic (ROC) and precision-recall (PR) curves, and the maximal achievable Matthews correlation coefficient (MCC) are reported for each evaluation plotted in Fig 4.

BioZernike components Reference methods
Weighted CN Weighted 3DZD Density 3DZD GEO Weighted CN+GEO 3DSurfer 3DZD Omokage
Domains
ROC AUC 0.95 0.94 0.93 0.94 0.97 0.85 0.84
PR AUC 0.76 0.73 0.71 0.59 0.79 0.39 0.38
MCC 0.69 0.66 0.65 0.54 0.72 0.38 0.38
Assemblies
ROC AUC 1.0 1.0 0.95 0.99
PR AUC 0.79 0.94 0.71 0.71
MCC 0.75 0.93 0.70 0.71

BioZernike library

An important result of this study is an open-source, customizable library that implements all routines required to obtain a BioZernike descriptor starting from a protein structure https://github.com/biocryst/biozernike. It is written in Java language and can be integrated into any project written in a JVM-compatible language. For instance it can be used together with BioJava to take advantage of its comprehensive structural bioinformatics capabilities [19].

The BioZernike library includes structure-to-volume conversion based on the gmconvert program [34]. We implemented dynamic scaling of the volume grid size to make both speed and precision equally suitable for smaller proteins and larger macromolecular assemblies. 3D Zernike moments were implemented after [32], with further optimization for batch processing. In addition to the classical 3DZD invariants, the library contains routines for calculating CN-norms introduced here and their application to multiple structure alignments.

The library is developed and continuously validated for processing of large amounts of structural data, such as those at RCSB PDB, which leads to a highly optimized and efficient implementation. For example, calculating a full BioZernike descriptor for PDB ID 5J7V (the largest macromolecular assembly represented in the PDB archive at the time of writing; 8280 component homo-oligomer containing 5,340,600 amino acid residues) takes ∼10 seconds. For a more typical oligomeric PDB structure, such as PDB ID 4HHB (hemoglobin α2 β2 hetero-tetramer containing 574 residues) the processing time is ∼30 milliseconds. The full processing for the entire archive as of November 2019 (all assemblies and all polymeric chains) takes 7 hours using 6 parallel threads. The time needed for descriptors comparison and moment alignment is negligible. The performance of the BioZernike library is showcased on the website shape.rcsb.org. The library’s comprehensive implementation, together with its flexibility and speed makes it especially useful for developers who wish to create novel applications for classification and comparison of structural data.

The rcsb.org main website also makes use of the BioZernike library since the April 2020 release. The integration enhances the applicability of this system by combining structure search with other types of searches. Two structure search modes are made available at rcsb.org: “strict” and “relaxed”. The modes correspond to two different threshold sets, based on training against the assemblies dataset (see Methods). “Strict” corresponds to maximal Matthews Correlation Coefficient (about 98% recall), whilst “relaxed” corresponds to 99.9% recall.

Case studies

Similar quaternary structure but different subunits

A very interesting set of comparisons is that of folds that are conserved globally across evolution while the subcomponents have been re-arranged in different ways as a result of gene fusion or duplication. The different biological assemblies are thus very similar overall but have different stoichiometries.

A striking example of this property is the Macrophage migration inhibitory factor (MIF). These tautomerase enzymes are conserved across the entire tree of life (Fig 5a). The assembly fold is composed of βαβ motifs, with a central β barrel formed by the different subunits coming together around a 3-fold axis of symmetry. Overall the assembly has quasi D3 point group symmetry. In eukaryotes (human: 4GRO; mouse: 1MFI; nematode: 2OS5) and cyanobacteria (2XCZ Prochlorococcus marinus) the enzyme is trimeric with a pseudo 2-fold symmetry within the subunits. In some bacteria the enzyme is hexameric, with both A6 (2X4K Staphylococcus aureus) and A3B3 (3EJ9 Pseudomonas pavonaceae) systems known.

Fig 5. Structure search modes.

Fig 5

(a,b) Global shape search finds similar assemblies regardless of a particular stoichiometry. (c) Search-by-parts mode allows discovery of the ‘transformer’ proteins that form different assemblies from similar components.

Another well-known case in this category is that of the DNA-clamps (overall quasi D6 symmetry, with A3 stoichiometry in archaea and eukaryotes and A2 in bacteria) [38], also detectable with our system.

Domain swaps are a further example that belong to this category and represent a widespread phenomenon in structural biology [39]. These assemblies do not present different stoichiometries but rather conformational changes in the subunits that allow for domains to be swapped with partner subunits. Conservation of quaternary structures between swapped and non-swapped assemblies is also detectable with our BioZernike system.

Different quaternary structure but similar subunits

Another case we can easily study and find using the BioZernike system involves divergent quaternary structure assemblies composed by the identical or highly similar subunits.

For example, the TRAP (trp RNA-binding attenuation protein) proteins from Geobacillus stearothermophilus have been determined to have both A11 and A12 stoichiometries, respectively with C11 and C12 point group symmetries (Fig 5b). Since both the global shape (low order Zernike moments) and the details (high order Zernike moments) are matching well, this case does not represent a problem for our retrieval system.

Other well-known cases were revealed through a mutation or an environmental change (e.g., pH) that favored one assembly relative to the other. One case in which conformational changes in the individual subunits lead to very different quaternary structures is porphobilinogen synthase (PBGS) [40], which exists as both a hexamer (1PV8) and octamer (1E51) (Fig 5c). Here, a single point mutation F12L dramatically shifts the equilibrium from octamer to hexamer, which produces an altered pH-rate profile; the hexameric assembly is active only at basic pH. Proteins, like PBGS, that can come apart, change subunit conformation, and reassemble differently with functional consequences have been named morpheeins, and can reflect a dissociative allosteric mechanism [41].

Our search system makes possible automatic identification of such proteins. In this case, the search can be performed only on parts of an assembly, such as an individual chain or a domain. Moreover, a distance function can be designed specifically to focus on higher-order Zernike moments so that structural features of the sub-components are weighted more heavily than the overall shape of the assembly.

Discussion

Protein structure retrieval and alignment with volumetric data provides several advantages versus traditional atomic-data based systems. First, it avoids the challenge of dealing with chain topology (arrangement of secondary structure components along the polypeptide chain) important in many biological systems (e.g., in circular permutants). Second, it obviates the problem of quaternary structure topology, be they local changes as in domain swapping or global changes with subunits that merge or split while conserving the overall quaternary arrangement. A further advantage of our method is that it automatically solves the chain matching problem [21]. These advantages combined with speed, yield a system that compares favorably to quaternary structure search and alignment tools in terms of scalability [14, 42, 20, 19]. Moreover, this method does not rely on atomic models and thus can be applied directly to the growing number of experimental maps obtained using 3D electron microscopy (3DEM) and available from the EMDB data resource (www.ebi.ac.uk/pdbe/emdb/). In fact the properties of 3D Zernike moments make them very suitable for experimental data: robustness to noise and hierarchical description from low to high resolution features. On the other hand, 3DEM maps present a few issues to address in a practical application, such as selection of an appropriate map contour level and consistent radial scaling of the volume into the unit sphere, which are complicated by a relatively high degree of noise density in a typical EM volume.

At the same time, volumetric data preserves information content far better than shape based on surface representation. Thus, as the benchmarks above demonstrate, there are clear advantages of our volume-based system when compared to surface based methods [26, 27]. Trivial examples such as hollow viral capsid versus a full spherical protein assembly can readily exemplify the difference.

On the negative side, one important disadvantage of this method is the inability to find local matches, e.g. finding a conserved domain between 2 chains that have different domain architecture and thus do not match globally. However there are ways of working around the problem, for instance domain decomposition of both query and database to perform searches specific to domains.

A key to the success of our method is the fact that the newly derived Canterakis normalizations (CNs) preserve much more information than the widely used 3DZDs. This is clearly demonstrated by the alignments that are naturally obtained from CNs.

As shown in the benchmark, our system outperforms other fast descriptor-based search approaches in terms of both precision and sensitivity. At the same time, it allows real-time (milliseconds) PDB archive-wide retrieval without the need to resort to ad-hoc strategies for speeding up the calculation. Run times of currently available services (Dali, TopSearch, PDBeFold) are measured in seconds or minutes solely because of additional speed-up strategies like pre-clustering or parallelization. Our system’s faster performance applies equally to user input atomic coordinates, adding only minimal overhead typically measured in milliseconds. Such a system constitutes a valuable tool for structural biologists, allowing for real-time hypotheses generation at the conclusion of a structure determination campaign.

Importantly, the speed and accuracy of this method opens up the possibility of automated structural classification at any level, an avenue that we shall explore in future work. One interesting application is multiple structure profiles: using normalized complete moments to parameterize entire protein families. A related ‘consensus shapes’ notion was introduced in [30], however we feel that using descriptor profiles rather than simple averages is the key. Akin to multiple sequence profiles, it would enable more sensitive searching through profile-to-profile alignments. Moreover, shape variation can be easily studied and visualized for an ensemble of structures. Further applications include scalable multiple structure alignment, alignment of 3DEM maps, and automated structural model-to-electron density (or 3DEM) map fitting.

Supporting information

S1 Fig

(a) The 3DZD library bug results in characteristic non-decreasing wave pattern (red) of the descriptor, often found in literature. The same descriptor without the bug is shown for comparison in blue. (b) Precision-recall curve using Euclidean distance on the test set improves with the corrected version of the descriptor.

(TIF)

S2 Fig. Omokage score validation.

The score calculated by our implementation (axis X) is plotted versus the score obtained from the PDBj server (axis Y) for 1000 random comparisons between structures in PDB.

(TIF)

Data Availability

Datasets used for training and benchmarking are available at https://github.com/rcsb/biozernike-validation.

Funding Statement

The RCSB PDB is jointly funded by the National Science Foundation (DBI-1832184), the National Institutes of Health (R01GM133198), and the United States Department of Energy (DE-SC0019749), grant recipient SKB. We gratefully acknowledge contributions from members of the RCSB PDB and our Worldwide PDB partners. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.

References

  • 1. Burley SK, Berman HM, Bhikadiya C, Bi C, Chen L, Di Costanzo L, et al. RCSB Protein Data Bank: biological macromolecular structures enabling research and education in fundamental biology, biomedicine, biotechnology and energy. Nucleic acids research. 2018;47(D1):D464–D474. 10.1093/nar/gky1004 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2. wwPDB consortium. Protein Data Bank: the single global archive for 3D macromolecular structure data. Nucleic acids research. 2018;47(D1):D520–D528. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3. Murzin AG, Brenner SE, Hubbard T, Chothia C. SCOP: a structural classification of proteins database for the investigation of sequences and structures. Journal of molecular biology. 1995;247(4):536–540. 10.1016/S0022-2836(05)80134-2 [DOI] [PubMed] [Google Scholar]
  • 4. Dawson NL, Lewis TE, Das S, Lees JG, Lee D, Ashford P, et al. CATH: an expanded resource to predict protein function through structure and sequence. Nucleic acids research. 2016;45(D1):D289–D295. 10.1093/nar/gkw1098 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5. Cheng H, Schaeffer RD, Liao Y, Kinch LN, Pei J, Shi S, et al. ECOD: an evolutionary classification of protein domains. PLoS computational biology. 2014;10(12):e1003926 10.1371/journal.pcbi.1003926 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6. McLachlan AD. A mathematical procedure for superimposing atomic coordinates of proteins. Acta Crystallographica Section A: Crystal Physics, Diffraction, Theoretical and General Crystallography. 1972;28(6):656–657. 10.1107/S0567739472001627 [DOI] [Google Scholar]
  • 7. Kabsch W. A solution for the best rotation to relate two sets of vectors. Acta Crystallographica Section A: Crystal Physics, Diffraction, Theoretical and General Crystallography. 1976;32(5):922–923. 10.1107/S0567739476001873 [DOI] [Google Scholar]
  • 8. Holm L, Sander C. Protein structure comparison by alignment of distance matrices. Journal of molecular biology. 1993;233(1):123–138. 10.1006/jmbi.1993.1489 [DOI] [PubMed] [Google Scholar]
  • 9. Rufino SD, Blundell TL. Structure-based identification and clustering of protein families and superfamilies. Journal of computer-aided molecular design. 1994;8(1):5–27. 10.1007/BF00124346 [DOI] [PubMed] [Google Scholar]
  • 10. Madej T, Gibrat JF, Bryant SH. Threading a database of protein cores. Proteins: Structure, Function, and Bioinformatics. 1995;23(3):356–369. 10.1002/prot.340230309 [DOI] [PubMed] [Google Scholar]
  • 11. Shindyalov IN, Bourne PE. Protein structure alignment by incremental combinatorial extension (CE) of the optimal path. Protein engineering. 1998;11(9):739–747. 10.1093/protein/11.9.739 [DOI] [PubMed] [Google Scholar]
  • 12. Krissinel E, Henrick K. Secondary-structure matching (SSM), a new tool for fast protein structure alignment in three dimensions. Acta Crystallographica Section D: Biological Crystallography. 2004;60(12):2256–2268. 10.1107/S0907444904026460 [DOI] [PubMed] [Google Scholar]
  • 13. Zhang Y, Skolnick J. TM-align: a protein structure alignment algorithm based on the TM-score. Nucleic acids research. 2005;33(7):2302–2309. 10.1093/nar/gki524 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14. Sippl MJ, Wiederstein M. Detection of spatial correlations in protein structures and molecular complexes. Structure. 2012;20(4):718–728. 10.1016/j.str.2012.01.024 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15. Holm L, Kääriäinen S, Rosenström P, Schenkel A. Searching protein structure databases with DaliLite v. 3. Bioinformatics. 2008;24(23):2780–2781. 10.1093/bioinformatics/btn507 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Krissinel E, Henrick K. Multiple alignment of protein structures in three dimensions. In: International Symposium on Computational Life Science. Springer; 2005. p. 67–78.
  • 17. Wiederstein M, Gruber M, Frank K, Melo F, Sippl MJ. Structure-based characterization of multiprotein complexes. Structure. 2014;22(7):1063–1070. 10.1016/j.str.2014.05.005 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18. Hasegawa H, Holm L. Advances and pitfalls of protein structural alignment. Current opinion in structural biology. 2009;19(3):341–348. 10.1016/j.sbi.2009.04.003 [DOI] [PubMed] [Google Scholar]
  • 19. Lafita A, Bliven S, Prlić A, Guzenko D, Rose PW, Bradley A, et al. BioJava 5: A community driven open-source bioinformatics library. PLoS computational biology. 2019;15(2):e1006791 10.1371/journal.pcbi.1006791 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20. Bertoni M, Kiefer F, Biasini M, Bordoli L, Schwede T. Modeling protein quaternary structure of homo-and hetero-oligomers beyond binary interactions by homology. Scientific reports. 2017;7(1):10480 10.1038/s41598-017-09654-8 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21. Mukherjee S, Zhang Y. MM-align: a quick algorithm for aligning multiple-chain protein complex structures using iterative dynamic programming. Nucleic acids research. 2009;37(11):e83–e83. 10.1093/nar/gkp318 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22. Ballester PJ, Richards WG. Ultrafast shape recognition to search compound databases for similar molecular shapes. Journal of computational chemistry. 2007;28(10):1711–1723. 10.1002/jcc.20681 [DOI] [PubMed] [Google Scholar]
  • 23. Suzuki H, Kawabata T, Nakamura H. Omokage search: shape similarity search service for biomolecular structures in both the PDB and EMDB. Bioinformatics. 2015;32(4):619–620. 10.1093/bioinformatics/btv614 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Veltkamp RC, Ruijsenaars R, Spagnuolo M, van Zwol R, ter Haar F. SHREC2006: 3D shape retrieval contest; 2006.
  • 25.Florent L, Axenopoulos A, Benhabiles H, Daras P, Giachetti A, Han X, et al. Protein Shape Retrieval Contest. In: Eurographics Workshop on 3D Object Retrieval. The Eurographics Association; 2019.
  • 26. La D, Esquivel-Rodríguez J, Venkatraman V, Li B, Sael L, Ueng S, et al. 3D-SURFER: software for high-throughput protein surface comparison and analysis. Bioinformatics. 2009;25(21):2843–2844. 10.1093/bioinformatics/btp542 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27. Kihara D, Sael L, Chikhi R, Esquivel-Rodriguez J. Molecular surface representation using 3D Zernike descriptors for protein shape comparison and docking. Current Protein and Peptide Science. 2011;12(6):520–530. 10.2174/138920311796957612 [DOI] [PubMed] [Google Scholar]
  • 28. Roseman AM. Docking structures of domains into maps from cryo-electron microscopy using local correlation. Acta Crystallographica Section D: Biological Crystallography. 2000;56(10):1332–1340. 10.1107/S0907444900010908 [DOI] [PubMed] [Google Scholar]
  • 29. Garzón JI, Kovacs J, Abagyan R, Chacón P. ADP_EM: fast exhaustive multi-resolution docking for high-throughput coverage. Bioinformatics. 2006;23(4):427–433. [DOI] [PubMed] [Google Scholar]
  • 30. Mavridis L, Ghoorah AW, Venkatraman V, Ritchie DW. Representing and comparing protein folds and fold families using three-dimensional shape-density representations. Proteins: Structure, Function, and Bioinformatics. 2012;80(2):530–545. 10.1002/prot.23218 [DOI] [PubMed] [Google Scholar]
  • 31.Canterakis N. 3D Zernike moments and Zernike affine invariants for 3D image analysis and recognition. In: In 11th Scandinavian Conf. on Image Analysis. Citeseer; 1999.
  • 32.Novotni M, Klein R. 3D Zernike descriptors for content based shape retrieval. In: Proceedings of the eighth ACM symposium on Solid modeling and applications. ACM; 2003. p. 216–225.
  • 33. Canterakis N. Complete moment invariants and pose determination for orthogonal transformations of 3d objects In: Mustererkennung 1996. Springer; 1996. p. 339–350. [Google Scholar]
  • 34. Kawabata T. Multiple subunit fitting into a low-resolution density map of a macromolecular complex using a gaussian mixture model. Biophysical journal. 2008;95(10):4643–4658. 10.1529/biophysj.108.137125 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35. Bakan A, Meireles LM, Bahar I. ProDy: protein dynamics inferred from theory and experiments. Bioinformatics. 2011;27(11):1575–1577. 10.1093/bioinformatics/btr168 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36. Wriggers W. Conventions and workflows for using Situs. Acta Crystallographica Section D: Biological Crystallography. 2012;68(4):344–351. 10.1107/S0907444911049791 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37. Di Rienzo L, Milanetti E, Lepore R, Olimpieri PP, Tramontano A. Superposition-free comparison and clustering of antibody binding sites: implications for the prediction of the nature of their antigen. Scientific reports. 2017;7:45053 10.1038/srep45053 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38. Bliven SE, Lafita A, Rose PW, Capitani G, Prlić A, Bourne PE. Analyzing the symmetrical arrangement of structural repeats in proteins with CE-Symm. PLoS computational biology. 2019;15(4):e1006842 10.1371/journal.pcbi.1006842 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39. Liu Y, Eisenberg D. 3D domain swapping: as domains continue to swap. Protein science. 2002;11(6):1285–1299. 10.1110/ps.0201402 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40. Breinig S, Kervinen J, Stith L, Wasson AS, Fairman R, Wlodawer A, et al. Control of tetrapyrrole biosynthesis by alternate quaternary forms of porphobilinogen synthase. Nature Structural & Molecular Biology. 2003;10(9):757 10.1038/nsb963 [DOI] [PubMed] [Google Scholar]
  • 41. Jaffe EK. Morpheeins–a new structural paradigm for allosteric regulation. Trends in biochemical sciences. 2005;30(9):490–497. 10.1016/j.tibs.2005.07.003 [DOI] [PubMed] [Google Scholar]
  • 42. Madej T, Lanczycki CJ, Zhang D, Thiessen PA, Geer RC, Marchler-Bauer A, et al. MMDB and VAST+: tracking structural similarities between macromolecular complexes. Nucleic acids research. 2013;42(D1):D297–D303. 10.1093/nar/gkt1208 [DOI] [PMC free article] [PubMed] [Google Scholar]
PLoS Comput Biol. doi: 10.1371/journal.pcbi.1007970.r001

Decision Letter 0

Charlotte M Deane, Arne Elofsson

27 Feb 2020

Dear Dr Duarte,

Thank you very much for submitting your manuscript "Preparing for the 3D data deluge: real time structural search at the scale of the PDB and beyond" for consideration at PLOS Computational Biology. As with all papers reviewed by the journal, your manuscript was reviewed by members of the editorial board and by several independent reviewers. The reviewers appreciated the attention to an important topic. Based on the reviews, we are likely to accept this manuscript for publication, providing that you modify the manuscript according to the review recommendations.

Please prepare and submit your revised manuscript within 30 days. If you anticipate any delay, please let us know the expected resubmission date by replying to this email. 

When you are ready to resubmit, please upload the following:

[1] A letter containing a detailed list of your responses to all review comments, and a description of the changes you have made in the manuscript. Please note while forming your response, if your article is accepted, you may have the opportunity to make the peer review history publicly available. The record will include editor decision letters (with reviews) and your responses to reviewer comments. If eligible, we will contact you to opt in or out

[2] Two versions of the revised manuscript: one with either highlights or tracked changes denoting where the text has been changed; the other a clean version (uploaded as the manuscript file).

Important additional instructions are given below your reviewer comments.

Thank you again for your submission to our journal. We hope that our editorial process has been constructive so far, and we welcome your feedback at any time. Please don't hesitate to contact us if you have any questions or comments.

Sincerely,

Charlotte M Deane

Associate Editor

PLOS Computational Biology

Arne Elofsson

Deputy Editor

PLOS Computational Biology

***********************

A link appears below if there are any accompanying review attachments. If you believe any reviews to be missing, please contact ploscompbiol@plos.org immediately:

[LINK]

Reviewer's Responses to Questions

Comments to the Authors:

Please note here if the review is uploaded as an attachment.

Reviewer #1: Review comments attached as pdf. Predominantly, what is needed is the clarification of the method through the use of non-ambiguous language.

Reviewer #2: The authors present an approach for fast retrieval of similar structures from PDB, using 3D Zernike moments. The proposed approach is an improvement over existing tools and the speed of the method is a big advantage and shows better performance in authors benchmark. The implementation seems robust and is a useful tool for the community. I have a few minor points that will help with user interpretation of results.

1) How does the approach perform (and rank) in case of partial alignments where only part of the larger protein is matched?

2) What are the safe thresholds of the total score to find close and distantly related structures? How much does Zernike descriptors contribute to the total score in general? A discussion would help users.

3) The method can deal with EM volumes but the current implementation and tests doesn’t include these. It is useful to discuss this although I noted that this is mentioned as part of future developments.

**********

Have all data underlying the figures and results presented in the manuscript been provided?

Large-scale datasets should be made available via a public repository as described in the PLOS Computational Biology data availability policy, and numerical data that underlies graphs or summary statistics should be provided in spreadsheet form as supporting information.

Reviewer #1: No: The approach used for generating the dataset is included but seemingly not the list of structures that resulted. list/spreadsheet of optimised zernike/geometric distance metric weights could also be included.

Reviewer #2: No: The benchmark datasets used for tests

**********

PLOS authors have the option to publish the peer review history of their article (what does this mean?). If published, this will include your full peer review and any attached files.

If you choose “no”, your identity will remain anonymous but your review may still be made public.

Do you want your identity to be public for this peer review? For information about this choice, including consent withdrawal, please see our Privacy Policy.

Reviewer #1: No

Reviewer #2: No

Figure Files:

While revising your submission, please upload your figure files to the Preflight Analysis and Conversion Engine (PACE) digital diagnostic tool, https://pacev2.apexcovantage.com. PACE helps ensure that figures meet PLOS requirements. To use PACE, you must first register as a user. Then, login and navigate to the UPLOAD tab, where you will find detailed instructions on how to use the tool. If you encounter any issues or have any questions when using PACE, please email us at figures@plos.org.

Data Requirements:

Please note that, as a condition of publication, PLOS' data policy requires that you make available all data used to draw the conclusions outlined in your manuscript. Data must be deposited in an appropriate repository, included within the body of the manuscript, or uploaded as supporting information. This includes all numerical values that were used to generate graphs, histograms etc.. For an example in PLOS Biology see here: http://www.plosbiology.org/article/info%3Adoi%2F10.1371%2Fjournal.pbio.1001908#s5.

Reproducibility:

To enhance the reproducibility of your results, PLOS recommends that you deposit laboratory protocols in protocols.io, where a protocol can be assigned its own identifier (DOI) such that it can be cited independently in the future. For instructions see http://journals.plos.org/ploscompbiol/s/submission-guidelines#loc-materials-and-methods

Attachment

Submitted filename: reviewer-comments.pdf

PLoS Comput Biol. doi: 10.1371/journal.pcbi.1007970.r003

Decision Letter 1

Charlotte M Deane, Arne Elofsson

20 May 2020

Dear Dr Duarte,

We are pleased to inform you that your manuscript 'Real time structural search of the Protein Data Bank' has been provisionally accepted for publication in PLOS Computational Biology.

Before your manuscript can be formally accepted you will need to complete some formatting changes, which you will receive in a follow up email. A member of our team will be in touch with a set of requests.

Please note that your manuscript will not be scheduled for publication until you have made the required changes, so a swift response is appreciated.

IMPORTANT: The editorial review process is now complete. PLOS will only permit corrections to spelling, formatting or significant scientific errors from this point onwards. Requests for major changes, or any which affect the scientific understanding of your work, will cause delays to the publication date of your manuscript.

Should you, your institution's press office or the journal office choose to press release your paper, you will automatically be opted out of early publication. We ask that you notify us now if you or your institution is planning to press release the article. All press must be co-ordinated with PLOS.

Thank you again for supporting Open Access publishing; we are looking forward to publishing your work in PLOS Computational Biology. 

Best regards,

Charlotte M Deane

Associate Editor

PLOS Computational Biology

Arne Elofsson

Deputy Editor

PLOS Computational Biology

***********************************************************

PLoS Comput Biol. doi: 10.1371/journal.pcbi.1007970.r004

Acceptance letter

Charlotte M Deane, Arne Elofsson

30 Jun 2020

PCOMPBIOL-D-19-01993R1

Real time structural search of the Protein Data Bank

Dear Dr Duarte,

I am pleased to inform you that your manuscript has been formally accepted for publication in PLOS Computational Biology. Your manuscript is now with our production department and you will be notified of the publication date in due course.

The corresponding author will soon be receiving a typeset proof for review, to ensure errors have not been introduced during production. Please review the PDF proof of your manuscript carefully, as this is the last chance to correct any errors. Please note that major changes, or those which affect the scientific understanding of the work, will likely cause delays to the publication date of your manuscript.

Soon after your final files are uploaded, unless you have opted out, the early version of your manuscript will be published online. The date of the early version will be your article's publication date. The final article will be published to the same URL, and all versions of the paper will be accessible to readers.

Thank you again for supporting PLOS Computational Biology and open-access publishing. We are looking forward to publishing your work!

With kind regards,

Laura Mallard

PLOS Computational Biology | Carlyle House, Carlyle Road, Cambridge CB4 3DN | United Kingdom ploscompbiol@plos.org | Phone +44 (0) 1223-442824 | ploscompbiol.org | @PLOSCompBiol

Associated Data

    This section collects any data citations, data availability statements, or supplementary materials included in this article.

    Supplementary Materials

    S1 Fig

    (a) The 3DZD library bug results in characteristic non-decreasing wave pattern (red) of the descriptor, often found in literature. The same descriptor without the bug is shown for comparison in blue. (b) Precision-recall curve using Euclidean distance on the test set improves with the corrected version of the descriptor.

    (TIF)

    S2 Fig. Omokage score validation.

    The score calculated by our implementation (axis X) is plotted versus the score obtained from the PDBj server (axis Y) for 1000 random comparisons between structures in PDB.

    (TIF)

    Attachment

    Submitted filename: reviewer-comments.pdf

    Attachment

    Submitted filename: BioZernike review - PLoS CB.pdf

    Data Availability Statement

    Datasets used for training and benchmarking are available at https://github.com/rcsb/biozernike-validation.


    Articles from PLoS Computational Biology are provided here courtesy of PLOS

    RESOURCES