Abstract

Molecular skin surface (MSS), proposed by Edelsbrunner, is a C2 continuous smooth surface modeling approach of biological macromolecules. Compared to the traditional methods of molecular surface representations (e.g., the solvent exclusive surface), MSS has distinctive advantages including having no self-intersection and being decomposable and transformable. For further promoting MSS to the field of bioinformatics, transformation between different MSS representations mimicking the macromolecular dynamics is demanded. The transformation process helps biologists understand the macromolecular dynamics processes visually in the atomic level, which is important in studying the protein structures and binding sites for optimizing drug design. However, modeling the transformation between different MSSs suffers from high computational cost while the traditional approaches reconstruct every intermediate MSS from respective intermediate union of balls. In this study, we propose a novel computational framework named general MSS transformation framework (GMSSTF) between two MSSs without the assistance of union of balls. To evaluate the effectiveness of GMSSTF, we applied it on a popular public database PDB (Protein Data Bank) and compared the existing MSS algorithms with and without GMSSTF. The simulation results show that the proposed GMSSTF effectively improves the computational efficiency and is potentially useful for macromolecular dynamic simulations.

1. Introduction

Physically understanding the protein-protein or protein-RNA interactions involved in the biological processes is essential for new drug design in biomedical research [1, 2]. Biological macromolecular surface visualization in 3D space helps us to focus on the spatial and structural information of proteins at atomic level and further explains the dynamic changes of molecular structure timely. Biological macromolecule (such as proteins) surface representation has been an important subject in the field of molecular visualization since 1964 [3], where atoms are represented by 3-dimensional spherical structures with the sphere centers at actual atom positions and radii representing the electron fields. For example, the public database PDB (Protein Data Bank) [4] provides the spatial information about the amino acids in each protein in 3D space. The studies of macromolecule surface visualization provide an effective way to improve our understanding of the complex biological processes and functions in tumor cells [5]. In clinic, the aim of modeling the protein surface representation is to potentially reveal the key domains involved in protein-related interactions for optimizing drug design in biotechnology and food industry [69].

In 1999, Edelsbrunner introduced a new paradigm of molecular surface class called the molecular skin surface (MSS) [10]. The MSS is a smooth transformable surface which was soon utilized in the macromolecular visualization assisting drug design and biomedical research [11]. Compared to traditional molecular surface representations, including Van der Waals surface [12], SAS [13], and SES [14], the MSS has the advantages of easy construction, no self-intersection, C2 continuous surface, being decomposable to quadratic patches, and being transformable between multiple MSSs. The static construction of MSS is simple and straightforward by considering all atoms as “balls” in . A special complex named “mixed cells” is constructed by taking the Minkowski sum of Delaunay and Voronoi complexes constructed by all balls. In each mixed cell, the MSS patch is either a sphere patch or a hyperboloid patch, which can be constructed by triangular meshes, or directly rasterized by ray casting. Figure 1 shows several examples of the MSS.

The MSS transformation shows an animation process between two MSSs, namely, source MSS and target MSS. For example, Figure 2 shows a dynamic transformation process between a caffeine molecule and a protein; both molecules are modeled with PDB files. Such transformation visualization processes have decent potentials, for example, visualizing the processes of macromolecular dynamics to assist drug design and bioinformatics research [1518]. However, existing static MSS algorithms slice the animation into a number of time frames and reconstruct each intermediate MSS from the union of balls to achieve the goal. At each step, the underlying Delaunay and Voronoi complexes and mixed cells are reconstructed on CPU. The computational complexity hinders the MSS to be widely used in modern molecular visualization softwares. Moreover, there are concerns about the animation discontinuity because of the discrete slicing and no surface point correspondence between the previous time frame and the next time frame.

In this study, we propose a general MSS transformation framework (GMSSTF) without reconstructing the intermediate MSS from unions of balls [19, 20]. First, by taking two input unions of balls and constructing the corresponding Delaunay and Voronoi complexes and mixed cells, we demonstrate a continuous transformation from the source mixed cell to the target mixed cell. Second, with the continuous mixed cell centers and various weights, we build the MSS in the next time frame by translation and scaling from the current frame. Third, we apply the GMSSTF to partial molecular movements, which is potentially useful in mimicking a single molecule movements. Last, we apply our algorithm to both CPU and GPU approaches of MSS construction to show the efficiency improvements. All experiments are performed with molecular structure downloaded from the public protein database PDB (Protein Data Bank http://www.rcsb.org/pdb/). In summary, the MSSTF has the following four contributions to the literature: (1)Modeling Dynamic Animation Process. It is the first computational framework which requires no reconstruction for the intermediate MSSs using unions of balls. Both the underlying mixed cells structure and the MSS are moving continuously with formulated mathematical expressions. The proposed framework therefore is able to generate high-quality animation process for the analyses in bioinformatics.(2)Handling Partial Molecular Movements. We demonstrate the usefulness of the proposed approach to the partial molecular movements, where the source and target molecules belong to the same molecule with different states (e.g., a protein in folding process). Some atoms positions are identical from the source to the target, which creates degenerate cases for general position assumption. We show the solution of handling such cases.(3)Improving Computational Efficiency. All intermediate mixed cells and MSSs are generated directly by moving the corresponding mixed cell elements or surface points from the previous time frame. The abovementioned approach saves the time of reconstructing the Delaunay and Voronoi complexes for intermediate MSSs. Experimental results show that the efficiency is largely improved compared to traditional static skin approaches.(4)Recording Surface Point Correspondence. Since each intermediate MSS is generated from the previous time frame by moving the surface points, there are surface point correspondences between neighboring frames. The surface point correspondence establishes an atom-atom linkage between the source, intermediate, and target molecules and can be an important evidence in macromolecular dynamics research.

In summary, the proposed computational framework of macromolecule MSS visualization improves the available techniques in the literature and can be potentially useful for protein interaction prediction and drug design.

2.1. The Definition of MSS

The mathematical expression of a weighted point in is , where is the weighted point center and is the weight. The definition of weighted point includes spheres; and the weighted point can be also viewed as a sphere with center and radius . In addition, the weighted point allows the weight to be negative. The weighted distance of a space point from a weighted point is defined as .

A MSS is constructed by a set of weighted points . Three weighted point operations are defined, including addition, scalar multiplication, and square root for and , respectively: where is the dot product of and .

The convex hull of B is defined as The MSS body is the union of all shrunken weighted points in , and the C2 continuous surface MSS is defined as the boundary of the union of all shrunken weighted points in conv(B), which is formally expressed as

Figure 3 depicts a MSS defined by two weighted points in . The input weighted points are the two largest blue circles; and the MSS is drawn in red.

2.2. The Construction of MSS

In , the MSS is constructed by a set of spheres with the sphere algebra. The resulting MSS is a C2 continuous surface defined by the convex hull of a set of shrunken spheres in , which can be decomposed into sphere and hyperboloid patches using the definition of Delaunay and Voronoi complexes. The flowchart of the MSS construction process is shown in Figure 4. The whole process of MSS construction can be partitioned into two phases. For the first phase, we construct the Delaunay and Voronoi complexes from a union of balls/atoms and take the Minkowski sum to form a more complex structure called the mixed cells. The mixed cell structure partitions the MSS into patches. In each mixed cell, the MSS patch is either a formulated sphere patch or a formulated hyperboloid patch. In the second phase, we model and build every patch within its local mixed cell. The combination of all patches is the final MSS.

2.2.1. The Delaunay and Voronoi Complexes and Mixed Cells

From the geometry insight, the Delaunay and Voronoi complexes can be easily obtained from the weighted point set [21]. By basic definition, the Voronoi region of can be defined by the equation: where denotes the weighted distance from to .

Then, a Voronoi cell of a set of weighted points can be written as , and the Voronoi complex of is the collection of all for [22]. A Delaunay cell is a complementary geometric element of the Voronoi cell [23]. The collection of all Delaunay cells is called the Delaunay complex of and denoted as . The general position assumption is usually made so that the resulting Delaunay complex is always a simplicial complex. The traditional general position (TGP) assumption is defined as [24]. Under the TGP assumption, the Delaunay cells in can be summarized involving four types, namely, vertices, edges, triangles, and tetrahedra.

The mixed cell structure is a mixture of Delaunay and Voronoi complexes [10]. A mixed cell is formed by taking the Minkowski sum of and . We also provide the definitions for the mixed cell center and mixed cell weight : where is a ball orthogonal to [21].

2.2.2. Sphere and Hyperboloid Patches

The mixed cells partition the MSS into sphere and hyperboloid patches which both can be represented by quadratic equations in the standard forms: by translating to the origin and orienting the symmetry axis to the -axis for hyperboloid patch cases. In (10), the ± sign represents the choices of one-sheet or two-sheet hyperboloid. The corresponding patch type of each mixed cell type is shown in Table 1. The table will be expanded while the TGP assumption is extended in superimposed Voronoi complexes [25].

2.2.3. CPU and GPU Implementation of MSS Visualization

Since the MSS was born in 1999, in the last decade, many efforts have been made to fast visualize the MSS with guaranteed resolution in order for MSS to be used in biomedical science and engineering. On the CPU side, Kruithof and Vegter proposed to triangulate the MSS within each patch [26]. Since the overall MSS can be decomposed to quadratic patches, it is convenient for them to project each patch into 2 dimensions and triangulate the patch with small triangles. The problem of Kruithof and Vegter's approach is that the triangles have completely no quality control and will be possibly distorted during the process of projecting. In 2004 and 2005, Cheng and Shi improved the triangulation quality of MSS by introducing the restricted Delaunay triangulation to the mesh representation [27, 28]. Instead of meshing sampled points on the skin surface and controlling the triangle quality by edge contraction and circumcenter insertion, they triangulate the sample points in 3 dimensions and take the surface triangle as the final mesh. The 3-dimensional triangulation satisfies the Delaunay property.

On the GPU side, Chavent et al. [29, 30] utilized GPU to speed up the rasterization and promote the MSS to real-world molecular visualization in the field of bioinformatics. It is noted that although Chavent et al.’s approach is named as the GPU approach, they utilize the CPU construction of Delaunay and Voronoi complexes and mixed cells in the first phase. And the GPU processing based on rasterization using ray tracing is only applied in the second phase. Lindow et al. [31] demonstrated how to further accelerate Chavent’s method by paralleling the first phase.

2.3. Existing Transformation Algorithms

Existing automatic transformation/morphing algorithms can be categorized into three types according to the surface representation of the source and target shapes. Explicit surface transformation methods [32, 33] represent objects in mesh form. The morphing trajectory is found by the vertices correspondence between the source and target shapes. By prespecified vertex correspondence or skeleton information, the explicit surface morphing methods handle morphings well between similar objects [34, 35]. However, it is usually difficult to handle topology changes automatically, for example, controlling splitting/merging and creation of holes and tunnels [36, 37]. Volumetric transformation methods [38] improve the explicit surface morphing methods by representing objects in voxels form. The transformation animation is achieved by mapping from one voxel in source shape to another voxel in target shape. One recent work by Wu et al. [39] shows that the volumetric transformation methods handle topology changes well. Implicit surface transformation methods [4042] represent source and target shapes by implicit functions. Topology changes again can be well handled. However, both volumetric transformation methods and implicit surface transformation methods require user-defined information, such as representative vertex correspondence or skeletons of the source/target shapes.

To our knowledge, there is no transformation/morphing method available that satisfies all the following three criteria: (1)Handling topology changes automatically(2)Not requiring user-specified anchor points between source and target shapes(3)Not requiring skeleton information of source and target shapes.

The general molecular skin surface transformation framework (GMSSTF) that we proposed in this paper satisfies all the three requirements as stated above, which is potentially useful in mimicking macromolecular transformation/interactions in macromolecular dynamics studies.

3. Transformation between Different MSSs

In this section, we present a transformation/morphing framework between two MSSs. The proposing transformation framework translates, scales the intermediate mixed cell, and generates each intermediate MSS from its previous time frame, which has the potential to largely improve the computational efficiency of the transformation, regardless of the MSS representation. Moreover, the proposed method requires no external information such as anchor point assignments or skeleton information. The implicit function property of the MSSs guarantees the automatic topology change handling during the transformation process.

3.1. General MSS Transformation Framework

The general MSS transformation framework (GMSSTF) slowly transforms one MSS (source) to another MSS (target). The two MSSs can be the same molecule in different forms (Section 4), or two different molecules. The underlying Voronoi complex is mathematically proved as a fixed underlying structure by Chen and Cheng in 2006 [25]. The corresponding Delaunay complex transforms along with the intermediate MSS with linear interpolation.

The GMSSTF describes the vertex flow trajectories between two MSS triangular meshes without any extra information, such as skeleton or vertex correspondence. Suppose the source MSS mesh is positioned at time ; and the target MSS mesh is positioned at time . All intermediate MSS meshes are generated by interpolation between the source shape and target shape with a . While and are the weighted point sets of the source and target MSSs, the intermediate weighted point set is where ; and the intermediate MSS can be obtained directly from [43].

3.2. Intermediate Voronoi Complexes

The GMSSTF guarantees all intermediate MSSs share the same Voronoi complex structure, which is superimposition of the source Voronoi complex and the target Voronoi complex [25]: where and are the source and target Voronoi complexes, respectively, constructed under TGP assumption.

For the superimposed Voronoi complex V, the TGP is violated, where we allow where is the Euclidean space dimension.

Figure 5 illustrated a new type Voronoi vertex which is created by intersecting two Voronoi edges and bounded by four Voronoi regions. The new definition of general position assumption is named as superimposition general position (SIGP) assumption [25].

There are six possible intermediate Voronoi cell types under SIGP assumption after superimposing Voronoi complexes in (Table 2). Each type of intermediate Voronoi cells can be identified by a tuple: , with the assumption that . The first four Voronoi cell types in Table 2 are identical to the four Voronoi cell types in Table 1. The new types are the last two types, namely, (2,2,1) and (2,1,0), which represent the two situations violating the TGP assumption. Tuple (2,1,0) describes the case while a Voronoi face (shared by two Voronoi regions) intersects a Voronoi edge (shared by three Voronoi regions) at a vertex. This resulting Voronoi vertex is shared by six Voronoi regions under the SIGP assumption.

3.3. Transforming Delaunay Complexes and Intermediate Mixed Cells

We denote the intermediate Delaunay complex, , as the Delaunay complex of , and it is not a simplicial complex. Apart from regular Delaunay triangulation, we define the intermediate Delaunay complex as where

With the fixed underlying intermediate Voronoi complex, every Delaunay cell in Table 2 can be translated and scaled according to linear interpolation between the source weighted point positions and target weighted point positions. Figure 6 illustrates the linear interpolation from an edge of the source Delaunay complex and a triangle of the target Delaunay complex, which is the case of Tuple (2,1,0) in Table 2. All six vertices of the intermediate Delaunay triangular prism follow the linear interpolation from the source vertices to the target vertices.

Each intermediate mixed cell is calculated by taking the Minkowski sum of the corresponding Delaunay cell and Voronoi cell (Table 2), where the mixed cell center is determined by the intersection between Delaunay and Voronoi cells and the mixed cell weight is calculated according to the mixed cell center position. The combination of the mixed cell center position and weight determines the skin patch within the mixed cell.

Since the intermediate Voronoi cells are fixed, and the intermediate Delaunay cells transform according to linear interpolation, the intermediate mixed cell center positions can be calculated by taking the linear interpolation between the source mixed cell centers and target mixed cell centers: and the mixed cell weight is computed accordingly:

3.4. Transforming Sphere and Hyperboloid Patches

The transformation of the MSS patches (either sphere or hyperboloid patches) relies on the transformation of the mixed cells. In each local coordinate system of an intermediate mixed cell , the translation of the mixed cell center and the variance of the mixed cell weight determine the surface point moving trajectory of the intermediate MSS. Suppose a MSS surface point at time is known. The point position at the next time frame can be calculated with the local mixed cell center translation and the mixed cell weight scaling factor :

The local mixed cell weight for both and can be calculated with the assistance of (17) and (18).

4. Partial Molecular Movements

In real-world macromolecular dynamics, partial molecular movement simulation visualization is required, where the source and target shapes are from the same molecule in different forms. The molecule changes only part of its structure, and the rest of the atoms remain unchanged (Figure 7).

However, the SIGP assumption is again unavoidably violated if partial molecular movement happens. In Figure 8, we show a simple “molecule” with four atom centers in , and one of its atoms moves to a different position. In the intermediate Voronoi complex, two Voronoi edges from two Voronoi complexes intersect at an edge endpoint that is not allowed by SIGP assumption in GMSSTF algorithm. The dual Delaunay cell of is a trapezoid, which is new to GMSSTF algorithm. In this section, we attack this more complex degeneracy problem and introduce more types of intermediate Delaunay and Voronoi cells during the MSS transformation.

4.1. Degenerate Intermediate Voronoi Complexes

In partial molecular movement, we allow where is the Euclidean space dimension.

In , we have seven additional degenerate cases for Table 2, namely, (2,2,2), (2,1,1), (2,0,0), (1,1,1), (1,1,0), (1,0,0), and (0,0,0) (see Table 3).

For each type, we demonstrate the shape of Voronoi cells and further conclude the shape of Delaunay cells using (14). In type (2,2,2), two coplanar Voronoi polygons overlap with each other, and the intersection is a polygon (Figure 9(a)). There are two Voronoi regions sharing this polygon. The two weighted points of these two regions form a convex hull that is a Delaunay edge. In type (2,1,1), a Voronoi edge intersects a Voronoi face and forms another Voronoi edge (Figure 9(b)). The resulting intermediate Voronoi edge is surrounded by four or five Voronoi regions, which are contributed by four or five intermediate weighted points. The convex hull of these weighted point centers is a quadrangle or pentagon. In type (1,1,0), two Voronoi edges intersect at a Voronoi vertex (Figure 9(c)). The Voronoi vertex is surrounded by nine Voronoi regions. The intermediate Delaunay cell is a 9-vertex polyhedron. In type (1,1,1), two Voronoi edges overlap and form an intermediate Voronoi edge (Figure 9(d)). There are minimally 3 and maximally 6 Voronoi regions surrounding this intermediate Voronoi edge. The intermediate Delaunay cell is a polygon with 3 to 6 vertices. For types (2,0,0), (1,0,0), and (0,0,0), the intermediate Voronoi cell is always a vertex. The intermediate Delaunay cells are obtained by counting the number of surrounding Voronoi regions.

Although the number of intermediate Voronoi cell types increases, the types of skin patches remain the same as hyperboloids and spheres. The transformation of intermediate skin surfaces still follows the approach described in Section 3.4.

5. Results

We apply the GMSSTF to both CPU and GPU approaches of MSS modeling. Suppose the source molecule consists of atoms and the target molecule consists of atoms. In the process of transformation, both CPU and GPU approaches reconstruct each intermediate MSS using balls. It is noted that both approaches construct the underlying Voronoi and Delaunay complexes and mixed cells on CPU in the first phase (Figure 4). In contrast, the GMSSTF precomputes the fixed underlying Voronoi complex and transforms the Delaunay complex and mixed cells using linear interpolation. The new approach largely saves the time in the MSS transformation process.

Nine closely related molecule structures are downloaded from the Protein Data Bank (http://www.rcsb.org/pdb/) [4] to form ten different transformation processes. The PDB IDs of the nine molecules are 1J5F, 100D, 133D, 101D, 1AIE, 1D63, 114D, 161D, and 1XD7. All downloaded files are followed with extension .pdb. In Table 4, we compare the CPU construction time with/without GMSSTF using Kruithof and Vegter’s approach (KVA) [26] and Cheng and Shi’s quality mesh approach (CSA) [28]. The experiment is performed on a machine with Intel [email protected] GHz and 8 GB RAM. Each transformation process generates 1000 intermediate MSSs. The average time taken for each intermediate MSS with the source and target molecules and the number of atoms is listed in Table 4.

Figures 10 and 11 show the computational time differences using KVA and CSA with/without GMSSTF, respectively. It is clear that the GMSSTF largely reduces the computational time on generating intermediate MSS in the transformation process because of the reuse of intermediate Delaunay and Voronoi complexes. The average speedup is around 0.9.

We also implement the GPU visualization on MSS using Chavent’s algorithm. It is noted that the first phase of Chavent’s algorithm utilizes the same approach as KVA and CSA to generate the intermediate Voronoi and Delaunay complexes, as well as the mixed cell and MSS patch function. Therefore, the GMSSTF again effectively improves the performance on GPU implementation of MSS (Table 5 and Figure 12). The average speedup is around 3.2.

It is noted that both CPU and GPU approaches are able to generate high-quality transformation animations between macromolecules. Two supplementary videos available online at https://doi.org/10.1155/2017/4818604, namely, “114D-161D.wmv” and “161D-1DX7.wmv,” are attached to this paper to show the transformation from 114D to 161D and from 161D to 1DX7, respectively. The only difference exists only in terms of time complexities. For fare comparison purpose, we use many-to-many mapping between the source atoms and target atoms, which maps each atom from the source molecule to each atom from the target molecule. All produced animation processes are therefore identical. By using the proposed GMSSTF, we have shown the significant efficiency improvement for all approaches.

6. Conclusions and Discussions

In this study, we introduced a general MSS transformation framework which is potentially useful in mimicking biological macromolecular dynamics in bioinformatics research. We illustrated the solutions for a transformation process from one molecule to another as well as the transformation of a single molecule in different forms. The proposed framework requires no anchor point or skeleton information and handles topology changes automatically.

In order to validate the effectiveness of the proposed approach, we applied our method on the PDB database to model the biological macromolecular surface transformation process. The simulation results show that our method speeds up the traditional approaches. Although the traditional approaches, such as KVA, CSA, and Chavent’s algorithm, also produce the similar animation process without GMSSTF, the construction of the first phase, that is, the Delaunay and Voronoi complexes and mixed cells, is recomputed for every intermediate frame. With GMSSTF, we reuse the previous frame’s information to build the next frame’s MSS with only translation and scaling operations. The new approach results in significant efficiency improvements using different PDB files.

In fact, each of the KVA, CSA, and Chavent’s algorithm can generate different transformation processes if we assign atom correspondences manually (by consulting experts). However, for simplicity and fare comparison purposes, in this study, we use many-to-many mapping which assigns each atom from the source molecule corresponding to each atom from the target molecule.

As a future work, we will consult biologist for the usefulness of such an animation process. To mimic the real-world biological macromolecular dynamics, local control will be required, which is not considered in the current GMSSTF. Moreover, for given source and target molecules, different transformation processes will be generated for the biologist to choose. This can be done by employing the concept of shape space [44].

Conflicts of Interest

The authors declare that they have no competing interests.

Authors’ Contributions

Ke Yan and Holun Cheng provided the idea of this study. Ke Yan, Bing Wang, and Zhiwei Ji wrote the paper. Jing Huang and Zhigang Gao contributed to the experiments.

Acknowledgments

This work was supported by the National Science Foundation of China (nos. 61602431, 61572164, and 61402417). This study was also supported by the foundation of talents start-up project in China Jiliang University (no. 000485), the foundation of talents start-up project in Zhejiang Gongshang University (no. 1120XJ2116016), Zhejiang Provincial Natural Science Foundation under Grant no. LY15F020037, and Key University Construction Projects of Hangzhou Dianzi University under Grant no. GK168800299017-9.

Supplementary Materials

A MSS transformation between a molecule with PDB indexed 114D and another molecule with PDB indexed 161D.

A MSS transformation between a molecule with PDB indexed 161D and another molecule with PDB indexed 1DX7.

  1. Supplementary Material
  2. Supplementary Material