Abstract

Finding similarities between protein structures is a crucial task in molecular biology. Most of the existing tools require proteins to be aligned in order-preserving way and only find single alignments even when multiple similar regions exist. We propose a new seed-based approach that discovers multiple pairs of similar regions. Its computational complexity is polynomial and it comes with a quality guarantee—the returned alignments have both root mean squared deviations (coordinate-based as well as internal-distances based) lower than a given threshold, if such exist. We do not require the alignments to be order preserving (i.e., we consider nonsequential alignments), which makes our algorithm suitable for detecting similar domains when comparing multidomain proteins as well as to detect structural repetitions within a single protein. Because the search space for nonsequential alignments is much larger than for sequential ones, the computational burden is addressed by extensive use of parallel computing techniques: a coarse-grain level parallelism making use of available CPU cores for computation and a fine-grain level parallelism exploiting bit-level concurrency as well as vector instructions.

1. Introduction

A protein’s three-dimensional structure tends to be evolutionarily better preserved than its sequence. Therefore, finding structural similarities between two proteins can give insights into whether these proteins share a common function or whether they are evolutionarily related. Structural similarity between two proteins is usually defined by two functions—a one-to-one mapping (also called alignment or correspondence [1]) between two subchains of their three-dimensional representations and a specific scoring function that assesses the alignment quality. The structural alignment problem is to find the mapping that is optimal with respect to the scoring function. Hence, the complexity of the protein structural alignment problem and the quality of the found solution strongly depend on the way that scoring function is defined.

The most commonly used among the various measures of alignment similarity are the internal-distances root mean squared deviation () and the coordinate root mean squared deviation () (see (3) and (2), resp., for the exact definitions). Tightly related to these measures are the two main approaches for solving the structural alignment problem. The similarity score in the first approach is based on the internal distances matrix, where a set of distances between elements in the first protein is matched with a set of distances in the second protein. The second approach uses the actual Euclidean distances between corresponding atoms in two proteins and aims to determine the rigid transformation that superimposes the two structures.

A huge majority of the algorithms representing these approaches are heuristics [26] (excellent reviews can be found in [7, 8]) and as such do not guarantee finding an optimal alignment with respect to any scoring function. The fact that finding exact solutions in this field is computationally hard is related to the fact that computing the longest alignment of protein structures is typically modeled as an NP-hard problem, for example, the protein threading problem [9], the problem of enumerating all maximal cliques [10, 11], or finding a maximum clique [1214].

These results have been generalized by Kolodny and Linial [1], who showed that protein structural alignment is NP-hard if the similarity score is distance based. They also point out that a correct and efficient solution of the structural alignment problem must exploit the fact that the proteins lie in three-dimensional Euclidean space.

In this paper we present an algorithm that avoids the fundamental intractabilities pointed out in [1]. Our algorithm is both internal-distances based and Euclidean-coordinates based (i.e., it uses a rigid transformation to optimally superimpose the two structures). Its computational complexity is polynomial and it comes with a quality guarantee—for a given threshold , it guarantees to return alignments that have as well as less than , if such exist.

Our algorithms are motivated by a class of exact structural-alignments algorithms that look for the largest clique in the so-called product (or alignment) graphs [1214]. The edges in such graphs encode information about pairs of residues in the two proteins that match based on internal distances between them, namely, if the difference between corresponding distances does not exceed some fixed parameter . Then a clique of size would correspond to subsets of residues in both proteins that match.

Here, we relax this condition and accept cliques such that edges correspond to matching of similar internal distances up to . For this relaxed problem, we propose a polynomial algorithm that takes advantage of internal-distance similarities among both proteins to search for an optimal transformation to superimpose their structures. We also replace the goal of finding the largest clique by the one of returning several very dense “near-clique” subgraphs. This choice is strongly justified by the observation that distinct solutions to the structural alignment problem that are close to the optimum are all equally viable from the biological perspective and hence are all equally interesting from the computation standpoint [1, 15].

To the best of our knowledge, our tool is unique in its capacity to generate multiple alignments with “guaranteed good” both and values. We do not require the alignments to be order preserving which makes our algorithm suitable for detecting similar domains when comparing multidomain proteins. Thanks to this property, the tool is able to find both sequential and nonsequential alignments, as well to detect structural repetitions within a single protein and between related proteins.

However, to enumerate exhaustively multiple similar regions requires a more systematic approach than those developed in other existing heuristic-based tools. The computational burden is addressed by extensive use of parallel computing techniques: a coarse-grain level parallelism making use of available CPU cores for computation and a fine-grain level parallelism exploiting bit-level optimization as well as vector instructions.

Other nonsequential structure alignment methods have been recently proposed (excellent review on this topic can be found in the very recent reference [16]). None of them is close to the approach proposed here. As they are all heuristic and do not guarantee finding an optimal alignment, a detailed comparison with algorithms based on different concepts requires extensive numerical experiments and is outside the scope of this study.

Here we present a significantly improved and expanded version of a paper originally presented at the PPAM 2013 conference [17]. In comparison to [17], the current version contains detailed description and explanation of all steps of the algorithms, all pseudocodes, supplementary figures illustrating the algorithms and the experimental results, and extended reference section. Additional sections are added including a comparison between the straightforward and the bit-vector implementations based on complexity analysis as well as detailed analysis of the work from the point of view of future performance improvements and additional possible applications.

2. Preliminaries

2.1. Measures for Protein Alignments

Consider a protein of atoms, , with . Many measures have been proposed to assess the quality of a protein alignment. These measures include additive scores based on the distance between aligned residues such as the TM-score [18], the DALI score [19, 20], the PAUL score [21] and the STRUCTAL score [22], and root mean square deviation (RMSD) based scores, such as RMSD100, SAS, and GSAS [23]. Given a set of deviations , its root mean square deviation isTwo different RMSD measures are used for protein structure comparison. The first one, , takes into account deviations consisting of the Euclidean distances between matched residues after optimal superposition of the two structures and is defined aswhere is the image of protein under a rigid transformation.

The second one, denoted here by , takes into account deviations consisting of absolute differences of internal distances within the matched structures. The measured deviations are , for all couples of matching pairs “.” Let be the latter set and its cardinality. We have that

2.2. Alignment Graphs

An undirected graph is represented by a set of vertices and a set of edges between these vertices. In this paper, we focus on a subset consisting of grid-like graphs, referred to as alignment graphs.

An alignment graph is a graph in which the vertex set is depicted by an array , where each cell contains at most one vertex from . An example of such an alignment graph for protein comparison is given in Figure 1.

A good matching of two proteins and can be found by analyzing their alignment graph , where and (resp., ) is the set of atoms of interest in protein (resp., protein ). A vertex is present in only if atoms and are compatible. An example of incompatibility could be different electrostatic properties of the two atoms. An edge is in if and only if the distance between atoms and in protein , , is similar to the distance between atoms and in protein , . In our case, these distances are considered similar if , where is a given threshold.

We arbitrarily order the vertices of the alignment graph and assign a corresponding index to each of them. In subsequent sections, the notion of successors of a vertex refers to all the vertices that are adjacent to in the alignment graph and have a higher index than with respect to those fixed indices. The notion of neighbors of a vertex refers to the set of all the vertices that are adjacent to in the alignment graph regardless of their respective indices. Formally, we define

In an alignment graph of two proteins and , a subgraph with high density of edges denotes similar regions in both proteins. One can, therefore, find similarities between two proteins by searching in the corresponding alignment graph for subgraphs with high edge density. The highest possible edge density is found in a clique, a subset of vertices that are all connected to each other. Then a clique of size would correspond to subsets of residues in both proteins that match since all internal distances are similar. For these reasons approaches like ProBis [12] and DAST [13] aim at finding the maximum clique in an alignment graph.

3. Methods

3.1. Our Approach

Since finding a maximum clique in a graph is NP-hard and any exact solver faces prohibitively long run times for some instances, here we relax the above definition of clique and accept cliques such that edges correspond to matching of similar internal distances up to . We also replace the goal of finding the largest clique by the one of returning several very dense “near-clique” subgraphs.

Our method uses geometric properties of the three dimensional (3D) space. Instead of testing for the presence of all edges among a subset of vertices, in order to determine if defines a clique, we only test for the presence of edges between every vertex of the subset and an initial -clique (triangle), referred to as seed. This reduction of the performed comparisons is crucial and leads to a polynomial algorithm that takes advantage of internal-distance similarities among both proteins to search for an optimal transformation to superimpose their structures.

3.2. Overview of the Algorithm

Algorithm 1 gives an overview of our approach. The algorithm consists of the following three steps.(i)Seeds in the alignment graph are enumerated. In our case, a seed is a set of three points in the alignment graph that correspond to two triangles (one in each protein) with similar internal distances. This step is detailed in Section 3.3.(ii)Each seed is then extended. Extending a seed consists in adding all pairs of atoms, for which distances to the seed are similar in both proteins, to the set of three pairs of atoms that make up the seed. Seed extension is detailed in Section 3.4.(iii)Each seed extension is filtered; compare lines through . Extension filtering is detailed in Section 3.5 and consists in removing pairs of atoms that do not match correctly.

(1)   function find_alignments(graph)
(2)   INPUT: graph, an alignment graph between atoms from two proteins
(3)   OUTPUT: resList, a list of the largest distinct alignments found
(4)  
(5)   ResultList resList = empty_result_list()
(6)   SeedList seeds = enumerate_seeds(graph)
(7)   For each seed in seeds
(8)      VertexSet set = extend_seed(seed)
(9)      VertexSet result = empty_set()
(10)    For each vertex in set
(11)        If (is_valid(vertex))
(12)          result.add(vertex)
(13)       End If
(14)       resList.insert_if_better(result)
(15)    End For
(16) End For

Filtered extensions are then ranked according to their size, number of aligned pairs of atoms, and a user-defined number of best matches are returned. This process is explained in Section 3.7. For very large alignment graph, the graph can be partitioned into a user-defined number of parts to speed up computations. The graph is partitioned using a min-cut type of heuristic to preserve the quality of the results. Each subgraph is then processed independently. This process is explained in Section 5. The overall worst-case complexity of the whole algorithm without partitioning is .

3.3. Seed Enumeration

A seed consists of three pairs of atoms that form similar triangles in both proteins. A triangle in protein is considered similar to a triangle in protein if the following conditions are met: , and , where denotes the Euclidean distance and is a user-defined threshold parameter. The default value for is Ångstroms.

In the alignment graph terminology, these conditions for a seed (, , ) in graph translate to the following: , , and .

A seed thus corresponds to a -clique in the alignment graph; that is, three vertices that are connected to each other. Enumerating all the seeds is therefore equivalent to enumerating every -clique in the input alignment graph.

Not all -cliques, however, are relevant. Suitable -cliques are composed of triangles for which a unique transformation can be found to optimally superimpose them. Namely, -cliques composed of triangles that appear to be too “flat” will not yield a useful transformation. We thus ensure that the triangles in both proteins defined by a potential seed are not composed of collinear points (or points which are close to being colinear). The method is detailed in Algorithm 2. The worst-case complexity of this step is using, for example, the algorithms from [24].

(1)   function enumerate_seeds(graph)
(2)   INPUT: graph, an alignment graph between atoms from two proteins
(3)   OUTPUT: seedList, a list of suitable 3-cliques (i.e. triplets of vertices that are connected
    to each other and correspond to non-degenerated triangles in both proteins)
(4)   
(5)   SeedList seedList = empty_seed_list()
(6)   For each vertex1 in graph
(7)      For each vertex2 in get_successors(vertex1)
(8)         For each vertex3 in get_successors(vertex2)
(9)            If is_edge(vertex1, vertex3)
(10)             If collinearity_check(vertex1, vertex2, vertex3)
(11)                 seedList. add(vertex1, vertex2, vertex3)
(12)             End If
(13)          End If
(14)       End For
(15)    End For
(16) End For

3.4. Seed Extension

Extending a seed consists in finding the set of vertices that correspond to pairs of atoms that potentially match well (see Section 3.5 for details) when the two triangles defined by the seed are optimally superimposed. Finding a superset of pairs of atoms that match well is performed by triangulation with the three pairs of atoms composing the seed. Let (, , ) be a seed of an alignment graph as defined in Section 3.3. Then the extension of the seed is defined as the setIn the alignment graph terminology, the previous definition translates toThe detail of seed extension is given in Algorithm 3. The sequential computational complexity associated to this step is . For the complexity of our parallel implementation refer to Section 4.3.

(1)   function extend_seed(vertexA, vertexB, vertexC)
(2)   INPUT: a seed represented by three vertices (or pairs of atoms) from the alignment graph
(3)   OUTPUT: res, a set of pairs of atoms that potentially match well when atoms from the
    seed are optimally superimposed;
(4)         size, the size of the returned set
(5)   
(6)   BinaryVertexSet setA = get_neighbors(vertexA)
(7)   BinaryVertexSet setB = get_neighbors(vertexB)
(8)   BinaryVertexSet setC = get_neighbors(vertexC)
(9)   BinaryVertexSet tmp = intersection(setA, setB)
(10) BinaryVertexSet res = intersection(tmp, vertexC)
(11)  int size = pop_count(res)

3.5. Extension Filtering

The triangulation performed when extending a seed is not sufficient to find alignments with good measures. Indeed, in most cases, knowing the distance of a point in a three-dimensional space to three other nonaligned points yields two possible locations. These locations are symmetrical with respect to the plane defined by the three reference points. A vertex in a seed extension represents a pair of atoms, one in each studied protein. By construction, these atoms have similar distances to the three points of their respective triangles. It may happen that one of the two points, say , is located, in protein , on one side of the plane defined by its reference triangle, while the second point, say , in protein , lies on the other side of the plane defined by the two optimally superimposed reference triangles; see Figure 2.

Using quadruplets of vertices as seeds does improve the quality of seed extensions but greatly increases the computational cost of seed enumeration and degeneration check on the corresponding tetrahedra. Moreover, larger seeds do not completely ensure the quality of extensions. Namely, in cases where, for a vertex , atom (resp., ) is very distant from atoms , , and (resp., atoms , , and ) of a seed (, , ), distance similarities to the atoms of the seed do not ensure similar positions of atoms and in the two proteins.

In order to remove issues with symmetry (where the atoms in the extending pair are roughly symmetrical with respect to the plane determined by the seed atoms) and distance from the seed, we implement a method to filter seed extensions. This method consists in computing the optimal transformation to superimpose the triangle from the seed corresponding to the first protein onto the triangle corresponding to the second. The optimal transformation is obtained in constant time with respect to the size of the alignment by using the fast, quaternion-based method of [25]. For each pair of atoms composing the extension of a seed (, , ), we compute the Euclidean distance between and . If the distance is greater than a given threshold , the pair is removed from the extension. The filtering method is detailed in Algorithm 4. The complexity of this step is per seed.

(1)   function filter_extension(extension)
(2)   INPUT: extension, a set of pairs of atoms
(3)   OUTPUT: result, a subset of the extension containing
    only pairs of atoms that match well
(4)   
(5)   VertexSet result = empty_set()
(6)   Matrix transformation = get_optimal_transformation(seed)
(7)   For each vertex in extension
(8)      Point = get_coordinates_in_first_protein(vertex)
(9)      Point _prime = get_coordinates_in_second_protein(vertex)
(10)    Point _transformed = apply_transformation(, transformation)
(11)     Float distance = dist(_transformed, _prime)
(12)    If (distance < threshold)
(13)       result.insert(vertex)
(14)    End If
(15) End For

3.6. Guarantees on Resulting Alignments’ RMSD Scores

By construction, the filtering method ensures that the RMSD for a resulting alignment is less than : the distance between two aligned residues after superimposition of the two structures is guaranteed to be less than .

Internal distance between any additional pair of atoms and the seed is also guaranteed, by construction to be less than . Concerning internal distances between two additional pairs of atoms, we show that in the worst possible case the difference does not exceed ; see Figure 3. The worst possible case happens when two additional pairs of atoms and , added to the extension of a seed , have atoms , , , and aligned, after superimposition, and atoms from one protein lie within the segment defined by the two other atoms. In such a case, the filtering step ensures that and ; it follows that .

3.7. Result Ranking

When comparing two proteins, we face a double objective: finding alignments that have both long overlaps and low scores. The methodology described in Section 3.5 ensures that any returned alignment will have a lower or equal to twice the user-defined parameter . We can therefore leave the responsibility to the user to define a threshold for scores of interest. However, ranking alignments that conform to this threshold simply based on their lengths is not an acceptable solution. In a given alignment graph, several seeds may lead to very similar transformations and thus very similar alignments. The purpose of returning multiple alignments is to find distinct similar regions in both proteins. Therefore, when two alignments are considered similar, we discard the shorter of the two.

Two alignments are considered similar, when they share a defined number of pairs of atoms. This number can be adjusted depending on the expected length of the alignments or even set to a percentage of the smaller of the two compared alignments. This methodology of ranking results ensures that no two returned alignments match the same region in the first protein to the same region in the second protein.

3.8. Graph Splitting

Large protein alignment graphs can contain millions of edges. In order to reduce the computations induced by such large graphs, a graph splitting scheme is implemented.

Graph splitting is performed using a min-cut like heuristic, also known as multilevel graph partitioning, provided by the METIS library [26]. This heuristic partitions the graph in components of similar number of vertices and aims at minimizing the number of intercomponent edges, edges between vertices that belong to distinct components. In order to further minimize the number of intercomponent edges, we allow the sizes in terms of numbers of vertices of the components to vary up to an order of magnitude. The assumption is that such partitions will keep each area of interest in the graph within a single component.

Once a partition is obtained, subgraphs corresponding to the components are sorted according to their respective numbers of vertices. Each subgraph is then processed in decreasing order of sizes starting with the largest one. The list of best results is transmitted from one subgraph to another, in order to be able to discard seeds whose extensions are smaller than the best results found so far.

In practice, partitioning the graph tends to group vertices of each of the best results within a single component. However, several of these vertices may be placed in different components. To address this issue, seeds yielding the best results in a subgraph are extended and filtered once more using atoms from the initial global graph.

This second extension and filtering phase significantly improved the length of resulting alignments but did not guarantee providing the same results as without partitioning. However, experimental results show that a given graph could be partitioned in up to components with only a loss in terms of alignment length and a fourfold overall speedup.

The graph splitting scheme is described in Algorithm 5.

(1)   function split_and_solve(globalGraph)
(2)   INPUT: globalGraph, an alignment graph between atoms from two proteins
(3)   OUTPUT: globalRes, a list of the longest distinct alignments found in the graph
(4)   
(5)   ResultList globalRes = empty_result_list()
(6)   Graph subGraphs = split(globalGraph)
(7)   sort(subgraphs)
(8)   For each subGraph in subGraphs
(9)      SeedList best_seeds = empty_list()
(10)    SeedList seeds = enumerate_seeds(subGraph)
(11)     For each seed in seeds
(12)       VertexSet current_res = extend_and_filter(subGraph, seed)
(13)       best_seeds.insert_if_better(seed)
(14)    End For
(15)    For each seed in best_seeds
(16)       VertexSet current_res = extend_and_filter(globalGraph, seed)
(17)       globalRes.insert_if_better(current_res)
(18)    End For
(19) End For

4. Parallelism

4.1. Overview of the Implemented Parallelism

The overall computational complexity of our algorithm being , handling large protein comparison with a decent level of precision, that is, using alignment graphs with a large number of edges, can prove time-consuming. Our approach is however parallelizable at multiple levels.

Figure 4 shows an overview of our parallel implementation. Multiple seeds are treated simultaneously to form a coarse-grain level of parallelism, while a finer grain parallelism is used when extending a single seed.

4.2. Coarse-Grain Parallelism

This level of parallelism is implemented using the open MP standard [27]. A user-defined number of threads is spawned to handle, in parallel, computations for the seeds generated in the seed enumeration procedure.

In order to output only significant (sufficiently large) alignments we perform here a kind of pruning strategy. It is based on the size of a seed extension which is in fact an easily computed upper bound of the alignment to be produced by the given seed. Whenever this size is smaller than the length of any of the alignments present in the result list (those are the best alignments, so called records), the corresponding seed is discarded, thus avoiding the cost of a filtering step.

In this regard, our pruning strategy is similar to the one applied in a branch and bound (B&B) kind of algorithms. A sequential implementation of this strategy is relatively easy since there is only one list of records. The order in which seeds (tasks to be performed) are treated is crucial for the efficiency of the approach. As sooner as the best alignments are computed, more tasks can be discarded and many computations can be avoided. However, parallelizing the approach induces the same challenges that parallel B&B implementations face [28] which can be resumed as follows.

Each thread has now its own (local) list of records which are only lower bounds of the global records found so far by all threads. The pruning strategy is less efficient and could even result in an increase of the amount of computations. One option to avoid this is to make threads share the list of records and to keep it updated. However, inserting frequently new entries in this global-result list or often updating its content would prove rather inefficient, because thread safety would need to be ensured by using locks around accesses to this result list. With such locks, threads would often stall whenever inserting a new alignment and the time lost on these accesses would only increase with the number of threads in use. In order to avoid any bottleneck when inserting a new alignment in the result list, in our implementation each thread has its own private list. These lists are merged at the end of the computations to form a final result list. This implementation choice prevents the need for a synchronization mechanism and allows threads to be completely independent.

4.3. Fine-Grain Parallelism

Seed extension makes extensive use of set intersection operations. We define for each vertex a set containing all neighbors of . Then, for each edge , the set of seeds containing can be computed by finding the intersection of with . In this section, we compare two alternative implementations for computing set intersection.

4.3.1. Straightforward Implementation

The straightforward implementation of a set of vertices is to store in a sorted array the indices of the vertices that are present in the set. Computing the intersection of two such sets, and , therefore consists in traversing both arrays and adding common vertices to the resulting intersection. The complexity of such an approach is thus , where is the length of and is the length of . Once the intersection has been found, the length of the resulting array is obtained in constant time.

4.3.2. Bit-Vector Implementation

In order to speed up set intersection operations, we implemented a bit-vector representation of the neighbors set of each vertex of the alignment graph. To any vertex , we associate a vector neighbors where the bit at position is if and only if vertexes and are connected in the alignment graph (see Figure 5 for illustration).

This representation of the neighbors sets allows bit parallel computations of set intersection. Simple logic and operation over every word element of the two sets yielded the intersection. For faster traversal of the neighbors set a traditional list representation is also kept. This list representation allows easy access to the first and the last elements of the neighbors set. Knowing the first and last elements of the sets allows restricting the area of interest for intersection operations as described below. Let (resp., ) be the first nonzero bit in neighbors (resp., neighbors), while (resp., ) denote the last nonzero bit in neighbors (resp., neighbors). We then apply the logic and operator only over the interval where and .

Intersection operations also benefit from SSE (Streaming SIMD Extensions) instructions. A number of atomic operations equal to the size of the SSE registers available on the machine (typically 128 or 256) can be computed simultaneously.

However, this bit-vector approach to computing set intersections increases the number of atomic operations to perform. Namely, vertices, which are not neighbors of any of the two vertices for which the intersection is computed, will induce atomic operations and provided such vertices reside in the area of interest. Such vertices would not be considered in the first approach to set intersection.

In order to efficiently compute the size of the intersection in case of a bit-vector implementation, we use a built-in population count instruction (POPCNT) available in SSE4. This operation returns, in constant time, the number of bits set in a single machine word. For architectures without a built-in population count instruction, a slower yet optimized alternative is provided.

4.3.3. Straightforward versus Bit-Vector Implementations

As mentioned in Section 4.3.1, the complexity of an intersection operation with the straightforward implementation is in , where and denote the lengths of the sets. The size of the resulting set is known after performing the intersection operation; that is, its complexity is also .

With the bit-vector implementation, the complexity of a set intersection operation is in   , where is the area of interest for a given set intersection,   is the number of vertices in the area of interest, and   is the size of the SSE registers available on the machine ( is 128 for the set of vector instructions we used on our machines). It is to be noted that the area of interest contains vertices that are present as well as vertices that are absent from a given set. The complexity of computing the size of the resulting set with the optimized implementation is also in   using POPCNT instructions.

Comparing both implementations requires comparing versus  . The latter is not straightforward, but it is obvious that for enough dense graphs (such as more of the alignment graphs and especially when they model atoms on proteins surfaces) the values of and tend to increase, and bit-vector implementation inclines to be faster.

Additionally, the bit-vector implementation induces regular data access patterns, making it a more cache friendly implementation. This property becomes crucial, when considering a future GPU implementation of the algorithm. Given these observations, we directly implemented the bit-vector alternative.

Note that the size of the intersection of the neighbors of two vertices gives an upper bound of the size of any clique than contains these vertices. If this upper bound is less than the size of a previously found clique, any seed containing these vertices will be discarded. These tests are evaluated when considering a new seed for extension and filtering.

5. Experimental Evaluation

We evaluated our algorithm with respect to accuracy and speed. In order to test the effectiveness of our approach to detect multiple regions of interest, we considered two proteins (PDB IDs 4clna and 2bbma). These proteins are each composed of two similar domains, named A and B (resp., C and D) for the first (resp., second) protein, separated by a flexible bridge (see Figure 6). The corresponding alignment graph contains 21904 vertices and 40762390 edges (17% of the total number of possible edges).

Existing approaches for global protein structure comparison such as PAUL [21] and ones based on contact map overlap (CMO) [29] tend to match both proteins integrally, yielding larger alignments but poorer RMSD scores. TM_align [6], the reference tool for protein comparison, only matches domain A onto domain C. The four top results of our tool correspond to all four possible combinations of domain matching (see Figure 7). Our tool was run using cores of an Intel(R) Xeon(R) CPU E5645 @ 2.40 GHz and the distance threshold was fixed to Ångströms in the alignment graph. Scores corresponding to these alignments are displayed in Table 1.

In order to test the efficiency of our coarse-grain parallel implementation, we compare run times obtained with various numbers of threads on a single instance. The input alignment graph for this instance contains vertices and edges. (In order to evaluate more accurately the impact of the number of threads on the computation time, we have chosen a larger instance than the one used for the same experiment in the conference version of this paper [17].) Computations were run using a varying number of cores of an Intel(R) Xeon(R) CPU E5-2670 0 @ 2.60 GHz. Table 2 shows run times and speedups with respect to the number of CPU cores. Run times displayed in this table are averages out of runs. The table also indicates the standard deviation of each set of runs.

Using more threads for computations provides substantial speedups but also induces different and unpredictable explorations paths of the search space of the alignment graph. Since finding the optimal set of solutions allows us to prune the search space, the order in which seeds of the graph are considered has an impact on the overall performance of the algorithm. With a single thread, the exploration path of the graph is fixed and run times are homogeneous: the standard deviation with a single thread is of the average run time. With more than one thread, the exploration path potentially changes at each run and impacts the total run time. This is particularly true for and threads with standard deviations of, respectively, and of the average run time. Further increasing the number of threads reduces the unpredictability by increasing the odds of finding optimal solutions early. This behavior is similar to that exhibited in parallel branch and bound algorithms [28].

Figure 8 shows run times for graphs with a varying number of edges and the same number of vertices . Computations were run using cores of an Intel(R) Xeon(R) CPU E5645 @ 2.40 GHz. Input alignment graphs were all generated from the same two proteins and different parameters to allow a varying number of edges. The diagram shows dependence of the run time on the number of edges consistent with the theoretical , where the dependence on is absorbed into the big factor.

6. Conclusion and Perspectives

In this paper, we introduce a novel approach to find similarities between protein structures. Resulting alignments are guaranteed to score well for both and , while remaining polynomial. This approach takes advantage of internal distance similarities, described in an alignment graph, to narrow down the search for an optimal transformation to superimpose two substructures of the proteins.

We consider two main possible directions for extending the results reported here: (i) improving the performance (accelerating the solver); (ii) diversifying the application area.

6.1. Performance Improvement

Though not implemented, an even higher level of parallelism could be considered when graph splitting is performed. Computations for each subgraph are also independent and could therefore be run in parallel. Since a multicore parallelism implementation is already provided, a cluster level parallelism could be implemented. Each subgraph would be sent to a single cluster node using, for example, using an MPI approach (for message passing interface [30]). However, load balancing would be a challenging task due to the limited number of subgraphs that can be generated without a prohibitive loss of accuracy and the difference in terms of numbers of vertices of these subgraphs. Moreover, the total amount of computations would increase if subgraphs were treated in parallel, since the optimal lower bound found in one subgraph could not be used to solve other subgraphs. This issue would also be similar to that observed in parallel branch and bound algorithms and first described in [28].

The structure of this algorithm as well as the required operations makes it suitable for a GPU implementation, which could speed up the computations. A bit-vector implementation for set intersection operations allows regular data access patterns. These access patterns make set intersection operations more cache friendly and could thus be efficiently mapped to the GPU paradigm. Moreover, GPUs provide all the necessary bit-level instructions such as population count and bit scanning. Seed listing and result ranking operations are however too irregular to be efficiently computed on a GPU; therefore, seeds could be listed by the CPU and sent to the GPU for extension and filtering operations. Results could then be transferred back to the CPU for ranking operations.

6.2. Diversifying the Applications

Detection of Structural Repeats. A big advantage of the approach is its capacity to find multiple/alternative alignments with good and property. This allows a deeper analysis of protein structures. One promising perspective is the investigation of repeats inside a protein structure. Structural repeats are common in protein structures [31, 32]. However, they are currently unsatisfactorily studied because of the lack of suitable algorithms. Preliminary results show that our approach returns the repetitions in several reliable alignments, so further investigations are in progress.

Combining Local Alignments into Global Ones. The idea here is to further analyze the returned multiple local nonoverlapping alignments and to combine them in a new global alignment. Such an approach allows introducing flexibility and nonsequentiality in protein structure alignments. Similar methods already exist such as LGA [5] or FlexSnap [15, 33, 34] and we are currently testing our approach on the corresponding datasets.

Disclosure

Preliminary version of this work was presented at PPAM 2013.

Conflict of Interests

The authors declare that they have no conflict of interests.

Acknowledgments

The authors are grateful to Noël Malod-Dognin and Frédéric Cazals for motivating discussions in the initial stage of this study. The authors would like to acknowledge the editors for their precise and in-depth proofreading of their paper.