Next Article in Journal
Pyrrolysyl-tRNA Synthetase with a Unique Architecture Enhances the Availability of Lysine Derivatives in Synthetic Genetic Codes
Next Article in Special Issue
Machine Learning Approaches for Protein–Protein Interaction Hot Spot Prediction: Progress and Comparative Assessment
Previous Article in Journal
Phytochemical Profile and Biological Activities of Satureja hortensis L.: A Review of the Last Decade
Previous Article in Special Issue
Prediction Methods of Herbal Compounds in Chinese Medicinal Herbs
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

An Algorithm for Computing Side Chain Conformational Variations of a Protein Tunnel/Channel

1
3D Convergence Technology Center, 70 Dongnaero, Donggu, Daegu 41061, Korea
2
School of Computer Science & Engineering, College of IT Engineering, Kyungpook National University, 80 Daehakro, Bukgu, Daegu 41566, Korea
3
School of Life Sciences and Biotechnology, Kyungpook National University, 80 Daehakro, Bukgu, Daegu 41566, Korea
*
Author to whom correspondence should be addressed.
Molecules 2018, 23(10), 2459; https://doi.org/10.3390/molecules23102459
Submission received: 24 August 2018 / Revised: 21 September 2018 / Accepted: 22 September 2018 / Published: 26 September 2018
(This article belongs to the Special Issue Computational Analysis for Protein Structure and Interaction)

Abstract

:
In this paper, a novel method to compute side chain conformational variations for a protein molecule tunnel (or channel) is proposed. From the conformational variations, we compute the flexibly deformed shapes of the initial tunnel, and present a way to compute the maximum size of the ligand that can pass through the deformed tunnel. By using the two types of graphs corresponding to amino acids and their side chain rotamers, the suggested algorithm classifies amino acids and rotamers which possibly have collisions. Based on the divide and conquer technique, local side chain conformations are computed first, and then a global conformation is generated by combining them. With the exception of certain cases, experimental results show that the algorithm finds up to 327,680 valid side chain conformations from 128~1233 conformation candidates within three seconds.

1. Introduction

Tunnels and channels in a protein molecule are the pathways for ligands (or substrates). The ligands are able to move from outside to inside cavity of the molecule or pass through the molecule by using the tunnels or channels. When a ligand reaches to the cavity, they can interact with residues in the protein molecule, where it causes functions of the protein. A channel is a pathway with two entrances from the exterior to the inside, while a tunnel has only one entrance. For studying protein functions, it is important to find them through which the ligand passes in a protein. The term tunnels can be replaced with channels in this paper, since we will suggest an algorithm which can be applied to both of tunnels and channels without modification. In the remaining part of this paper, we will use the term tunnels, rather than using the term tunnels and channels.
There have been many researches on finding tunnels in the protein molecule [1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25]. To find the tunnels, geometric information on atoms in the molecule must be known. The Protein Data Bank (PDB, http://www.rcsb.org) provides such geometric information as snapshots of a molecule at the static state. In this case, the relative positions of the atoms in the molecule are static, and the tunnel can be computed for the atoms with fixed positions.
In the natural state, protein molecules are flexible, since the side chain of each amino acid can be rotated, and the backbone is flexible. Therefore, the shape of the tunnel in the molecule can be changed according to the changed atom positions in the molecule. When the tunnel shape is changed, the ligand types that pass through it also can be changed; thus, computing the shape changes of a tunnel is important.
In particular, when the target of a chemical is inside the protein, the accessibility of the chemical to the target is essential to the function of the protein. For example, DosT, an oxygen sensor protein, from Mycobacterium tuberculosis has a tunnel for oxygen to a heme inside the protein, while its paralog, DosS has a narrower tunnel. Rotation of the side chain of a residue at the tunnel in DosS can change the tunnel even narrower not to pass an oxygen molecule, and as a result, DosS becomes a redox sensor unlike DosT [26]. In cases of enzyme, the shape of the tunnel restricting the size of substrate provides substrate specificity of the enzyme. Changes in the shape of the tunnel affect the activity of the enzyme because access to the target site of the substrate increases the local concentration of the substrate. Tunnel shape changes can be also applied to ligands for cell signaling, inhibitors targeting the enzyme active site, allosteric modulators, and so on. Thus, it will provide valuable information for drug discovery and determination of molecular mechanisms for enzymes and sensor proteins.
So far, most research related to the shape changes of the tunnel is either on computing them for each snapshot of protein molecule captured during sequential time period or computing them by using the molecular dynamics [9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25,27,28]. For previous research, the tunnel shape changes are tracked for a sequence of snapshots.
For the protein molecule with side chain flexibility, we suggest an algorithm to compute valid conformational variations for the amino acid side chain rotamers composing a tunnel. Our algorithm is summarized as follows. Given a tunnel, the amino acids composing it are extracted. For those tunnel adjacent amino acids, we remove the side chain rotamers that cause invalid conformations. Based on two types of graphs and their maximal cliques, the amino acids and rotamers are classified as two groups: amino acids and rotamers in one group are guaranteed to have no collisions each other, while those in the other group possibly have collisions. After computing the local valid conformations from each maximal clique, the global valid conformations are generated based on the divide and conquer method. As one of the applications of the suggested algorithm, we show the way to compute the maximum bottleneck of the flexibly deformed tunnel. Experimental results show the computational time efficiency of our algorithm.
Graphs have been widely used for side chain prediction (or side chain packing) problems [29,30,31,32,33,34,35,36], where the problem is known as NP-hard [37,38]. For the side chain prediction, graphs and cliques have been used to find the rotamer conformation that minimizes the energy between atoms. To solve the problem, many variations of graphs and graph search methods have been used, and most of previous research focused on solving the combinatorial optimization.
In this paper, though we suggest a method that uses graphs and maximal cliques like as the previous works on side chain prediction problems, the output of our method is different from them. Rather than finding one solution that corresponds to combinatorial optimization, our method finds every valid rotamer conformation. The purpose of our research is computing flexibly deformed tunnels from a given initial tunnel, so we need to compute every valid rotamer conformation rather than finding one optimized conformation. For the efficient finding of all valid conformations of the side chain rotamers, we suggest ways to compute the local valid conformations from the graph. We also present a way to combine those to global valid conformations.
Both of our algorithm and molecular dynamics simulation can produce a valid conformation, but there are differences in possibility or existing time. A sequence of molecular dynamics snapshots are the conformations with various energy states and it can provide the most possible conformation, which exists for the longest time in a given time period. Our algorithm focused on fast finding of every valid rotameric conformation around a tunnel, so it is useful to decide the maximum bottleneck of the varied shapes of a tunnel starting from the same position in the protein. Although the shapes of a tunnel simulated by our method with a fixed backbone would be different from those generated by molecular dynamics simulation, our algorithm shows a specific application that it can be used with interactive computation time performance for the most of cases.
This paper is organized as follows: in Section 2, related works are discussed. The geometric features of the protein molecule and amino acids are presented in Section 3. In Section 4, we present an algorithm for computing every valid rotamer conformation in the tunnel adjacent amino acids. By using the valid conformations, we present a method to compute the maximum bottleneck of the tunnel, which decides the maximum size of the ligand that can pass through the tunnel, in Section 5. The experimental results are discussed in Section 6, and we conclude this paper in Section 7.

2. Related Works

There has been previous research on computing or tracking tunnels in the protein molecule, and there exist many software tools or algorithms [1,2,3,4,5,6,7,8,9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25]. Those tools or algorithms find the cavities and tunnels efficiently, and the ligand size can be decided for each tunnel. The methods for tunnel finding are applied for the protein molecule in a static state [1,2,3,4,5,6,7,8], while those for tunnel tracking are used for deformed tunnels in a single protein molecule under the time-varying situation [9,10,11,12,13,14,15,16,17,18,19,20,21,22,23,24,25].
There are good survey papers on computing tunnel finding algorithms [27,28]. Simoes et al. [28] classified the cavity into void, pocket and channels, and then classified pockets as cleft/groove, invagination, and tunnels. A number of methods are shown for tunnel finding and tracking under the time-varying situation [9,14,15,16,17,18,19,20,21,22,23], and most of them use the molecular dynamics result for tracking the changed shape of tunnels.
Proteins have a flexibility which causes shape changes along the time axis. Beneš et al. [10,11] proposed a method to track the dynamic tunnel by using a Voronoi diagram of the protein. For a sequence of snapshots of protein molecule, they compute a Voronoi diagram for each snapshot. From the initial tunnel, they choose the nearest Voronoi edges to it, and then construct the modified tunnel. Based on their method, in CAVER 3.0 [12,13], the tunnel updates for each snapshot is computed in parallel. Rather than computing the whole tunnel, it efficiently updates the tunnels by choosing the similar pathway to the initial tunnel.
Raunest and Kandt [16] presented dxTuber that is a grid-based cavity simulation method based on protein and solvent residence probabilities, where those probabilities are derived from molecular dynamics simulations. They convert solvent and protein trajectories into density voxels, and then detect internal solvent voxels (ISV) through scanning density voxels in the directions of principal axes. After they find ISVs, they group ISVs into buried cavities, surface clefts, and tunnels.
Craig et al. [15] presented PocketAnalyzerPCA, which uses principal component analysis and clustering for the detected pockets. For each dynamically changed protein structure derived from molecular dynamics, they detect pockets based on grid method. They encode the pocket shape as a row vector of integers 1 and 0, by representing the grid points as included in the pocket or not. A pocket shape matrix is composed by merging those row vectors, and derives the principal components from the matrix. Then, the dominant deformation modes of dynamic pocket shape are computed by projecting the row on those principal components.
Ashford and et al. [17] showed Provar that provides a way to analyze and visualize the pockets in a flexibly deformed protein structure. Rather than presenting a novel way to compute the pockets from the deformed protein structure, they focused on the post-processing of the outputs from existing various pocket finding software tools. They discussed the difficulties of comparing predicted pockets from a single protein structure when those pockets are detected by using different software tools. They also showed the difficulties of comparing the pockets detected from conformational variants from a protein structure. To solve the difficulties, they find the pocket-lining atoms and side chains by the probability scores based on the cut-off distance of each atom from every pocket derived from different software tools. Then, the atoms within a specified probability range are colored as pockets.
Lindow et al. [19,20] developed a tool to compute dynamics of cavities based on the computation of Voronoi diagrams of spheres. They derived geometric paths from static protein structures at each time step based on Voronoi diagrams of spheres, where each static structure is decided by molecular dynamics. Then, they associated each path with a cavity, and traced the paths over time by computing the intersection volume of two cavities.
Paramo et al. [21] presented trj_cavity for detecting cavities. They represent the 3D grid system with voxels. They map the atoms to voxels, and then incrementally detect the cavities from one of voxels inside a cavity. By checking the neighbors of the voxel in a cavity, they find a connected cavity. When there is no more empty voxels in the cavity, they start to detect new cavity. They detect cavities for each snapshot of molecular dynamics simulation, and consider a cavity is identical if there are overlaps between two cavities in the sequence of snapshots.
Desdouits et al. [22] propose an algorithm for tracking the dynamics of cavity topology changes along the sequential frame of molecular dynamics. They applied Principal Component Analysis (PCA) to analyze the characteristics of the evolution of cavity geometry, and described the cavity evolution by using the PCA components.
Laurent et al. [23] presented Epock, where it focuses on tracking the identical cavity along the sequence of frames from molecular dynamics simulation. Rather than detecting cavities, they use the cavities computed in a priori by using other software.
Vonasek et al. [24,25] presented sampling-based motion planning method to detect tunnels in a protein molecule. By using the concept from robot motion planning and Voronoi diagram, they used the Rapidly Exploring Random Tree algorithm to extract the empty space in each molecular dynamics frame of the protein. They represented the empty space in the protein molecule as a tree structure, and updated it according to the disappearance, split, or merge of the empty space in the next frame.

3. Preliminaries

By using the atom center positions provided by the PDB file and van der Waals radius [39], we can represent each atom as a sphere with a specific center position and radius in a 3-dimensional space. It is general to represent atoms to spheres for the geometric approaches in analyzing protein structure. When two atoms have a covalent bond, they are represented as two intersecting spheres, while the corresponding spheres of non-bonded atoms do not intersect.
The atoms in an amino acid are classified as two parts: main chain and side chain. In every amino acid, the main chain part is composed of the same four atoms (N, Cα, C, O), where each neighbor atoms are linked by covalent bonds. The main chains of amino acids sequentially compose a polypeptide chain.
In the side chain, the atoms are hierarchically structured with each hierarchy sharing the same rotation axis and angle, and this produces the side chain flexibility. The atom Cα in the main chain has covalent bond with the atom Cβ in the side chain. The line passes through the centers of Cα and Cβ works as the first rotation axis, by which the whole side chain is able to rotate around this axis, where in the lower hierarchy similarly rotation occurs. According to the amino acid type, there can be 0 to 4 rotation axes (Cα-Cβ, Cβ-Cγ, Cγ-Cδ, and Cδ-Cε) in a side chain. The rotation angle for each rotation axis is given to satisfy energetically favored arrangement of the adjacent atoms attached to the axis. All atomic positions of the side chain adopting the rotation angles determine the specific conformation of the side chain. There are numerous possible conformations for a given side chain. A few conformations occur more frequently than others, and are called rotamers.
Except the case when two atoms have a covalent bond, the intersection between corresponding spheres is not allowed. We define the case when two atoms without a covalent bond have intersection as a collision. For two non-bonded atoms A1 and A2 with the center point (xi, yi, zi), i = 1, 2, and radii ri, the collision occurs when the following is satisfied:
(x1 − x2)2 + (y1 − y2)2 + (z1 − z2)2 < (r1 + r2)2.
We consider it as a valid conformation only when there is no collision between two rotamers of different amino acids. Bounding Sphere Volume (BSV) [40] is a spherical area that containing an amino acid with its every rotamer from all hierarchies. For the side chain atoms at the lowest hierarchy, we construct a bounding sphere first. In the bottom up direction, for each hierarchy, we compute the bounding sphere which contains the rotation of the bounding sphere in the lower level. In this way, at the highest hierarchy, we have a bounding sphere which contains every rotamer in lower hierarchies. When we represent each amino acid with two non-intersecting BSVs, it is guaranteed that there is no collision between two amino acids for any rotamer conformation. We can reduce the computation time by checking collisions between BSVs rather than rotamers. If two BSVs B1 and B2 do not intersect, the rotamers in B1 and those in B2 do not have collisions. On the other hand, using BSVs results less accuracy. Though B1 and B2 have an intersection, there are possibilities that two rotamers from B1 and B2 have a valid conformation without collision. In this reason, when B1 and B2 intersect, we check every pair of rotamers from B1 and B2, to finally decide if there are valid conformations. BSVs also are used to decide the tunnel adjacent amino acids. For the amino acids whose BSVs do not intersect with the tunnel, we can exclude them from the tunnel adjacent ones.
Since the atoms bonded to a carbon are at the tetrahedral position, the side chain prefers the staggered conformation of neighbor atoms to avoid steric hindrance. Thus, the favorable rotamers are positioned every 120° around the rotation axis, and there are three rotamers for each rotation axis [41,42]. A long side chain with four steps of rotation axes has 34 (81) possible conformations. However, the rotation axis, which is most effective to determine a BSV of an amino acid, is the axis of Cα-Cβ. In this paper, we assumed that each side chain has one rotation axis Cα-Cβ to reduce the amount of calculation and the conformations of a side chain are generated by rotating the whole fixed side chain every 30° around the rotation axis Cα-Cβ considering possible spatial positions of side chain atoms generated by other rotation axes (Figure 1). Then, each amino acid has 12 conformations and when we consider n amino acids in a tunnel, there are up to 12n rotamer conformation candidates. Since the volume of hydrogen atoms attached to C, N, O, and S atoms is relatively small and ignorable compared to the BSV, we did not consider the hydrogen atoms.

4. Suggested Algorithm

The suggested algorithm computes every valid conformation of side chains in tunnel adjacent amino acids, which can be found from only one snapshot of the protein molecule. The algorithm overview is presented in Algorithm 1. We can obtain atom positions, covalent bond relation, rotation axis, amino acid information, etc. from a PDB file. They are input to the algorithm with tunnel information.
Amino acids which possibly affect the given tunnel are selected and all of their rotamers are added to the set S. Then, we remove the side chain rotamers which collide with main chains and other static atoms. For the amino acids with remaining rotamers, the collision graph and the collision free graph are constructed. By finding maximal cliques from those graphs, we can group the amino acids which do not collide at all, and generate the valid rotamer conformations for the amino acids possibly have collisions each other. For each subset of amino acids, rotamer valid conformations are found. Then, the valid rotamer conformations for all tunnel adjacent amino acids are computed by combining them.
Algorithm 1
Input: Protein Molecule M, a tunnel H
Step 1: S ← {amino acids that are adjacent to H, and their rotamers}
Step 2: S ← S–{invalid rotamers of the amino acids in S}
Step 3: CG ← collision graph for amino acids in S
Extract maximal cliques from CG
//if two amino acids are in different maximal cliques in CG,
//they do not have collisions in any case
Step 4: For each maximal clique of CG,
FGk ← collision free graph for rotamers in each maximal clique of CG
Extract maximal cliques from FGk
//if rotamers of different amino acids have an edge
//in a maximal clique in FGk, then they have no collision
Step 5: Compute local valid conformations from each maximal clique of FGk
Step 6: Combine the local valid conformations to global valid conformations
Step 7:Output global valid conformations

4.1. Step 1: Extraction of Amino Acids That Are Adjacent to a Tunnel

We represent the tunnel H(t), 0 ≤ t ≤ 1, as the center trajectory H.c(t) and the radius H.r(t) of the moving empty ball, which represents the tunnel as a swept volume (Figure 2). When the radius of empty ball is locally minimum, we denote it as a bottleneck of the tunnel. When there are one or more bottlenecks in a tunnel, the minimum bottleneck restricts the size of a ligand that can reach to the inside cavity.
The amino acids adjacent to tunnel H can be defined as two types:
(1)
The amino acids that contact with the tunnel H in the initial state
(2)
The amino acids whose side chain rotamers possibly collide with the tunnel H
The original definition of the tunnel implies that the tunnel has no collision with atoms, and only some atoms contact the tunnel. However, for an amino acid which was apart from the tunnel in the initial state, its side chain rotamer possibly collides with and affects the tunnel. So, we consider both types of amino acids as tunnel- adjacent ones.
For each amino acid Ai, 1 ≤ i ≤ n, we compute BSV(Ai) that contains every side chain rotamer of Ai. Then, the set of tunnel adjacent amino acids, S, is computed as follows:
S = {Ai with its rotamers, which satisfies BSV(Ai) ∩ H(t) ≠ ∅, 1 ≤ i ≤ n}.
In Figure 3, the examples of a tunnel and tunnel adjacent amino acids are presented.

4.2. Step 2: Removing Invalid Rotamers

We assumed that there are 12 rotamers for each tunnel adjacent amino acid in S, and that the remaining amino acids are static. For each tunnel adjacent amino acid, one of the rotamers corresponds to the initially given side chain in the PDB file.
In the following cases, rotamers are considered to be invalid:
  • Case 1: a rotamer that collides with main chains
  • Case 2: a rotamer that collides with the amino acids not in S
In the normal status, both cases do not happen, so we consider the rotamers in those cases as invalid. We also remove those invalid rotamers from the set S. In Figure 4, the rotamers A2.R0 and A3.R2 are invalid since they collide to main chain or amino acids which are not in S.

4.3. Step 3: Computing Amino-Collision-Cliques

A CG graph is used to group the amino acids whose rotamers possibly collide with each other. Before computing CG, we first compute a temporarilly used graph TG for the computation time efficiency, and then revise it to CG. The temporary collision graph TG(V,E) is constructed as follows, where V and E denote a vertex set and an edge set, respectively:
V = {Ai}, Ai ∈ S, where 1 ≤ i ≤ n
E = {(X, Y) | X, Y ∈ V and BSV(X) ∩ BSV(Y) ≠ ∅}
For each amino acid pair (X,Y), which shares an edge in TG, we check if a rotamer from X and another one from Y have a collision. For an amino acid A, we represent its rotamers as A.j. If any pair of rotamers has a collision, then an edge between X and Y is added to the edge set of CG. The collision graph CG(V,E) is as follows:
V ={Ai}, Ai ∈ S, where 1 ≤ i ≤ n
E = {(X, Y) | X, Y ∈ V and there exist one or more X.a ∩ Y.b ≠ ∅}
After CG is constructed, we compute the set of maximal cliques by using Bron-Kerbosch algorithm [43]. The clique is a complete subgraph, and the maximal clique is a complete subgraph which is not included in another complete subgraph.
We denote the maximal cliques of CG as amino-collision cliques. If two amino acids are in the same amino-collision-clique, they always have one or more rotamer pairs which collide each other. If two amino acids Ai and Aj are in different amino-collision-cliques C1 and C2 and Ai and Aj are not in C1 ∩ C2, then they are guaranteed to have no collisions for any pair of rotamers.

4.4. Step 4: Computing a Collision Free Graph for Each Amino-Collision-Clique

For each maximal clique in CG, we construct a collision free graph, where it is used to find the valid rotamer conformation for the amino acids that possibly have collisions. For every pair of amino acids in amino-collision-clique, every rotamer pair is checked for collisions.
Let us denote the amino-collision-cliques of CG as C1, C2, …, Cm. Then, for each clique Ck, 1 ≤ k ≤ m, a collision free graph FGk (Vk, Ek) is constructed by Algorithm 2.
Algorithm 2
For k = 1 to m do begin
 For each amino acid Ai in Ck,
  Add every rotamer Ai.j to Vk
 For each rotamer pair Ax.a and Ay.b, x ≠ y and Ax, Ay ∈ Vk do
  If Ax.a ∩ Ay.b = ∅ then
   Add (Ax.a, Ay.b) to Ek
end

4.5. Step 5: Computing Local Valid Rotamer Conformations

The collision free graph FGk(Vk, Ek) for amino-collision-cliques Ck represents the valid rotamer conformation for the amino acids in Ck. If we can find a maximal clique from FGk whose number of vertices is identical to the number of amino acids in FGk, then it corresponds to a valid rotamer conformation for the amino acids in Ck. There is no valid conformation for those in Ck, otherwise.
Figure 4 shows the example of the collision free graph for the amino-collision-clique with vertices for amino acids A2, A3, and A5 and their valid rotamers. Each amino acid is assumed to have three rotamers: R0, R1, and R2, where A2.R0 and A3.R2 are invalid rotamers. The rotamer pairs (A2.R2, A3.R0), (A2.R2, A5.R1,), and (A3.R1, A5.R0) have collisions, respectively. Other pairs have no collisions, so the collision free graph is constructed with an edge set excluding only (A2.R2, A3.R0), (A2.R2, A5.R1), and (A3.R1, A5.R0). In this collision free graph, we find all maximal cliques. For example, there are three maximal cliques which includes the edge (A2.R1, A3.R0) such as (A2.R1, A3.R0, A5.R0), (A2.R1, A3.R0, A5.R1) and (A2.R1, A3.R0, A5.R2). There are six maximal cliques with three vertices. There also is only one maximal clique with two vertices: (A2.R2, A5.R0). In this case, there is no valid conformation including A2.R2 and A5.R0, since any rotamer from A3 will have collisions with A2.R2 or A5.R0.

4.6. Step 6: Combining the Local Valid Rotamer Conformations to Global Ones

For finding the valid rotamer conformations for all the amino acids in S, we have to combine the valid conformations generated from the cliques in FGk. Let us denote the set of maximal cliques found in the collision free graph FGk as a set Qk. Then, the valid conformations for each Qk can be computed.
After generating an array whose size is the number of tunnel adjacent amino acids, we put the rotamer identification numbers of those maximal cliques in the array. According to the intersection between two different maximal cliques, we can decide the rotamers which must be shared by two different collision free graphs. The final valid conformation is computed with backtracking. In Figure 5, we show the tree structure for the valid conformations in each clique. For each clique Ci, 0 < i ≤ m, let us assume that there are ni valid conformations: {V1, V2, …, Vni}, which are generated from Qk. Each valid conformation consists of an one-dimensional vector, whose size corresponds to the number of adjacent amino acids: (x1, x2, …, xn), where xi is either a rotamer identification number in the valid conformation or −1 for the case when the corresponding amino acid is not included in the clique. For example, if there are 6 tunnel adjacent amino acids, and the clique contains three amino acids among them, and has a valid conformation: A2.R1, A3.R0, A5.R0, then the valid conformation V is (−1, 1, 0, −1, 0, −1).
A tree structure with searching and pruning for combining process is well-known and widely used, but for clearly showing its usage for our algorithm, we explain about it with implementation details. The combining process can be considered as a depth first search of a tree from the root with the pruning steps, if necessary (Figure 5). Whenever visiting a node N, an incrementally composed valid conformation that is the result of combination of every valid conformations of its ancestors, preVC, is given. If preVC is not compatible with the valid conformation of N, currentVC, then we do not visit the subtree rooted N. If preVC is compatible to currentVC, then we combine preVC and currentVC to compose a new incremental valid conformation, updatedVC. The new conformation updatedVC is given to N’s children when they are visited. If there are no children of N, then output updatedVC as a global valid conformation.
Though the combining process can be considered as depth first search of a tree, but actually we do not have to use the tree structure in the implementation. If we represent the cliques and their valid conformations as nodes in a tree, the number of nodes is represented as the product: n1n2…nm. In this reason, rather than physically constructing a tree in Figure 5, we implement the combining process by using the recursive calls of the function. By this way, we use the memory space that increases linearly to the number of valid conformations in cliques: C1.V1, C1.V2, …, C1.Vn1, C2.V1, C2.V2, …, C2.Vn2, …, Cm.V1, Cm.V2, …, Cm.Vnm.
The algorithm to combine the local valid conformations to a global valid conformation is presented as Algorithm 3. In the main function, the function Combine is called as Combine (1, j, preVC), where 0 < j ≤ n1 and preVC is initialized as the integer array (−1,−1, …, −1).
Algorithm 3
Combine (int cur_level, int cur_VC, int preVC[ ])
//cur_level and cur_VC: pointing the VC which are visited now
//preVC: the combined valid conformations for the ancestors
Begin
  currentVC = Ccur_level.Vcur_VC;
  //combine the preVC and currentVC to updateVC
  //AdjAminoNum is the number of tunnel adjacent amino acids
  for i = 0 to AdjAminoNum do
    if (currentVC[i] > 0 and preVC[i] > 0 and currentVC[i] ≠ preVC[i])
      return; //currentVC and preVC is not compatible
    else if (currentVC [i] == preVC[i] or currentVC[i] == −1)
      updatedVC[i] = preVC[i];
    else (preVC[i] == −1)
      updatedVC[i] = currentVC [i];
  if (cur_level == m) output updatedVC and return;
  next_level = cur_level + 1;
  for j = 1 to nnext_level do
    Combine(next_level, j, updatedVC);
End

5. The Maximum Bottleneck of Deformed Tunnels

From the side chain conformations produced from the algorithm in Section 4, we can compute the deformed tunnels. The tunnel finding algorithm [8] is repeatedly applied to compute each tunnel. Among those minimum bottlenecks of tunnels, the maximum bottleneck is found and it decides the maximum size of the ligand when the tunnel shape is flexibly deformed.
A tunnel H(t) is represented as a set of empty balls with a center trajectory H.c(t) and radius H.r(t) (Figure 2). A bottleneck in the tunnel, H(t*), is defined as follows:
H(t*), where H.r(t* − ε) > H.r(t*) and H.r(t* + ε) > H.r(t*).
For each valid side chain conformation, we can compute the tunnel H’(t) which is the variation of the tunnel H(t). After we compute the minimum bottleneck radius from each tunnel H’(t), we choose the maximum value from them. Then, the maximum value is the maximum size of the ligand that can pass through the flexible tunnels which is produced from H(t) (Refer to Algorithm 4).
Algorithm 4
Input: Flexible tunnels H’(t) produced from tunnel H(t)
Step 1: For each tunnel H’(t),
1.1 Generate sphere set according to the conformation
1.2 Apply tunnel finding algorithm [8] and compute the tunnel H’
1.3 For the tunnel H’, find the minimum bottleneck and add it to B
Step 2: Output the maximum value from B.

6. Experimental Results

The suggested algorithm was implemented using Microsoft Visual C++ and OpenGL. The experiments were performed at a PC with a CPU Intel Core i5-6200U 2.6 GHz, and 8 GB RAM. For the tests, we used 22 tunnels inside nine protein molecules which were computed by the method proposed by Kim et al. [8]. For computing tunnel geometry and valid conformation, we used two programs which are separately executed. The tunnel computing program of Kim et al. was executed at a PC with a CPU Intel i5-4570 3.2GHz, 8GB RAM, and NVIDIA GeForce GTX760. The protein molecules were downloaded from the PDB website (http://www.rcsb.org).
In Table 1, we present the number of valid rotamer conformations for the specific tunnel in a protein molecule and the computation time in seconds. For the most of tunnels, we found up to 76,800 valid conformations in 1.06 s. For the cases of tunnel Id. 215 and 298 of PDB Id. 2OAR, around 300,000 valid conformations were found and it took less than 3 s for the computation. The case of tunnel Id. 334 of PDB Id. 1DDZ shows the highest diversity. More than 3,000,000 valid conformations were found, and the computation time was around 40 s.
Most of the cases, the experimental results show the efficiency of the computation time. The number of valid rotamer conformations is somewhat related to the computation time. However, there is no relationship between the computation time and the number of conformations in rotamer-cliques. Unexpectedly, the number of valid conformations is not much related to the number of tunnel adjacent amino acids, either. Regardless of the number of tunnel adjacent amino acids, the number of valid conformations is decided. For the case of tunnel Id. 72 of PDB Id. 1A52, the number of tunnel adjacent amino acids is 33 and the number of valid conformations is 17,280. Comparing to it, tunnel Id. 215 of PDB Id. 2OAR has 19 tunnel adjacent amino acids, but the number of valid conformations is 327,680. It seems that the size and shape of the side chains in the tunnel adjacent amino acids are more important for calculating valid conformations than its number of amino acids.
From each valid rotamer conformation, we computed the deformed tunnel by applying the tunnel computing algorithm. The initial input tunnel shape is deformed according to the valid conformation. From every deformed tunnel shape, we obtained the bottlenecks and found the maximum bottleneck among them. By applying the suggested algorithm, we computed the valid rotamer conformations, and show two examples for the corresponding tunnel shape changes in Figure 6.
In some cases, the position of the entrance to the identical cavity was varied due to the path of tunnel is varied according to the rotation of the side chain. In Figure 7, the case when the tunnel entrance is changed due to the different rotamer conformations for the tunnel Id. 76 of PDB Id. 1MQF. For the tunnel Id. 148 of PDB id. 1B44 and tunnel Id. 51 of PDB Id. 3RLR, the rotamers which do not contribute to the tunnel shape changes are in the tunnel adjacent amino acids. We cannot extract the tunnel amino acids exactly, since it is hard to know how tunnel shape changes and which side chain rotamer possibly contributes to the deformed tunnel in advance.
In Table 2, we present the size of the maximum bottleneck of the deformed tunnels and its computation time. For each valid conformation, we applied the tunnel detection algorithm [8], and derived the deformed tunnel information. From those tunnels, we computed the maximum bottleneck. In Table 2, only the column ‘Tunnel computation time’ was measured through the tunnel detection algorithm. Usually different tunnel detection algorithms produce different tunnels though the tunnel starts from the identical position (cavity) in the protein [17,27]. The tunnels we used can be different from those derived by other software. The suggested valid conformation detection algorithm can be applied to tunnels generated from any software, if the software provides the geometric information on starting cavity and the tunnel.
The cases of tunnels Id. 215 and Id. 298 of PDB 2OAR and tunnel Id. 334 of PDB Id. 1DDZ, of which the numbers of valid conformations are greater than 100,000, are excluded from the maximum bottleneck computing since the tunnel computation takes about 1 s per a conformation. For other cases, we present the computation time for tunnels and finding the maximum bottleneck in seconds. For each tunnel, we compute all valid conformations first. Then, we construct the deformed tunnel from each valid conformation, and find the bottleneck which is the smallest empty ball of it. After deciding the bottleneck for each deformed tunnel, we find the maximum bottleneck from those. The computation time for the deformed tunnels and their maximum bottleneck is almost linear to the number of valid rotamer conformations.
From the various tunnel shapes, we can obtain the bottleneck in each shape and the range of bottleneck changes by the minimum and maximum bottleneck values. In Figure 8, we present the minimum, maximum and mean of bottleneck values for each tunnel. The difference between the maximum and minimum values suggests dynamics of the tunnel bottleneck by rotating side chains in the tunnel. The low bottleneck value such as 0 implies that the tunnel could be completely blocked or the cavity is disappeared. If the side chain can be rotate freely, the mean value represents the average opening of the tunnel in a given time period suggesting the accessibility to the cavity through the tunnel. For the cases of tunnel Id. 140 of PDB Id. 1DDZ and tunnel Id. 179 of PDB Id. 3RLR, the maximum and minimum bottlenecks have little difference. The tunnels in these cases do not have big difference of shapes around the bottleneck.

7. Conclusions

In this paper, a novel algorithm to find every valid conformation for the side chain rotamers in tunnel adjacent amino acids was presented. The algorithm selected the amino acids that possibly affect the tunnel shapes as tunnel adjacent ones. By using the graph structure, the tunnel adjacent amino acids are grouped by the collision possibility. Then based on a divide and conquer technique, we compute the local valid rotamer conformations first, and then combine them as global valid conformations. The suggested algorithm is applied to compute the maximum bottleneck of the deformed tunnels derived from the valid rotamer conformations.
Though the graph-based computation of valid conformation has been researched widely, there have been few attempts to find every valid conformation. By considering the two types of graphs, collision and collision free graphs, with maximal cliques, we efficiently remove the rotamers whose conformations are invalid. The number of possible valid conformations in local area is reduced by removing the conformations having collisions. We compute the global valid conformation by combining local results, so the computation time was feasible regardless of the exponential solution space. We also show the novel method to find the maximum size of the ligand which can pass through the flexible tunnel by using the suggested algorithm.

Author Contributions

U.S. and K.-J.K. conceived and designed the algorithm and experiments; U.S. performed the experiments; B.S.K. analyzed the data; U.S. and K.-J.K. contributed computation tools; U.S., K.-J.K., and B.S.K. wrote the paper.

Funding

This research was supported by Basic Science Research Program through the National Research Foundation of Korea (NRF) funded by the Ministry of Education (NRF-2016R1D1A1B03930628).

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Smart, O.S.; Neduvelil, J.G.; Wang, X.; Wallace, B.A.; Sansom, M.S.P. HOLE: A program for the analysis of the pore dimensions of ion channel structural models. J. Mol. Graph. 1996, 14, 354–360. [Google Scholar] [CrossRef]
  2. Petřek, M.; Otyepka, M.; Banáš, P.; Košinová, P.; Koča, J.; Damborský, J. CAVER: A new tool to explore routes from protein clefts, pockets and cavities. BMC Bioinform. 2006, 7, 316. [Google Scholar] [CrossRef] [PubMed]
  3. Petřek, M.; Košinová, P.; Koča, J.; Otyepka, M. MOLE: A Voronoi diagram-based explorer of molecular channels, pores, and tunnels. Structure 2007, 15, 1357–1363. [Google Scholar] [CrossRef] [PubMed]
  4. Ho, B.K.; Gruswitz, F. HOLLOW: Generating accurate representations of channel and interior surfaces in molecular structures. BMC Struct. Biol. 2008, 8, 49. [Google Scholar] [CrossRef] [PubMed]
  5. Yaffe, E.; Fishelovitch, D.; Wolfson, H.J.; Halperin, D.; Nussinov, R. MolAxis: Efficient and accurate identification of channels in macromolecules. Proteins 2008, 73, 72–86. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  6. Pellegrini-Calace, M.; Maiwald, T.; Thornton, J.M. Porewalker: A novel tool for the identification and characterization of channels in transmembrane proteins from their three-dimensional structure. PLoS Comput. Biol. 2009, 5, e1000440. [Google Scholar] [CrossRef] [PubMed]
  7. Lindow, N.; Baum, D.; Hege, H.C. Voronoi-based extraction and visualization of molecular paths. IEEE Trans. Vis. Comput. Graph. 2011, 17, 2025–2034. [Google Scholar] [CrossRef] [PubMed]
  8. Kim, B.; Lee, J.E.; Kim, Y.J.; Kim, K.-J. GPU Accelerated Finding of Channels and Tunnels for a Protein Molecule. Int. J. Parallel Program. 2016, 44, 87–108. [Google Scholar] [CrossRef]
  9. Eyrisch, S.; Helms, V. Transient pockets on protein surfaces involved in protein-protein interaction. J. Med. Chem. 2007, 50, 3457–3464. [Google Scholar] [CrossRef] [PubMed]
  10. Beneš, P.; Medek, P.; Sochor, J. Tracking single channel in protein dynamics. In Proceedings of the WSCG Communication Papers proceedings, Plzen, Czech Republic, 1–4 February 2010; pp. 109–114. [Google Scholar]
  11. Benes, P.; Medek, P.; Strnad, O.; Sochor, J. Computation of dynamic channels in proteins. In Proceedings of the 3rd International Conference on Bioinformatics, Biocomputational Systems and Biotechnologies, Venice/Mestre, Italy, 22–27 May 2011. [Google Scholar]
  12. Chovancova, E.; Pavelka, A.; Benes, P.; Strnad, O.; Brezovsky, J.; Kozlikova, B.; Gora, A.; Sustr, V.; Klvana, M.; Medek, P.; et al. CAVER 3.0: A tool for the analysis of transport pathways in dynamic protein structures. PLoS Comput. Biol. 2012, 8. [Google Scholar] [CrossRef] [PubMed]
  13. Pavelka, A.; Sebestova, E.; Kozlikova, B.; Brezovsky, J.; Sochor, J.; Damborsky, J. CAVER: Algorithms for analyzing dynamics of tunnels in macromolecules. IEEE/ACM Trans. Comput. Biol. Bioinform. 2016, 13, 505–517. [Google Scholar] [CrossRef] [PubMed]
  14. Bajaj, C.; Gillette, A.; Goswami, S.; Kwon, B.J.; Rivera, J. Complementary space for enhanced uncertainty and dynamics visualization. In Topological Methods in Data Analysis and Visualization; Pascucci, V., Tricoche, X., Hagen, H., Tierny, J., Eds.; Springer: Berlin, Germany, 2010; pp. 217–228. [Google Scholar]
  15. Craig, I.R.; Pfleger, C.; Gohlke, H.; Essex, J.W.; Spiegel, K. Pocket-space maps to identify novel binding-site conformations in proteins. J. Chem. Inf. Model. 2011, 51, 2666–2679. [Google Scholar] [CrossRef] [PubMed]
  16. Raunest, M.; Kandt, C. dxTuber: Detecting protein cavities, tunnels and clefts based on protein and solvent dynamics. J. Mol. Graph. Model. 2011, 29, 895–905. [Google Scholar] [CrossRef] [PubMed]
  17. Ashford, P.; Moss, D.S.; Alex, A.; Yeap, S.K.; Povia, A.; Nobeli, I.; Williams, M.A. Visualisation of variable binding pockets on protein surfaces by probabilistic analysis of related structure sets. BMC Bioinform. 2012, 13, 1–16. [Google Scholar] [CrossRef] [PubMed]
  18. Metz, A.; Pfleger, C.; Kopitz, H.; Pfeiffer-Marek, S.; Baringhaus, K.H.; Gohlke, H. Hot spots and transient pockets: Predicting the determinants of small-molecule binding to a protein-protein interface. J. Chem. Inf. Model. 2012, 52, 120–133. [Google Scholar] [CrossRef] [PubMed]
  19. Lindow, N.; Baum, D.; Bondar, A.N.; Hege, H.C. Dynamic Channels in Biomolecular Systems: Path Analysis and Visualization. In Proceedings of the IEEE Symposium on Biological Data Visualization (biovis’12), Seattle, WA, USA, 14–15 October 2012; pp. 99–106. [Google Scholar]
  20. Lindow, N.; Baum, D.; Bondar, A.N.; Hege, H.C. Exploring cavity dynamics in biomolecular systems. BMC Bioinform. 2013, 14 (Suppl. 19), S5. [Google Scholar] [CrossRef] [PubMed]
  21. Paramo, T.; East, A.; Garzón, D.; Ulmschneider, M.B.; Bond, P.J. Efficient characterization of protein cavities within molecular simulation trajectories: trj_cavity. J. Chem. Theory Comput. 2014, 10, 2151–2164. [Google Scholar] [CrossRef] [PubMed]
  22. Desdouits, N.; Nilges, M.; Blondel, A. Principal component analysis reveals correlation of cavities evolution and functional motions in proteins. J. Mol. Graph. Model. 2015, 55, 13–24. [Google Scholar] [CrossRef] [PubMed]
  23. Laurent, B.; Chavent, M.; Cragnolini, T.; Dahl, A.C.E.; Pasquali, S.; Derreumaux, P.; Sansom, M.S.; Baaden, M. Epock: Rapid analysis of protein pocket dynamics. Bioinformatics 2015, 31, 1478–1480. [Google Scholar] [CrossRef] [PubMed]
  24. Vonásek, V.; Kozlíková, B. Tunnel detection in protein structures using sampling-based motion planning. In Proceedings of the 11th International Workshop on Robot Motion and Control (RoMoCo), Wasowo, Poland, 3–5 July 2017; pp. 185–192. [Google Scholar]
  25. Vonasek, V.; Jurčík, A.; Furmanová, K.; Kozlikova, B. Sampling-Based Motion Planning for Tracking Evolution of Dynamic Tunnels in Molecular Dynamics Simulations. J. Intell. Robot. Syst. 2018, 1–23. [Google Scholar] [CrossRef]
  26. Cho, H.Y.; Cho, H.J.; Kim, M.H.; Kang, B.S. Blockage of the channel to heme by the E87 side chain in GAF domain of Mycobacterium tuberculosis DosS confers the unique sensitivity of DosS to oxygen. FEBS Lett. 2011, 585, 1873–1878. [Google Scholar] [CrossRef] [PubMed]
  27. Brezovsky, J.; Chovancova, E.; Gora, A.; Pavelka, A.; Biedermannova, L.; Damborsky, J. Software tools for identification, visualization and analysis of protein tunnels and channels. Biotechnol. Adv. 2013, 31, 38–49. [Google Scholar] [CrossRef] [PubMed]
  28. Simoes, T.; Lopes, D.; Dias, S.; Fernandes, F.; Pereira, J.; Jorge, J.; Bajaj, C.; Gomes, A. Geometric detection algorithms for cavities on protein surfaces in molecular graphics: A survey. Comput. Graph. Forum 2017, 36, 643–683. [Google Scholar] [CrossRef] [PubMed]
  29. Brown, J.B.; Dukka, K.C.; Tomita, E.; Akutsu, T. Multiple methods for protein side chain packing using maximum weight cliques. Genome Inform. 2006, 17, 3–12. [Google Scholar] [PubMed]
  30. Canutescu, A.A.; Shelenkov, A.A.; Dunbrack, R.L. A graph-theory algorithm for rapid protein side-chain prediction. Protein Sci. 2003, 12, 2001–2014. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  31. Dukka, K.C.; Tomita, E.; Suzuki, J.; Akutsu, T. Protein side-chain packing problem: A maximum edge-weight clique algorithmic approach. J. Bioinform. Comput. Biol. 2005, 3, 103–126. [Google Scholar] [CrossRef]
  32. Kingsford, C.L.; Chazelle, B.; Singh, M. Solving and analyzing side-chain positioning problems using linear and integer programming. Bioinformatics 2004, 21, 1028–1036. [Google Scholar] [CrossRef] [PubMed]
  33. Krivov, G.G.; Shapovalov, M.V.; Dunbrack, R.L. Improved prediction of protein side-chain conformations with SCWRL4. Proteins 2009, 77, 778–795. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  34. Miao, Z.; Cao, Y.; Jiang, T. RASP: Rapid modeling of protein side chain conformations. Bioinformatics 2011, 27, 3117–3122. [Google Scholar] [CrossRef] [PubMed]
  35. Xu, J. Rapid Protein Side-Chain Packing via Tree Decomposition. In Proceedings of the 9th Annual International Conference on Research in Computational Molecular Biology (RECOMB), Cambridge, MA, USA, 14–18 May 2005; pp. 423–439. [Google Scholar]
  36. Xu, J.; Berger, B. Fast and accurate algorithms for protein side-chain packing. J. ACM 2006, 53, 533–557. [Google Scholar] [CrossRef] [Green Version]
  37. Akutsu, T. NP-hardness results for protein side-chain packing. Genome Inform. 1997, 8, 180–186. [Google Scholar]
  38. Pierce, A.N.; Winfree, E. Protein design is NP-hard. Protein Eng. 2002, 15, 779–782. [Google Scholar] [CrossRef] [PubMed]
  39. Bondi, A. van der Waals volumes and radii. J. Phys. Chem. 1964, 68, 441–451. [Google Scholar] [CrossRef]
  40. Kim, Y. Computation of the Motion Range of Flexible Amino Acids by Using a Bounding Sphere Hierarchy. Master’s Thesis, Kyungpook National University, Daegu, Korea, 2014. [Google Scholar]
  41. Lowell, S.C.; Word, J.S.; Richardson, J.S.; Richardson, D.C. The penultimate rotamer library. Proteins 2000, 40, 389–408. [Google Scholar]
  42. Bhuyan, M.S.; Gao, X. A protein-dependent side-chain rotamer library. BMC Bioinform. 2011, 12 (Suppl. S14), S10. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  43. Bron, C.; Kerbosch, J. Algorithm 457: Finding all cliques of an undirected graph. Commun. ACM 1973, 16, 575–577. [Google Scholar] [CrossRef]
Figure 1. The side chain and its rotamers that are represented by atom center points, where R0 is identical to given side chain.
Figure 1. The side chain and its rotamers that are represented by atom center points, where R0 is identical to given side chain.
Molecules 23 02459 g001
Figure 2. Example of the tunnel in the protein molecule and its bottleneck.
Figure 2. Example of the tunnel in the protein molecule and its bottleneck.
Molecules 23 02459 g002
Figure 3. A tunnel (color purple), tunnel adjacent amino acids, and remaining amino acids (color gray).
Figure 3. A tunnel (color purple), tunnel adjacent amino acids, and remaining amino acids (color gray).
Molecules 23 02459 g003
Figure 4. Collisions between rotamers (left) and the corresponding collision free graph (right).
Figure 4. Collisions between rotamers (left) and the corresponding collision free graph (right).
Molecules 23 02459 g004
Figure 5. The combining process of the valid conformations Vj, 0 < j ≤ nj, for the rotamer clique Ci, 0 < i ≤ m.
Figure 5. The combining process of the valid conformations Vj, 0 < j ≤ nj, for the rotamer clique Ci, 0 < i ≤ m.
Molecules 23 02459 g005
Figure 6. Tunnel shape changes with respect to different valid rotamer conformations, where arrows indicate changes of the tunnel shape: (a) tunnel Id. 138 of PDB Id. 1EA1 and (b) tunnel Id. 140 of PDB Id. 1DDZ.
Figure 6. Tunnel shape changes with respect to different valid rotamer conformations, where arrows indicate changes of the tunnel shape: (a) tunnel Id. 138 of PDB Id. 1EA1 and (b) tunnel Id. 140 of PDB Id. 1DDZ.
Molecules 23 02459 g006
Figure 7. The case when the position of tunnel entrance is changed due to the different rotamer conformations, where arrows indicate changes of the rotamer (tunnel Id. 76 of PDB Id. 1MQF).
Figure 7. The case when the position of tunnel entrance is changed due to the different rotamer conformations, where arrows indicate changes of the rotamer (tunnel Id. 76 of PDB Id. 1MQF).
Molecules 23 02459 g007
Figure 8. Dynamics of the tunnel bottleneck with valid rotamer conformations. The top and bottom bars indicate the maximum and minimum bottleneck sizes, respectively. The middle bar shows the average bottleneck size in the deformed tunnels.
Figure 8. Dynamics of the tunnel bottleneck with valid rotamer conformations. The top and bottom bars indicate the maximum and minimum bottleneck sizes, respectively. The middle bar shows the average bottleneck size in the deformed tunnels.
Molecules 23 02459 g008
Table 1. Experimental Results on Finding Valid Rotamer Conformations.
Table 1. Experimental Results on Finding Valid Rotamer Conformations.
PDB Id. (Number of Amino Acids)Tunnel Id.Number of Tunnel Adjacent Amino AcidsNumber of Conformations in Rotamer CliquesNumber of Valid Rotamer ConformationsComputation Time of Valid Rotamer Conformations (s)
1A52 (479)7233829,44017,2800.344
2412215,163,20020,1600.266
1B44 (531)1071713,50021600.046
1483011,796,480,00076,8001.062
1DDZ (962)7824129,60017,2800.234
10927844,800,0003000.062
14022691,200100.032
33426936,448,1283,144,96040.875
1EA1 (447)1522410,8001240.203
1MQF (475)7618139,9682880.032
1MXT (499)9719432320.031
10813113,40038250.047
113268,006,169,60095040.188
2OAR (625)2062814,738,630,4004800.078
21519539,320,320327,6802.984
29818887,040295,6802.656
3DOB (293)3913285,76837,0440.297
431120,41226460.031
531138886480.015
3RLR (440)51855208160.016
1422610,036,2241800.078
179222688560.031
Table 2. Experimental Results on Finding the Maximum Bottleneck.
Table 2. Experimental Results on Finding the Maximum Bottleneck.
PDB Id.Tunnel Id.Number of Valid Rotamer ConformationsTunnel Computation Time for All of Valid Conformations (s)Maximum Bottleneck (Å)Maximum Bottleneck Computation Time (s)
1A527217,28017,3431.2560.015
24120,16019,3291.6220.031
1B44107216022701.1390
14876,80076,9122.1110.078
1DDZ7817,28021,2871.0980.016
1093003590.9260
14010120.9160
1EA11521241201.0060
1MQF762882871.1760
1MXT9732321.1480
108382532561.7210
113950478421.20.016
2OAR2064805531.370.015
3DOB3937,04431,1831.1870.046
43264622171.7310
536486071.9740
3RLR518168551.3210.015
1421801631.0410
17956490.9840

Share and Cite

MDPI and ACS Style

Seo, U.; Kim, K.-J.; Kang, B.S. An Algorithm for Computing Side Chain Conformational Variations of a Protein Tunnel/Channel. Molecules 2018, 23, 2459. https://doi.org/10.3390/molecules23102459

AMA Style

Seo U, Kim K-J, Kang BS. An Algorithm for Computing Side Chain Conformational Variations of a Protein Tunnel/Channel. Molecules. 2018; 23(10):2459. https://doi.org/10.3390/molecules23102459

Chicago/Turabian Style

Seo, Udeok, Ku-Jin Kim, and Beom Sik Kang. 2018. "An Algorithm for Computing Side Chain Conformational Variations of a Protein Tunnel/Channel" Molecules 23, no. 10: 2459. https://doi.org/10.3390/molecules23102459

Article Metrics

Back to TopTop