Abstract
Molecular cavities, which include voids and channels, are critical for molecular function. We present a webserver, BetaCavityWeb, which computes these cavities for a given molecular structure and a given spherical probe, and reports their geometrical properties: volume, boundary area, buried area, etc. The server's algorithms are based on the Voronoi diagram of atoms and its derivative construct: the beta-complex. The correctness of the computed result and computational efficiency are both mathematically guaranteed. BetaCavityWeb is freely accessible at the Voronoi Diagram Research Center (VDRC) (http://voronoi.hanyang.ac.kr/betacavityweb).
INTRODUCTION
Molecular structure determines molecular function. Of particular importance are the ‘gaps’ within a structure—internal voids, channels running through it, pockets in the surface—because biological molecules perform their tasks via interactions with other molecules in their environment and these interactions often take place in these spaces. This paper reports a webserver, BetaCavityWeb, which recognizes voids and channels in molecular structures and measures their geometrical properties such as volume, area of cavity boundary and atoms contributing to geometric features.
Here we define a void as a cavity in a molecular interior that is not accessible to bulk solvent around the molecule and can be either hydrated or free from any solvent molecule. A channel is defined as a hole penetrating a molecular structure with two or more openings toward the exterior space through which a solvent or ligand molecule can freely pass (1,2).
The first work on the properties of voids in molecular structures was Connolly's MS program in the early 80s (3,4). MS used a rolling ball on the surface of a molecule to define a shell corresponding to the external molecular boundary and an internal void boundary. Many methods have since been developed for identifying the empty regions, specifically for locating potential binding sites. In 1994, Kleywegt and Jones developed VOIDOO which recognized voids by embedding the molecule in a grid and checking which grid points were not within any of the atoms (5). Another method using a grid was AVP (6). The SURFNET program fitted spheres into the spaces between pairs of atoms and then identified the voids as clusters of these spheres (7). Sheffler and Baker developed RosettaHoles to recognize voids by first generating a set of void-filling balls that cover the interstitial space in a molecule and then applying the statistical learning technique of support vector machines (8). Liang et al. developed the VOLBL program using the alpha-shape which was based on the power diagram (9) and further improved into CASTp (10). Most recently the BetaVoid program was developed by Kim et al. and used the beta-complex derived from the Voronoi diagram of spherical atoms and its derivative constructs. They showed that it outperforms existing methods (11) including CASTp (10).
The earliest efforts on the recognition of molecular channels came during the mid 90s for computing the pore dimensions of ion channels. The HOLE program (12) required the user to specify an initial location within a channel and its direction. It then used Monte Carlo simulation to recognize the channel. Subsequent studies on channel recognition have been reported relatively recently. In 2006, Voss et al. showed that channel geometry is important for ribosomal polypeptides in determining biomolecular function (13). Channel geometry is also important for transmembrane proteins in selecting transport of ions, small molecules and even large molecules (14–18). In 2006, Damborský and colleagues reported a grid-based method for extracting cavities by tracing routes from buried active sites to the external solvent and developed CAVER (19) as a plug-in to PyMOL (20). Otyepka and colleagues developed MOLE using the ordinary Voronoi diagram of atom center points (21). The MolAxis program used the alpha-shape of the molecule, where atoms were approximated by a number of identically sized balls (22). In 2009, Pellegrini-Calace et al. reported the PoreWalker server which computed channels in transmembrane proteins. The method took advantage of the knowledge that secondary structures are usually aligned with the medial axis of the channel, and additionally used to geometric information (23). An important step forward was made by Hege and colleagues in 2011 (24) who adapted an algorithm which traced the edges in the Voronoi diagram of atoms (25). In 2012, Otyepka's group reported the MOLEonline 2.0 server, which was an improved version of the original MOLE program mentioned above (26), and Damborský's group produced a new version of CAVER, as CAVER 3.0, which could analyze both static structures and molecular dynamic trajectories, now using the ordinary Voronoi diagram of points by approximating atoms with several spherical balls with identical radii (27).
There are two critical issues in cavity recognition. First, an accurate, efficient and convenient approach is necessary for recognizing and measuring cavities. Vlassi et al. have pointed out the difficulty of comparing void sizes produced from different programs due to the different computational methods and parameters used (28). They concluded that cavity volume was a poor parameter for analyzing structural responses to mutation because of the unreliable and somewhat contradictory computational results. This suggests that a more accurate and reliable mathematical method and its implementation is necessary. Second, there are various types of information to be analyzed and reported regarding cavities. The volume and area are only two of these. For example, Hubbard et al. pointed out that there were numerous types of analysis possible regarding molecular voids (29): position, size and shape, number of voids, polarity, packing of solvent in cavities, distribution of cavity volumes for solvated and empty cavities, amino acid preferences for accessible and buried protein surfaces, hydrogen bonding of polar atoms and solvent within voids, mobility of cavity atoms, etc. For this purpose, it is necessary to have a formal representation of molecular structure. These two issues are the motivation for BetaCavityWeb. Voids and channels are indeed important quality measures of computational protein design (30). BetaCavityWeb is accurate, efficient and convenient and is freely available at the VDRC (http://voronoi.hanyang.ac.kr/betacavityweb).
METHODS AND MATERIALS
Voronoi diagrams, quasi-triangulations and beta-complexes
Let A = {a1, a2, …, an} be a set of three-dimensional spherical atoms where ai = (ci, ri) is an atom with center ci and vdW-radius ri. Consider A a molecule. Let be the Voronoi cell for ai defined as
. Then, the Voronoi diagram
for the atom set A is defined as
where the connectivity among the topological entities are appropriately represented. In the three-dimensional space,
can be represented as
where
is the set of Voronoi vertices,
is the set of Voronoi edges,
is the set of Voronoi faces and
is the set of Voronoi cells. The topology among vertices, edges, faces and cells in
are properly maintained in the radial-edge data structure (31). Suppose that AO is an offset model where
is an offset atom where its radius is increased by a constant amount δ from the atom ai ∈ A. Then, it is known that the topology of the Voronoi diagram
for AO is identical to that of
. Thus, we call the Voronoi diagram of atoms
offset-invariant. Formally, in the computational geometry community,
is called the additively weighted Voronoi diagram. Note that
in Figure 1(c) is different from both the ordinary Voronoi diagram of points where the points correspond to atom centers in Figure 1(a) and the power diagram in Figure 1(b). For the details of
and its algorithm, refer to (25,32) and for the Voronoi diagram in general, refer to (33). Figure 1(c) shows the
of a two-dimensional atom set A which consists of six circular disks. Figure 1(d) shows the two offset curves for different offset amounts where the intersections between offset circles are always placed on the Voronoi edges.
Figure 1.
Voronoi diagrams and derivative constructs (figures drawn by the BetaConcept program). (a) Ordinary Voronoi diagram of center points of circle generators, (b) power diagram of circle generators, (c) Voronoi diagram of circle generators, (d) invariant Voronoi diagram of offset, (e) quasi-triangulation and (f) beta-complex.
The quasi-triangulation is the dual structure of
and is represented as
where
,
,
and
are one-to-one dual-mapped from
,
,
and
, respectively. As
is different from the ordinary Voronoi diagram of points,
is different from the Delaunay triangulation which is the dual structure of the ordinary Voronoi diagram.
is offset-invariant and so is
. For the details of
, see (34–36). Figure 1(e) shows
of A.
The beta-complex is defined from
when a spherical probe with radius β is given. Consider an edge e in
and the two atoms corresponding to the vertices of e. If the probe can pass between the two atoms without any intersection, we remove e from
. Similarly, if the probe can pass among the three atoms corresponding to the vertices of a triangular face f in
, we remove f from
. If we apply this operation for all the simplexes in
, we eventually have the beta-complex
which is therefore a subset of
. The region of Euclidean space bounded by
is called the beta-shape
. Hence, each simplex on the boundary of
determines the proximity among the atoms on the boundary of the molecule where the boundary is defined by the probe. Each simplex in
determines the proximity among all atoms on and within the boundary of the molecular structure. We emphasize here that the beta-complex can be computed very efficiently from the quasi-triangulation. For details, see (37). Figure 1(f) shows an example of
for β-value. Note that Figure 1 was drawn by BetaConcept (38).
The BetaCavity algorithm
Consider a vdW-molecule A and its offset model AO, offset by an amount δ ≥ 0. The boundary ∂AO of the offset model is equivalent to the Lee–Richards (solvent accessible) surface for a solvent molecule probe with the radius δ.
Suppose that of A is computed. Due to the offset invariant property,
is also the Voronoi diagram of AO. Let
be an abstraction of
without V-cells. We compute the Voronoi complement VorC = (VC, EC, FC) by trimming the structure of Vor with each offset atom in the offset model AO. VorC can be computed in O(m) time in the worst case, where m represents the number of entities in the Voronoi diagram. The BetaCavity algorithm is detailed in (39) from which we quote the following theorem fundamental for the BetaCavityWeb server. Note that the BetaVoid program is the implementation for voids (11).
Theorem 1. The Voronoi complement VorC and the space external to an offset model are homotopy equivalent.
Therefore, a Voronoi complement and the exterior of an offset model have an identical topological property and its structure can be used to correctly recognize the voids and channels of the offset model. A Voronoi complement consists of one or more components. If there is only one component, it corresponds to the external space possibly with channels without any void. If there are two or more components, the one connected to infinity corresponds to the external space and each of the others corresponds to a void. Given VorC = {ξ1, ξ2, …} where ξi is a component, we classify its components corresponding to the unbounded external region and voids.
There are two types of Voronoi edges in the component ξ of VorC for the unbounded region: those intersecting the boundary of an offset model and those non-intersecting. Similarly, there are two types of Voronoi faces: those intersecting and those non-intersecting Voronoi faces. Given ξ, we remove the intersecting edges and faces. Then, the contraction of each Voronoi face to one of its bounding Vornoi edges reduces ξ to a graph called the Voronoi graph which consists of vertices and edges. Then, the Euler-Poincaré formula of the Voronoi graph of ξ gives the information about the topology of the channel (i.e. the existence of handles). In the case of channels, the Voronoi graph is called its spine and reveals the topology of the channel. For details about the Euler-Poincaré formula, see (31). The volume and area of each cavity can be correctly and efficiently computed by applying the beta-decomposition algorithm (40). The Supplementary material illustrates the recognition of channels and voids using two example molecules.
RESULTS AND DISCUSSION
The functions of the BetaCavityWeb server
BetaCavityWeb has two ways of taking an input molecular structure. As the server mirrors the molecular structures in the PDB (41), users can simply enter a PDB accession code. Alternatively, users may upload their own molecular structures stored in PDB format. Users can indicate whether they wish to compute voids and/or channels with respect to a solvent probe with a specified radius, β.
BetaCavityWeb produces both text and graphics output as shown in Figure 2 (For 1jd0, see (42); For the role of the channel in carbonic anhydrase, see (43)). The textual output consists of three sections: the header, containing overall information about the session, and two other sections containing information on the voids and channels in the structure. Statistics such as the van der Waals volume and area and the computation time are also reported. Each of the void and channel sections contain information such as the number of cavities, their geometrical properties, a list of atoms defining their boundary, etc.
Figure 2.
An output page for human carbonic anhydrase XII (PDB id: 1jd0).
A probe radius of zero corresponds to the van der Waals surface and thus the recognized cavities are the van der Waals cavities. If the probe radius is nonzero, the recognized cavities are the Lee–Richards (solvent accessible) cavities. In the case of channels, BetaCavityWeb further reports the topological properties of each one: the number of openings (i.e. entrances and exits), the number of topological handles within the channel, the number of atoms contributing to the channel boundary, the atom triplets defining an area on the channel boundary, etc. BetaCavityWeb also reports channel spines and the bottleneck of each channel (i.e. its narrowest point). We emphasize that solution correctness and computational efficiency are mathematically guaranteed. BetaCavityWeb allows a user to choose individual cavities for further analysis. The textual output can be customized by the user before downloading.
The graphical output, which employs JSmol (44), is shown in Figure 2. The computed voids and channels can be displayed together with a molecular structure represented by a space-filling, ball-and-stick, stick, or line model. Figure 3(a) and (b) show the computed voids in the Lee–Richards solvent accessible surface and the atoms contributing to the boundary of the largest void, respectively. Channels can be visualized in three different ways: (i) a spine, (ii) a radius-varying ball sweeping through a spine where the radius is determined by the perpendicular distance from its center to the boundary of nearby atoms and (iii) the atoms contributing to channel boundary. Figure 4 shows channels: (a) the spines of all recognized channels, (b) the spine-sweeping ball of all channels, (c) the spine-sweeping ball of the largest channel and (d) the atoms contributing to the boundary of the largest channel. The largest channel is usually meaningful from a biological point of view while the tiny ones, such as those in Figure 4(b), are meaningless as they are defined only from a geometric point of view.
Figure 3.
Voids (1jd0, probe radius: 1.4Å) computed by and visualized in BetaCavityWeb. (a) Lee–Richards (accessible) surface representation, and (b) contributing atoms of the biggest void.
Figure 4.
The channels for 1jd0 (probe radius: 1.4Å) computed by and visualized in BetaCavityWeb. (a) the spines of all recognized channels, (b) the spine-sweeping ball of all channels (Tiny ones are meaningless), (c) the spine-sweeping ball of the biggest channel and (d) the atoms contributing to the boundary of the biggest channel.
The components of BetaCavityWeb
BetaCavityWeb is composed of four components: (i) a geometric kernel, (ii) a trimmer of the Voronoi diagram, (iii) a classifier of the Voronoi graph and (iv) an evaluator of geometric properties. The geometric kernel computes the Voronoi diagram, transforms to a quasi-triangulation and extracts the beta-complex. The trimmer computes the Voronoi complement by trimming the Voronoi structure intersecting a van der Waals molecule or a Lee–Richards solvent accessible surface model (i.e. the offset model) and converts the Voronoi complement into the Voronoi graph. The classifier parses the Voronoi graph to recognize voids and channels. The evaluator computes geometrical properties such as volume, boundary area, etc. of the recognized voids and channels. Figure 5 shows how these components are related: arrows denote the computational logic and data flow.
Figure 5.
The BetaCavityWeb server's components and computational flow.
QTDB: computational acceleration
The timing for the computation of the quasi-triangulation for molecular structures in the PDB is important. In most cases, a molecule of interest might have several analyses performed. In such cases the quasi-triangulation only needs to be computed once and can be reused for subsequent analyses. Hence, it is convenient to compute the quasi-triangulation in a preprocessing stage and store it in a database so it can be recalled when required. This approach is possible because the Voronoi diagram of atoms and the quasi-triangulation are offset invariant. For this purpose, we have defined a quasi-triangulation file format (QTF) (45) to store the data in a quasi-triangulation database (QTDB), available from the VDRC. Users can simply download the QTF file corresponding to the PDB file of interest and convert it to a Voronoi diagram. The QTF file takes O(m) memory for a quasi-triangulation with m simplexes and the conversion from a quasi-triangulation to the Voronoi diagram or vice versa takes O(m) time in the worst case. If it is necessary or desirable, users can build their own QTDB by running the QTFier program available from the VDRC. Figure 6 shows this approach.
Figure 6.
The computational acceleration with QTDB: n: # atoms; m: # simplexes; m = O(n2) for general spheres but m = O(n) for molecules.
CONCLUSIONS
We report the BetaCavityWeb server which recognizes molecular voids and channels and computes their geometric properties. BetaCavityWeb is based on the Voronoi diagram of atoms, its quasi-triangulation and the beta-complex whose properties are all mathematically proven. The algorithms used in the computation are correct and efficient with mathematical guarantee. With the BetaCavityWeb server, researchers can easily and freely access the powerful capabilities of the Voronoi diagram of atoms to analyze molecular voids and channels.
SUPPLEMENTARY DATA
Supplementary Data are available at NAR Online.
FUNDING
NRF [2012R1A2A1A05026395 to Kim, Cho, Lee and Kim]; [2011-0030030 to Ryu], Korea; Grant-in-Aid for Scientific Research [24650015, 24360039 to Sugihara] of MEXT, Japan. Funding for open access charge: NRF [2012R1A2A1A05026395], Korea.
Conflict of interest statement. None declared.
REFERENCES
- 1.Brezovskya 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. doi: 10.1016/j.biotechadv.2012.02.002. [DOI] [PubMed] [Google Scholar]
- 2.Strnad O., Kozlikova B., Sochor J. Detection of intramolecular tunnels connecting sequence of sites in protein structures. Adv. Intell. Syst. Comput. 2014;294:73–80. [Google Scholar]
- 3.Connolly M.L. Solvent-accessible surfaces of proteins and nucleic acids. Science. 1983;221:709–713. doi: 10.1126/science.6879170. [DOI] [PubMed] [Google Scholar]
- 4.Connolly M.L. Computation of molecular volume. J. Am. Chem. Soc. 1985;107:1118–1124. [Google Scholar]
- 5.Kleywegt G.J., Jones T.A. Detection, delineation, measurement and display of cavities in macromolecular structures. Acta Crystallogr. D. 1994;50:178–185. doi: 10.1107/S0907444993011333. [DOI] [PubMed] [Google Scholar]
- 6.Cuff A.L., Martin A.C.R. Analysis of void volumes in proteins and application to stability of the p53 tumour suppressor protein. J. Mol. Biol. 2004;344:1199–1209. doi: 10.1016/j.jmb.2004.10.015. [DOI] [PubMed] [Google Scholar]
- 7.Laskowski R.A. SURFNET: A program for visualizing molecular surfaces, cavities, and intermolecular interactions. J. Mol. Graph. 1995;13:323–330. doi: 10.1016/0263-7855(95)00073-9. [DOI] [PubMed] [Google Scholar]
- 8.Sheffler W., Baker D. RosettaHoles2: a volumetric packing measure for protein structure refinement and validation. Protein Sci. 2010;19:1991–1995. doi: 10.1002/pro.458. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Liang J., Edelsbrunner H., Fu P., Sudhakar P.V., Subramaniam S. Analytical shape computation of macromolecules: I. molecular area and volume through alpha shape. Proteins. 1998;33:1–17. [PubMed] [Google Scholar]
- 10.Dundas J., Ouyang Z., Tseng J., Binkowski A., Turpaz Y., Liang J. CASTp: Computed atlas of surface topography of proteins with structural and topographical mapping of functionally annotated residues. Nucleic Acids Res. 2006;34:W116–W118. doi: 10.1093/nar/gkl282. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Kim J.-K., Cho Y., Laskowski R.A., Ryu S.E., Sugihara K., Kim D.-S. BetaVoid: molecular voids via beta-complexes and Voronoi diagrams. Proteins. 2014;82:1829–1849. doi: 10.1002/prot.24537. [DOI] [PubMed] [Google Scholar]
- 12.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. doi: 10.1016/s0263-7855(97)00009-x. [DOI] [PubMed] [Google Scholar]
- 13.Voss N.R., Gerstein M., Steitz T.A., Moore P.B. The geometry of the ribosomal polypeptide exit tunnel. J. Mol. Biol. 2006;260:893–906. doi: 10.1016/j.jmb.2006.05.023. [DOI] [PubMed] [Google Scholar]
- 14.Binda C., Coda A., Angelini R., Federico R., Ascenzi P., Mattevi A. A 30 Ålong U-shaped catalytic tunnel in the crystal structure of polyamine oxidase. Structure. 1999;7:265–276. doi: 10.1016/s0969-2126(99)80037-9. [DOI] [PubMed] [Google Scholar]
- 15.Koronakis V., Sharff A., Koronakis E., Luisi B., Hughes C. Crystal structure of the bacterial membrane protein TolC central to multidrug efflux and protein export. Nature. 2000;405:914–919. doi: 10.1038/35016007. [DOI] [PubMed] [Google Scholar]
- 16.Gouaux E., MacKinnon R. Principles of selective ion transport in channels and pumps. Science. 2005;310:1461–1465. doi: 10.1126/science.1113666. [DOI] [PubMed] [Google Scholar]
- 17.Bezanilla F. How membrane proteins sense voltage. Nat. Rev. Mol. Cell Biol. 2005;9:323–332. doi: 10.1038/nrm2376. [DOI] [PubMed] [Google Scholar]
- 18.Yuan P., Leonetti M.D., Pico A.R., Hsiung Y., MacKinnon R. Structure of the human BK channel Ca2 +-activation apparatus at 3.0 Åresolution. Science. 2006;329:182–186. doi: 10.1126/science.1190414. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Petrek M., Otyepka M., Banas P., Kosinova P., Koca J., Damborsky J. CAVER: a new tool to explore routes from protein clefts, pockets and cavities. BMC Bioinform. 2006;7:316. doi: 10.1186/1471-2105-7-316. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.DeLano W.L. Pymol: an open-source molecular graphics tool. CCP4 Newsletter; 2002. [Google Scholar]
- 21.Petrek M., Kosinova P., Koca J., Otyepka M. MOLE: a Voronoi diagram-based explorer of molecular channels, pores, and tunnels. Structure. 2007;15:1357–1363. doi: 10.1016/j.str.2007.10.007. [DOI] [PubMed] [Google Scholar]
- 22.Yaffe E., Fishelovitch D., Wolfson H.J., Halperin D., Nussinov R. MolAxis: a server for identification of channels in macromolecules. Nucleic Acids Res. 2008;36:W210–W215. doi: 10.1093/nar/gkn223. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.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. doi: 10.1371/journal.pcbi.1000440. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Norbert Lindow D.B., Hans-Christian Hege I. Member, Voronoi-based extraction and visualization of molecular paths. IEEE Trans. Vis. Comput. Graph. 2011;17:2025–2034. doi: 10.1109/TVCG.2011.259. [DOI] [PubMed] [Google Scholar]
- 25.Kim D.-S., Cho Y., Kim D. Euclidean Voronoi diagram of 3D balls and its computation via tracing edges. Comput. Aided Des. 2006;37:1412–1424. [Google Scholar]
- 26.Berka K., Hanák O., Sehnal D., Banáš P., Navrátilová V., Jaiswal D., Ionescu C.-M., Vařeková R.S., Koča J., Otyepka M. MOLEonline 2.0: interactive web-based analysis of biomacromolecular channels. Nucleic Acids Res. 2012;40:W222–W227. doi: 10.1093/nar/gks363. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27.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:e1002708. doi: 10.1371/journal.pcbi.1002708. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Vlassi M., Cesareni G., Kokkinidis M. A correlation between the loss of hydrophobic core packing interactions and protein stability. J. Mol. Biol. 1999;285:817–827. doi: 10.1006/jmbi.1998.2342. [DOI] [PubMed] [Google Scholar]
- 29.Hubbard S.J., Gross K.-H., Argos P. Intramolecular cavities in globular proteins. Protein Eng. 1994;7:613–626. doi: 10.1093/protein/7.5.613. [DOI] [PubMed] [Google Scholar]
- 30.Kim D.-S., Ryu J. Side-chain prediction and computational protein design problems. Biodesign. 2014;2:26–38. [Google Scholar]
- 31.Lee K. Principles of CAD/CAM/CAE Systems. Boston: Addison Wesley; 1999. [Google Scholar]
- 32.Gavrilova M., Rokne J. Updating the topology of the dynamic Voronoi diagram for spheres in Euclidean d-dimensional space. Comput. Aided Geometric Des. 2003;20:231–242. [Google Scholar]
- 33.Okabe A., Boots B., Sugihara K., Chiu S.N. Spatial Tessellations: Concepts and Applications of Voronoi Diagrams. 2nd ed. Chichester: John Wiley & Sons; 1999. [Google Scholar]
- 34.Kim D.-S., Kim D., Cho Y., Sugihara K. Quasi-triangulation and interworld data structure in three dimensions. Comput. Aided Des. 2006;38:808–819. [Google Scholar]
- 35.Kim D.-S., Cho Y., Sugihara K. Quasi-worlds and quasi-operators on quasi-triangulations. Comput. Aided Des. 2010;42:874–888. [Google Scholar]
- 36.Kim D.-S., Cho Y., Ryu J., Kim J.-K., Kim D. Anomalies in quasi-triangulations and beta-complexes of spherical atoms in molecules. Comput. Aided Des. 2013;45:35–52. [Google Scholar]
- 37.Kim D.-S., Cho Y., Sugihara K., Ryu J., Kim D. Three-dimensional beta-shapes and beta-complexes via quasi-triangulation. Comput. Aided Des. 2010;42:911–929. [Google Scholar]
- 38.Kim J.-K., Cho Y., Kim D., Kim D.-S. Voronoi diagrams, quasi-triangulations, and beta-complexes for disks in ℝ2: The theory and implementation in BetaConcept. J. Comput. Des. Eng. 2014;1:79–87. [Google Scholar]
- 39.Kim D.-S., Cho Y., Kim J.-K., Sugihara K. Tunnels and voids in molecules via Voronoi diagrams and beta-complexes. Trans. Comput. Sci. XX. 2013;LNCS 8110:92–111. [Google Scholar]
- 40.Kim D.-S., Ryu J., Shin H., Cho Y. Beta-decomposition for the volume and area of the union of three-dimensional balls and their offsets. J. Comput. Chem. 2012;12:1225–1283. doi: 10.1002/jcc.22956. [DOI] [PubMed] [Google Scholar]
- 41.RCSB Protein Data Bank. http://www.rcsb.org/pdb/ (1 April 2014, date last accessed).
- 42.Whittington D.A., Waheed A., Ulmasov B., Shah G.N., Grubb J.H., Sly W.S., Christianson D.W. Crystal structure of the dimeric extracellular domain of human carbonic anhydrase xii, a bitopic membrane protein overexpressed in certain cancer tumor cells. Proc. Natl. Acad. Sci. 2001;98:9545–9550. doi: 10.1073/pnas.161301298. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 43.Teng Y.-B., Jiang Y.-L., He Y.-X., He W.-W., Lian F.-M., Chen Y., Zhou C.-Z. Structural insights into the substrate tunnel of saccharomyces cerevisiae carbonic anhydrase nce103. Biomed Cent. Struct. Biol. 2009;9:1–8. doi: 10.1186/1472-6807-9-67. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.JSmol: an open-source HTML5 viewer for chemical structures in 3D. http://wiki.jmol.org/index.php/JSmol (1 April 2014, date last accessed).
- 45.Kim D.-S., Cho Y., Kim J.-K., Ryu J. QTF: Quasi-triangulation file format. Comput. Aided Des. 2012;44:835–845. [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.