Next Article in Journal
DNA Methylation and Apoptosis Resistance in Cancer Cells
Next Article in Special Issue
An Enhanced ELISPOT Assay for Sensitive Detection of Antigen-Specific T Cell Responses to Borrelia burgdorferi
Previous Article in Journal
The Role of Tricho-Rhino-Phalangeal Syndrome (TRPS) 1 in Apoptosis during Embryonic Development and Tumor Progression
Previous Article in Special Issue
A New Integrated Lab-on-a-Chip System for Fast Dynamic Study of Mammalian Cells under Physiological Conditions in Bioreactor
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Spatial Rule-Based Modeling: A Method and Its Application to the Human Mitotic Kinetochore

1
Bio Systems Analysis Group, Institute of Computer Science, Jena Centre for Bioinformatics and Friedrich Schiller University Jena, Ernst-Abbe-Platz 2, D-0007743 Jena, Germany
2
German Cancer Research Centre, DKFZ-ZMBH Alliance, Im Neuenheimer Feld 280, 69120 Heidelberg, Germany
*
Authors to whom correspondence should be addressed.
These authors contributed equally to this work.
Cells 2013, 2(3), 506-544; https://doi.org/10.3390/cells2030506
Submission received: 29 March 2013 / Revised: 5 June 2013 / Accepted: 25 June 2013 / Published: 2 July 2013
(This article belongs to the Special Issue Feature Papers 2013)

Abstract

: A common problem in the analysis of biological systems is the combinatorial explosion that emerges from the complexity of multi-protein assemblies. Conventional formalisms, like differential equations, Boolean networks and Bayesian networks, are unsuitable for dealing with the combinatorial explosion, because they are designed for a restricted state space with fixed dimensionality. To overcome this problem, the rule-based modeling language, BioNetGen, and the spatial extension, SRSim, have been developed. Here, we describe how to apply rule-based modeling to integrate experimental data from different sources into a single spatial simulation model and how to analyze the output of that model. The starting point for this approach can be a combination of molecular interaction data, reaction network data, proximities, binding and diffusion kinetics and molecular geometries at different levels of detail. We describe the technique and then use it to construct a model of the human mitotic inner and outer kinetochore, including the spindle assembly checkpoint signaling pathway. This allows us to demonstrate the utility of the procedure, show how a novel perspective for understanding such complex systems becomes accessible and elaborate on challenges that arise in the formulation, simulation and analysis of spatial rule-based models.

Graphical Abstract

1. Introduction

Large molecular complexes, like the kinetochore [1] or the spindle pole body (SPB, yeast centrosome) [2], consist of many different proteins and other components. Due to the combinatorics of modification and cluster formation, a detailed reaction network model of the system would need to handle a prohibitively large number of molecular species [3]. The number of molecular species can easily go into the millions and can be virtually infinite. Time and space add further dimensions to the combinatorial complexity [4]. Conventional modeling approaches, such as differential equations, Boolean networks and Bayesian networks, are insufficient to cope with combinatorial explosion, due to their use of a restricted state space with fixed dimensionality [5]. To overcome this problem of combinatorial explosion, several rule-based modeling approaches have been developed [611], which allow one to define a reaction network implicitly [12]. Extending this line of research, we have recently presented SRSim [13], which combines the BioNetGen language (BNGL) for rule-based reaction systems [611] with a three-dimensional coarse-grained simulation building upon the LAMMPSmolecular dynamics (MD) simulator [14]. SRSim fills a gap located in between the fine-grained MD simulation models, which do not allow for the formulation of reaction networks, and 2-D or 3-D graph drawing software tools, which do not include any possibility for dynamic simulation.

Here, we describe (i) the work flow for how to construct a rule-based spatial model using SRSim [13]; (ii) how to integrate experimental data from different sources; and (iii) how to analyze the output of that model. We demonstrate the method by constructing a model of the human mitotic kinetochore, which is a multi-protein structure that assembles on centromeric DNA through complex pathways coordinated by cell-cycle phases [15]. Kinetochores play a central role in mediating chromosome segregation during mitosis [15]. They are of particular interest, because malfunction can cause aneuploidy and cancer [1621]. Understanding the function and the structure of kinetochores is challenging, both experimentally (due to their complex dynamical structure) and theoretically (due to the combinatorial explosion in the number of intermediate complexes).

A kinetochore consists of a large number of different, interacting proteins, each possessing various sites for binding to other proteins or for modification, e.g., by phosphorylation. To overcome the difficulties of modeling such heterogeneous and complex systems, rule-based modeling relies on implicit descriptions for the binding and modification reactions, where “meta” rules are listed instead of writing all possible reactions. Each meta rule usually describes a large or infinite set of possible concrete reactions. Consider, as an example, a simple polymerization, where a monomer, A, can form polymers, AAandAAA,… via reactions, like A + AAA, AA + AAAA, etc. The resulting reaction network possesses an infinite number of molecular species and reactions, thus it cannot be described by conventional frameworks, like the Systems Biology Markup Language (SBML). The same system can be described by the definition of an elementary molecule (monomer; compare Table 1 for more details about the terminology), A(a, a), possessing two binding sites, named “a”, and one “meta” rule of the form A(a)+A(a) → A(a!1).A(a!1), which defines the formation of a bond, named “1”, between binding sites, named “a”. Note that the rule does not care whether the second binding site of an elementary molecule, A, is occupied. To specify those rules, our SRSim uses a formal language compatible with BNGL [6,8], though alternative languages, like kappa [22], would have been equally suitable.

Table 1. Terminology box.
Table 1. Terminology box.
TermSpecification
elementary moleculesBasic building block, consisting of a set of sites. Here, in our example, representing a protein, like Cdc20, or a complex, like anaphase promoting complex (APC) or CenpC
complex moleculeA connected set of elementary molecules
siteRegion of a elementary molecule where specific other elementary molecules can attach.
reactionA transformation of a (possibly connected) set of elementary molecules into a modified (possibly differently connected) set of elementary molecules.
ruleAn implicit definition of a family of reactions, specified by the common features of the involved elementary molecules. For complex molecules, only specific binding sites are explicitly described and others are omitted
parameter setValues defining the simulation and model. Changing a single value will lead to a new parameter set.

A second fundamental challenge is that spatial dynamics are important to the organization of kinetochores, which is a key element in understanding their function, e.g., with respect to the spindle assembly checkpoint [23]. Note that spatial properties, like molecular geometry and location, add further dimensions to the combinatorial complexity. In order to cope with this problem, we have presented a novel spatial and rule-based simulation (SRSim, Gruenert et al. [13]), which extends a rule-based framework by adding information about the molecules' geometry and which allows spatial stochastic simulations, based on the molecular dynamics software, LAMMPS [14]. Note that our approach is different from rule-based spatial simulations using partial differential equations or spatial versions of the Gillespie algorithm. In particular, molecules in our model possess a volume and orientation, which generates additional constraints on the applicability of reaction rules that are not present in the aforementioned spatial simulation methods. For example, a particular definition of molecular size and bond angles will prevent the formation of small ring-like molecules in the polymer example above. Another interesting feature is that transport processes can emerge, which would not appear in a (stochastic) partial differential equation (PDE) [13]. The software and its source code are freely available online [24].

In the next section, we present the process of constructing a spatial rule-based model, describing the information necessary for the construction and how to analyze the simulation output. Then, in Section 3, we demonstrate the application of the method on a model of the human kinetochore.

2. Methods

The model we construct consists of an implicit description of a reaction network and a description of the geometry of the elementary molecules, forming the molecules of the network. Furthermore, it is necessary to specify the dynamics for the simulation (summary Table 2). We suggest the following procedure for building the model and simulation. In the following sections and in Figure 1, we will elaborate on the steps given here.

Table 2. Overview of the required model specifications and typical experiments for obtaining them. FCS, fluorescence correlation spectroscopy; FCCS, fluorescence cross-correlation spectroscopy; FRET, Förster resonance energy transfer; FRAP, fluorescence recovery after photobleaching.
Table 2. Overview of the required model specifications and typical experiments for obtaining them. FCS, fluorescence correlation spectroscopy; FCCS, fluorescence cross-correlation spectroscopy; FRET, Förster resonance energy transfer; FRAP, fluorescence recovery after photobleaching.
Model parameter/specificationTypical experimental procedure
List of elementary moleculesDependent on model assumptions and no specific experimental procedure
List of interaction rulesYeast two-hybrid (Y2H), mammalian two hybrid (M2H), co-immunoprecipitation, tandem affinity purification, FCS, FCCS, FRET (see Section 2.4 for details)
Geometry of elementary moleculesEstimates based on molecular mass (see Section 2.3), or protein structure methods (X-ray crystallography [25,26], NMR spectroscopy [27,28], and Dual polarization interferometry [29])
Diffusion coefficient (D)FCS, FCCS, and FRAP
Dissociation rate koffFRAP, and FCS
Association konBased on koff and the relative concentration
Figure 1. A flowchart depicts the steps and processes necessary for creating a spatial rule-based simulation. First, we prepare three tables with the geometry of the elementary molecules, their interactions and the structure templates (if any). These tables are the input for the file generator that will then translate the geometry information and rules in the SRSim language and will generate several files (namely, .in, .bngl, .geo and .tgeo). The final step is to run the simulation and to store the user defined output, which is the foundation for the analysis. The grey marks correspond to the steps mentioned in Section 2.
Figure 1. A flowchart depicts the steps and processes necessary for creating a spatial rule-based simulation. First, we prepare three tables with the geometry of the elementary molecules, their interactions and the structure templates (if any). These tables are the input for the file generator that will then translate the geometry information and rules in the SRSim language and will generate several files (namely, .in, .bngl, .geo and .tgeo). The final step is to run the simulation and to store the user defined output, which is the foundation for the analysis. The grey marks correspond to the steps mentioned in Section 2.
Cells 02 00506 g001 1024

Step 1:

Construct the reaction network.

Step 1a:

List the basic elementary molecules (e.g., proteins).

Step 1b:

List the interaction rules (e.g., complex formation).

Step 2:

Specify the geometry of elementary molecules. This may include predefined structural templates for elementary molecules with non-spherical shapes.

Step 3:

Obtain dynamical parameters (e.g., for binding).

Step 4:

Specify simulation parameters (e.g., volume and simulated time).

Step 5:

Specify simulation output modes for a later analysis and visualization.

Step 6:

Perform simulation and analyze simulation output.

2.1. How to List the Basic Elementary Molecule (Step 1a)

As a first step, the basic reacting particles, called elementary molecules, should be defined. In our example, we define for each involved protein one elementary molecule. In general, elementary molecules can also represent arbitrary types of components, like atoms, small molecules, protein complexes or DNA. In Figure 2, two different elementary molecules, A and B, are shown. The circle symbols, a, b and c, denote sites. A modification of site b is introduced to the displayed molecules. All sites are unaffected on the left, while b has been modified unspecifically on the right.

An example of complete BNGL source files can be found in Supplementary Materials 5.

For each elementary molecule, we also have to define a set of sites that can later be bound to other elementary molecules or can be modified, e.g., phosphorylated. Furthermore, as shown in Section 2.3, each binding site can be arranged in particular angles to define the interaction geometry. Binding sites of a elementary molecule can be given the same name, so that reaction rules do not distinguish between them. This might simplify the set of necessary reaction rules, but sacrifice specificity. If we have no further informationabout structure, we suggest the following two alternatives: Case 1: We define the elementary molecules, {C, D, E}, that should bind to A; according to our data, one specific binding site in A (Figure 3, left). In this case, each of the molecules, {C, D, E}, can bind only once to A and all {C, D, E} can bind simultaneously. Case 2: We define n generic binding sites having the same name (Figure 3, right). In this case, different combinations of up to n molecules from the set {C, D, E} can bind to A. This approach does not allow one to define specific binding angles for a particular binding partner, D, in Step 2, because different binding partners, and thus, their angles, cannot be distinguished any more.

Figure 2. Examples of typical elementary molecules. On the left side, two different elementary molecules, A and B, are displayed with three sites, a, b and c, which are represented by the circles. The attached squares on the right symbolize a modification of the site, b. In this example, no further information about the kind of modification is given.
Figure 2. Examples of typical elementary molecules. On the left side, two different elementary molecules, A and B, are displayed with three sites, a, b and c, which are represented by the circles. The attached squares on the right symbolize a modification of the site, b. In this example, no further information about the kind of modification is given.
Cells 02 00506 g002 1024
Figure 3. Illustration of binding site specifications with generic or with specific binding sites. On the left, molecule A has three specific sites, c, d and e. The elementary molecules, C, D and E, are connected to molecule A by using the appropriate binding site of the lower case name only—site a is suitable for molecule A only Those specific binding sites do not allow the link between A and C twice, due to the fact that only one site c exists. Molecule B, on the right, in contrast, has three times the same site, x. Here, the underlying rules would allow any molecule from {C, D, E} to bind to any binding site, x, reducing the number of necessary rules to describe the system. As a result, it would not be guaranteed that the molecules binding to B are distinct, as exemplified by two molecules, C, and one molecule, D, binding to B.
Figure 3. Illustration of binding site specifications with generic or with specific binding sites. On the left, molecule A has three specific sites, c, d and e. The elementary molecules, C, D and E, are connected to molecule A by using the appropriate binding site of the lower case name only—site a is suitable for molecule A only Those specific binding sites do not allow the link between A and C twice, due to the fact that only one site c exists. Molecule B, on the right, in contrast, has three times the same site, x. Here, the underlying rules would allow any molecule from {C, D, E} to bind to any binding site, x, reducing the number of necessary rules to describe the system. As a result, it would not be guaranteed that the molecules binding to B are distinct, as exemplified by two molecules, C, and one molecule, D, binding to B.
Cells 02 00506 g003 1024

2.2. How to List the Interaction Rules (Step 1b)

Experiments that deliver information on binding and proximities can be mapped to reaction rules that bind two elementary molecules together. In this step, the information on how these elements interact needs to be specified: Using the elementary molecules, the reaction system can be described via an implicit reaction rule, as displayed in Figure 4. Here, an example is shown, which represents the interaction of the elementary molecules, A and B, from Figure 2. The greyed out sites of the molecules, A and B, do not have to be specified. Omitting them means that they can be in either a bound or an unbound state or modified in any way. The solid sites, a and c, in contrast, have to be in the specified state on the left-hand side of the reaction rule, that is, they have to be unbound before the reaction can happen.

To illustrate the concept of an implicitly defined reaction system, different instances of the polymerization rule (Figure 4) are displayed in Figure 5.

In this example, the modification at site b is of no importance for the polymerization dynamics. Furthermore, the reaction rule does not distinguish between molecules that are already bound to some other structure and between molecules that would assemble freely from two unbound monomers.

Note that a bond in the model does not necessarily need to represent an actual chemical bond. Assume that we have only proximity data (e.g., Förster resonance energy transfer (FRET) data), which indicates that two molecules are close to each other. It could make sense to define a binding reaction for these two molecules. In this case, the bond in the model should be interpreted as an unknown mechanism bringing these two molecules into close proximity.

Figure 4. Examples of implicit reaction rules. Illustrative presentation of different rules between two molecules. Both displayed rules describe an interaction between the elementary molecules, A and B. The difference is in the participating sites. This example could lead to a double connection between A and B if there were no steric restraints. Another possibility is the formation of polymers of indefinite length. Please note that the binding sites in grey are not part of the rule, i.e., the bond and modification state of the grey sites is not considered for the rule to be applicable. All that is required for the upper rule to fire is that a molecule, A, has a free binding site, c, and that a molecule, B, has a free binding site, a. Then, these free binding sites are bound together. Via the grey binding sites, large molecule graphs could be connected, which would not interfere with the reaction.
Figure 4. Examples of implicit reaction rules. Illustrative presentation of different rules between two molecules. Both displayed rules describe an interaction between the elementary molecules, A and B. The difference is in the participating sites. This example could lead to a double connection between A and B if there were no steric restraints. Another possibility is the formation of polymers of indefinite length. Please note that the binding sites in grey are not part of the rule, i.e., the bond and modification state of the grey sites is not considered for the rule to be applicable. All that is required for the upper rule to fire is that a molecule, A, has a free binding site, c, and that a molecule, B, has a free binding site, a. Then, these free binding sites are bound together. Via the grey binding sites, large molecule graphs could be connected, which would not interfere with the reaction.
Cells 02 00506 g004 1024
Figure 5. Instances of the reaction rule. Explicit instances of the implicit reaction rule defined in Figure 4 (upper rule), whereby, * refers to the application of the implicit rules. As described for Figure 4, the sites that were not mentioned (grey) by the rule can be modified or bound to other molecules.
Figure 5. Instances of the reaction rule. Explicit instances of the implicit reaction rule defined in Figure 4 (upper rule), whereby, * refers to the application of the implicit rules. As described for Figure 4, the sites that were not mentioned (grey) by the rule can be modified or bound to other molecules.
Cells 02 00506 g005 1024

How to Specify Context-Dependent Binding Rules

It is possible to specify context for the reaction rules to customize the binding dynamics. For example, the system under consideration could exclude the assembly of new structures in the absence of a nucleation structure (like the γ-tubulin in the case of microtubule formation [3032]). Such a behavior can easily be incorporated into the rule-based model by a slight modification of the polymerization rule.

For example, we can add a dependency on a modification of site b that will denote, if the molecule is already in some way connected to the nucleation structure. Furthermore, we will add one more rule that will propagate the modification of site b to adjacent molecules, as shown in Figure 6.

Figure 6. Context-dependent reaction rules that exclude the assembly in the absence of a nucleation structure. That is, polymerization will only happen when a protein modification at site b is already present. When a non-modified protein is bound to a modified one, the modification is passed on by the second rule. These new rules would have to replace the reaction rules defined in Figure 4 to avoid the context-free assembly reaction to happen, as well.
Figure 6. Context-dependent reaction rules that exclude the assembly in the absence of a nucleation structure. That is, polymerization will only happen when a protein modification at site b is already present. When a non-modified protein is bound to a modified one, the modification is passed on by the second rule. These new rules would have to replace the reaction rules defined in Figure 4 to avoid the context-free assembly reaction to happen, as well.
Cells 02 00506 g006 1024

2.3. How to Specify the Geometry of the Elementary Molecule (Step 2)

For the spatial rule-based simulation, the geometries of the participating particles need to be defined in addition to the diffusion coefficient (cf. Section 2.4). In the simplest case, a spheric shape is assumed for every molecule in the reactor. Nonetheless, for any particle, a more complex shape can be assembled from a collection of spheric elementary molecules, as shown in the next section.

To model the spheric building blocks, the following values are required: the elementary molecule's mass, m, its diameter, d, and the geometry of its sites. When the size is unknown, the mass of the molecules can be used for a coarse approximation of its volume, V, and, thus, of its diameter, d, by assuming the same density, ρ, for all particles:

ρ = m / V
d = 2 4 m 3 ρ π 3

For the interaction with reaction partners, the geometry of all the elementary molecule's sites is then specified in polar coordinates, i.e., by the two angles, φ and θ, and the length of the binding site (compare Figure 7). This length is typically the radius of the elementary molecule, which means reactions occur on its surface. Next to the binding angle, there is also the possibility to define dihedral angles. While this information can be specified if (partially) present, in many cases, no data on the structure or on binding angles will be present, so that the whole surface of the spheric particles will have to be considered equally reactive.

Figure 7. Specification of binding sites. Exemplary specification of a binding site with the angles, φ and θ, and the length of the bond, r. These variables correspond to spheric coordinates. Coarsely comparable to geographic coordinates, (90° − φ) would correspond to the latitude, θ to the longitude and r would be the distance between the location and the Earth's center. While φ gives the angle between the binding site and the vertical zenith axis, θ gives the rotation around this zenith axis.
Figure 7. Specification of binding sites. Exemplary specification of a binding site with the angles, φ and θ, and the length of the bond, r. These variables correspond to spheric coordinates. Coarsely comparable to geographic coordinates, (90° − φ) would correspond to the latitude, θ to the longitude and r would be the distance between the location and the Earth's center. While φ gives the angle between the binding site and the vertical zenith axis, θ gives the rotation around this zenith axis.
Cells 02 00506 g007 1024

How to Predefine Structural Templates

If there exists detailed information about the shape and structure of a molecule or complex, a structural template can be defined. It can consist of multiple sphere shaped elementary molecules, assembled in a particular shape. Now, initial coordinates for each of the elementary molecules can be specified. The relative coordinates can be fixed, so that the whole template behaves as a rigid particle or, at least, starts from a defined spatial configuration. For example, to approximate a cube shaped complex molecule, the position of the eight edges in space could be specified for eight equidistant connected elementary molecules with fixed angles of 90 degree, as displayed in Figure 8. The edges of the cube refer to the sites, while the illustrated angle is defined between three elementary molecules, so the whole template becomes rigid if all those angles are fixed.

Figure 8. Structural template. Example of a structural template, showing a cube shaped assembly composed of eight elementary molecules. As a rigid body, this structure will keep its shape during the whole length of the simulation.
Figure 8. Structural template. Example of a structural template, showing a cube shaped assembly composed of eight elementary molecules. As a rigid body, this structure will keep its shape during the whole length of the simulation.
Cells 02 00506 g008 1024

2.4. How to Obtain Dynamical Parameters from Experiment (Step 3)

While the reaction system described so far can be analyzed algebraically [33], a dynamic simulation requires the following kinds of parameters: First order reaction rate constants for dissociation and modification reactions, as well as second order rate constants for binding and modification reactions. Furthermore, for spatial simulations with explicit diffusion of particles, diffusion rates should be known. We now present typical measurement techniques for determining these values.

For obtaining diffusion, association and dissociation rates and relative concentrations, many methods exist. Most of these are based on fluorescence microscopy, which provides an efficient tool to study molecular processes in either fixed and living cells [34]. Both fluorescence correlation spectroscopy (FCS) and two-color fluorescence cross-correlation spectroscopy (FCCS) measurements provide information about diffusion, protein-protein interactions and average concentrations. These measurements can be conducted either in vitro or in vivo [35] (for a review, see [36,37]). More elaborate techniques, including fluorescence recovery after photobleaching (FRAP), Förster resonance energy transfer (FRET), fluorescence localization after photobleaching (FLAP) and fluorescence lifetime imaging microscopy (FLIM), exist. These techniques provide either protein diffusion and/or binding characteristic between proteins (herein, only the dissociation rate, koff, can be obtained). For a review, we refer to [38]. In addition to those biophysical techniques, there are biochemical methods that are more specific for interactions among proteins, like yeast two-hybrid [39], mammalian two hybrid (M2H) [40], co-immunoprecipitation [4143] and tandem affinity purification [44]. In addition to those experimental techniques listed above, other in-silico interaction prediction methods are available, such as docking [45] or co-evolution [46]. Furthermore, interaction databases, like the STRING database [47,48], are available.

Each of these techniques has their own advantages and disadvantages. In order to make meaningful and accurate quantification out of experimental data, the right models and methods should be carefully chosen. A very basic example is that, while using FRAP, you can calculate the off rate, koff. The naive approach of fitting the data to single or double exponential functions does not reflect the physical reality. That is because fitting data to a first order reaction, while the correct reaction is of the second order, leads to unit inconsistencies (the forward reaction rate for the first order is sec–1 and for the second order reaction is sec–1Mol–1). This is particularly important, since koff is essential to further calculate your kon, if relative concentrations of the related proteins are known. Thus, for a complex or unknown mechanism, a detailed mathematical model is required (we refer, for example, to the successful FRAP model applied to PMLnuclear bodies [49]).

Moreover, it is important to carefully interpret the means of signaling output for these techniques. For example, the FRET signal observable range of distances is limited [5052]. The donor and acceptor fluorophores should be in close proximity to each other (around 10 nm or 14 nm), otherwise, no FRET signal can be detected [53]. Nonetheless, a weak or missing FRET signal does not imply large distances.

2.5. How to Specify the Simulation Parameters (Step 4)

For a spatial particle simulation, in addition to the description of the reaction dynamics, further parameters for the reaction vessel, as well as a simulation protocol can be specified; in particular, the size and shape of the reactor, its boundary conditions, the initial state of the reactor and the length of the time-steps (Table 3).

A thermostat for the Brownian motion of particles and other forces that constrain the behavior of all particles or of subsets can dynamically be adjusted. Doing this in a fixed time regime leads to the definition of a simulation protocol, e.g., first equilibrate the simulation system for 105 time-steps, then add additional molecules of type X, then equilibrate for another 105 time-steps, then add a force from an electric field on some of the particles and, finally, simulate for 106 time-steps. For more details on the possible configuration and simulation protocol options, we refer to [13,54].

Table 3. Main simulation parameters.
Table 3. Main simulation parameters.
NameExample values in Section 3Meaning
Reactor volume800Å × 400Å × 600ÅSize of the reaction space
Reactor ShapeCubicShape of the reaction space
Boundary conditionsReflectiveBoundary conditions can be reflective, harmonic or gran, for example
Initial statesRandom or fixedThe initial state can be specified by exactly specifying components and their initial positions. Alternatively, the positions are generated randomly.
Simulation time8 × 106 time-stepDuration of the simulation
ForceLeonard-JonesThe conservative force between particles additional to the friction. Other possibilities are EAM, hybrid LJor no interaction.

2.6. How to Specify Simulation Output for a Later Analysis and Visualization (Step 5)

During and after the simulation, it is possible to write various information to files. Typically, snapshots of the position of each particle are written regularly, for later structural analysis and visualization, as well as for tracking and analyzing the simulation process. These datasets can become quite big, so that there is a trade-off for the experimenter between saving disk space and the temporal resolution of the simulation trajectories. For a first impression of the reactor contents, we used the Visual Molecular Dynamics software (VMD) [55]. It produces plots of the particles in the reactor along the dumped simulation snapshots, leading to visualizations, as shown in Figure 9.

Further useful information is in which bonds are formed or broken during the simulation process at which time. Especially if not focusing on the 3D structure, but on the bond-network, the graphviz package produces a visualization of this network of actually realized interactions. Next to the already implemented general methods to this aim, there are simulator modules for the output that can be modified for special needs. For example, in the case of the kinetochore, more specialized information can be extracted by automatically determining if a path along connected molecules exists from one nucleosome to another.

Figure 9. Single rosette-like structure assembly in mitosis. (A) Shows a rosette-like structure where SACis active and no microtubule is present or attached; (B) Same as in Panel A, showing the rosette-shape in top view; (C) Shows a rosette-like structure attached to a microtubule and including the Ska complex, where the Spindle Assembly Checkpoint (SAC) switched off; (D) Same as Panel A, showing the rosette-shape in top view similar to Panel B, while SAC is inactive. The distance between two nucleosomes is 14 nm, and consequently, the diameter of the rosette-shape and microtubule is 25 nm. The rosette-structure and the Ska-complex are 60 nm apart. The attached, as well as the unattached kinetochore took about one hour to simulate.
Figure 9. Single rosette-like structure assembly in mitosis. (A) Shows a rosette-like structure where SACis active and no microtubule is present or attached; (B) Same as in Panel A, showing the rosette-shape in top view; (C) Shows a rosette-like structure attached to a microtubule and including the Ska complex, where the Spindle Assembly Checkpoint (SAC) switched off; (D) Same as Panel A, showing the rosette-shape in top view similar to Panel B, while SAC is inactive. The distance between two nucleosomes is 14 nm, and consequently, the diameter of the rosette-shape and microtubule is 25 nm. The rosette-structure and the Ska-complex are 60 nm apart. The attached, as well as the unattached kinetochore took about one hour to simulate.
Cells 02 00506 g009 1024

2.7. How to Analyze Simulation Output (Step 6)

The raw result of each simulation is the position of each elementary molecule in space, varied over time. The particles' trajectories in the simulator are influenced by the chaotic interactions between the elementary molecules, their stochastic reactions, as well as by the random forces implementing Brownian motion. Additionally, every elementary molecule starts the simulation at a random position in the reactor, influencing the position of the molecules at any later time-step. Hence, each simulation instance, even from a single model, will produce different trajectories. They might differ in small details only or even vary in macroscopic or structural properties of the assembled complexes. Nonetheless, some final reactor states will be more probable than others, e.g., the formation of a correctly assembled kinetochore complex. Therefore, we are interested in the spatial probability distribution of all the constituting particles, and therefore, sample the space of all possible final configurations by running multiple simulations with varying random seeds.

However, also for different parameter sets, several simulations are run to discover all possible structures. To compare a hypothesis against a null hypothesis, two or more parameter sets are simulated. This amounts to a lot of simulation data, which is computationally and analytically challenging (see the analysis of the inner kinetochore structure [56]). The model presented in Section 3 generated 230 GB of trajectory data and took 3 days to analyze on a compute cluster with 20 state-of-the-art CPU cores.

A number of methods are available to analyze the raw data (Table 4). Typically, a collection of them has to be used to draw up meaningful conclusions. A key question to answer is if two conformations of a cloud of elementary molecules in space represent the same structure or not. In addition, one wants to know how dissimilar two structures are. Beyond structure analysis, one can ask, for example, which elementary molecules form bonds during simulation or consider the time it took for structure formation and dissolution.

Table 4. Analysis methods and required simulation outputs.
Table 4. Analysis methods and required simulation outputs.
AnalysisSimulation requirements
Measure similarities between two structures: RMSD, Paired RMSD and Local RMSDPosition of each elementary molecule for two simulations
A dendrogram for discovering structural diversity within one parameter setParticle position for multiple simulations of one parameter set
A dendrogram for discovering structural diversity between two parameter setsParticle position for multiple simulations of multiple parameter sets
Discover irrelevant reactionsFrequency of realized bounds averaged over several simulations

All these analysis methods can be extended to the dimension of time.

Here, we present—with modifications—our protocol of the structural analysis method used previously [56]. To measure structural similarity, it relies on the root mean square deviation (RMSD) between a chosen set of elementary molecules—typically all. Three different RMSDs can be generated: difference of positions, of distances and of local distances. In the rest of the section, pi and qi, denote the position of elementary molecule i in two different simulation runs that are to be compared, and ‖x‖ denotes the Euclidean norm of x.

In very simple cases, one can consider the RMSD of the positions of the n elementary molecules [57]:

RMSD p q = 1 n i = 1 n p i q i 2

As molecules can freely rotate and translate in the simulated space, the elementary molecule coordinates require transformation before this method is applied: Translational degrees of freedom (DoF) are eliminated by assuming that one elementary molecule is fixed in space (e.g., p0 = q0 = 0⃗. Rotational DoF are eliminated by aligning the straight line between two elementary molecule pairs (e.g., p 0 p i ¯ q 0 q i ¯ for i = 1,2). This scheme can only be used to discriminate small, rigid structures: negligible changes to the macrostructure usually have a larger RMSD than significant changes to a few elementary molecules, because the measure relies entirely on the absolute elementary molecule position.

To overcome this limitation, we need to incorporate relative position information. We thus consider the RMSD of the pairwise distance between elementary molecules [56]:

paired RMSD p q = 2 n 2 + n i = 1 n j = 1 i ( p i p j q i q j ) 2

It increases if and only if the distance between any particles in structure p is different from that in structure q. Thus, rotational and translational DoF are irrelevant in paired RMSD. The method is robust against some macrostructural variance (e.g., small rotation of a backbone). We apply paired RMSD for the analysis in Section 3.

If one requires to compare structures with high variability in their macrostructure—for example, long polymers, where the exact shape of the backbone does not matter—one can restrict the paired RMSD to consider only the distances of proximate particles. This can be achieved by a cut-off distance, C:

local RMSD p q = 2 n 2 + n i = 1 n j = 1 i ( min ( C , p i p j ) min ( C , q i q j ) ) 2

A low local RMSD implies that the local structure—bonds and component orientation—is relatively unchanged, whereas the macrostructure might have any shape. The notion of what is considered proximate and what is considered insignificant macrostructure is determined by setting the cut-off distance, C, to an appropriate value. Because cut-off distance induced spheres around each particle strongly overlap, local RMSD can be used to detect whether substructures are connected. This does not work in general for RMSD or paired RMSD.

Each of the three RMSD measures allows one to compute a distance between two structures, p and q. However, typically, one has to compare n ≫ 2 different structures, p1,…, pn. Computing the distance for each pair (pi,pj) of structures yields a n × n-matrix of distances. A standard approach to visualize such a distance matrix is a dendrogram [58]. In this tree, each leaf represents one structure from one simulation, and the distance from each inner node to the root is proportional to the negated maximal distance between all structures that are child nodes of this inner node. At a glance, one is able to spot families and similarities between (groups of) structures: the closer to the root the lowest common node between two structures is, the more different they are. Reciprocally, if there are qualitatively different structures in the dataset, the junctions closest to the root distinguish between them. See Figure 10 for an example.

Figure 10. A dendrogram visualizing the distances between 200 structures. Comparison of the structures resulting from 200 simulations by displaying the pairwise root mean square deviation (paired RMSD) using a dendrogram. The leaves are marked with the simulation index. An inner node close to the root denotes high dissimilarity between the branches of the node. The presented tree reveals only inner nodes very close to the root. This leads to the conjecture that all structures are microscopically different, but macroscopically similar. Considering structure 179 as an outlier, this implies that the given model produces exactly one structure.
Figure 10. A dendrogram visualizing the distances between 200 structures. Comparison of the structures resulting from 200 simulations by displaying the pairwise root mean square deviation (paired RMSD) using a dendrogram. The leaves are marked with the simulation index. An inner node close to the root denotes high dissimilarity between the branches of the node. The presented tree reveals only inner nodes very close to the root. This leads to the conjecture that all structures are microscopically different, but macroscopically similar. Considering structure 179 as an outlier, this implies that the given model produces exactly one structure.
Cells 02 00506 g010 1024

One can use analysis methods that do not rely on the particle positions of each simulation run. One such example is the probability of bond realization averaged over several simulation runs. This can be used to discover if a reactions is superfluous, which, in turn, allows one to derive the smallest set of reactions that explains the formation of a certain structure (model reduction). It can also be used to validate models if an experimentally confirmed bond does not occur in a simulation.

All proposed analysis methods can be extended in the dimension of time. Considering the bond frequency over time allows for several conclusions. A transiently elevated bond frequency hints at a reaction that might be required for structure formation, but not maintenance. A delayed onset of the bond frequency of a mutant compared to a wild-type indicates reactions that are not strictly necessary for a complex to form, but that increase the formation speed. This difference in timing can be critical—for example, during mitosis [59].

3. Biological Application: Rule-Based Spatial Model of the Human Mitotic Kinetochore (HMK)

Due to the combinatorial explosion of the number of intermediate complexes, studying the 3D structure of the full kinetochore is challenging, both experimentally and theoretically Conventional modeling approaches, like differential equations, fail to describe the self-assembly process. Recently, a first 3D rule-based model of the inner kinetochore has been proposed based on intracellular proximity between inner kinetochore proteins [56], which suites to cope with combinatorial complexity However, they modeled the S-phase inner kinetochore and used the same geometry for all proteins.

Here, we used a similar approach to study a full mitotic kinetochore model (HMK), including inner and outer kinetochore and the spindle assembly checkpoint modules. We used structural template geometry for CenpC,-T,-Q, Mis 12-, Ndc80-, Mad1:Mad2-, RZZ-, APC- and Ska-complexes and microtubules (Tables 5 and 6). “Rosette”-like nucleosomal shape was suggested for the kinetochore structure in mitosis [15]. We test if this specific structure can be assembled and under which possible conditions. We study several model variants for either attached or unattached kinetochore and with single or multiple microtubules.

Table 5. Molecular geometry information. We derived the radius of simulation particles from the assumption that molecules are spheric and all have the same density.
Table 5. Molecular geometry information. We derived the radius of simulation particles from the assumption that molecules are spheric and all have the same density.
ProteinMolecular mass in [kDa]Radius in [Å]ProteinMolecular mass in [kDa]Radius in [Å]
CenpA16.0015.33Apc1216.5036.53
CenpB65.0024.46Apc294.0027.66
CenpC107.0028.88Apc392.0027.46
CenpI87.0026.95Apc492.0027.46
CenpK31.5019.21Apc585.0026.75
CenpM20.0016.51Apc671.5025.25
CenpN39.5020.71Apc767.0024.71
CenpO34.0019.00Apc869.0024.95
CenpP33.0019.51Apc1021.0016.78
CenpQ30.5019.01Apc1110.0013.11
CenpR20.0016.51Apc1210.0013.11
CenpS16.0015.33Apc138.5012.41
CenpT60.5023.88Cdc2055.0023.13
CenpU47.5022.03Mad183.0026.53
CenpW10.0013.10Mad223.5017.42
CenpX9.0012.65Bub1122.0030.17
H315.0015.00BubR1120.0030.00
Dsn140.0020.8Bub337.0020.27
Mis1224.0017.55Mps197.0027.95
Nnf123.5017.42Zwint31.0019.11
Nsl132.0019.31Zwilch67.0024.71
Hec174.0025.54Zw1089.0027.16
Nuf254.0022.99Rod1250.0038.32
Spc2422.5017.17
Spc2526.0018.02
Knl1265.0039.07
Table 6. The inner and outer kinetochore and SAC proteins.
Table 6. The inner and outer kinetochore and SAC proteins.
ProteinInteraction partner(s)
CenpACenpB [60], -N [61,62], -C [63,64]
CenpBCenpW [56], -Q [65] -U [66], -C [67]
CenpC
CenpICenpU [66]
CenpKCenpO [65], -R [65], -U [65], -N [65]
CenpMCenpS [56], -U [56], -T [66], H3 [56]
CenpN
CenpOCenpP [65], -U [65], -Q [65]
CenpPCenpU [65], -Q [65]
CenpQCenpU [65]
CenpRCenpU [65]
CenpSH3 [56], -T[68], -X[69]
CenpTH3 [56,70]
CenpU
CenpWH3 [56,68]
CenpX
H3
Dsn1Mis12 [71], Nsl1 [71]
Nnf1Mis12 [72], CenpC [64]
Nsl1Spc24 [72,73], Spc25 [72,73]
Mis12
Ndc80/Hec1Nuf2 [74,75]
Nuf2Spc25 [74,75]
Spc24Spc25 [75,76], CenpT [77,78]
Spc25
Knl1
Cdc20Mad2 [7981], BubR1 [8285], Apc2 [86,87]
Mad2Mad1 [8890], Rod1 [91,92], Zw10 [91,92]
Mad1Bub1 [93], Rod1 [91,92], Zw10 [91,92]
Bub3Bub1 [94,95], BubR1 [9597]
BubR1Bub1 [94,98], Knl1 [99102], Apc3 [103], Apc4 [104,105], Apc5 [106], Mps1 [107], Rod1 [108], Zw10 [108]
Bub1Knl1 [100,101]
Mps1Mis12 [109], Hec1 [71,110]
ZwintZw10 [111,112],Knl1 [101], Mis12 [71,113]
ZwilchRod1 [114,115], Zw10 [108,111,115]
Zw10Rod1 [108,115,116], Knl1 [101]
Rod1

3.1. Human Mitotic Kinetochore

Human kinetochores contains over 100 proteins and complexes and can be classified into two functional parts: the inner kinetochore that binds centromeric DNA and the outer kinetochore that binds microtubules. The inner kinetochore is composed of a centromeric CenpA and 16 CCAN (constitutive centromere-associated network) proteins (CenpC, CenpH, CenpI, CenpK to CenpU, CenpW, CenpX) [117]. The inner kinetochore is relatively stable and present during most of the cell cycle [1,118,119], while the outer kinetochore is less stable and forms in mitosis [120,121].

The outer kinetochore proteins and complexes include the KNL-complex (Spcl05/Knl1), Mis12-complex (Dsn1, Nnf1, Nsl1 and Mis12) and the Ndc80-complex (Ndc80/Hec1, Nuf2, Spc24 and Spc25), which are referred to as the KMNnetwork (for a review, we refer to [1]). Additionally, the Ska-complex (Ska1, Ska2 and Ska3/Rama1) is essential for the attachment of the chromosome to the spindle microtubules [122].

Kinetochores are a part of and regulate two crucial mechanisms during mitosis. First, they work as a platform, generating a signal for the Spindle Assembly Checkpoint (SAC, [123]) which mediates the correct attachment between the chromosome and spindle microtubules. Second, they ensure proper tension and orientation of attached chromosomes. Here, we shall focus on both the inner and outer kinetochore together with the SAC pathway.

SAC delays the onset of anaphase, until all chromosomes have made amphitelic tight bipolar attachments to the mitotic spindle. Even one misaligned kinetochore catalyzes the formation of a “wait-anaphase” signal, which then diffuses to counter the ubiquitin ligase anaphase promoting complex (APC) by its co-activator, Cdc20. Activation of APC by Cdc20 triggers chromosome segregation by ubiquitination of securin and cyclin B [124127]. The core proteins involved in SAC are conserved in all eukaryotes, include MAD (“Mitotic Arrest Deficient”; Mad1, Mad2 and Mad3 (in humans: BubR1)) [128] and BUB (“Budding Uninhibited Benzimidazole”; Bub1 and Bub3) [129]. These proteins work to regulate APC and Cdc20. In addition to these core proteins, the SAC involves several other components. Among these are the Aurora-B [130], the RZZ complex (ROD, Zw10 and Zwilch; for a review, see [131]) and Zwint-1 [112]. The biochemical reactions of SAC activation and maintenance can be thought of in a very simple way as two modules. First is the Mad2-activation and its function in sequestering Cdc20, which is known as the “Template model”. Second is the formation of the MCC complex (which consists of Mad2, Cdc20, Bub3 and BubR1 [126]), which directly binds and inhibits the APC complex (for a review, see [132]). Several conventional detailed models are available in the literature for SAC modules (e.g., [23,59,133138]). However, none of these models considered molecular geometry and structure. We have recently developed a spatial rule-based model for the S-phase inner kinetochore structure [56]. Here, we present, to the best of our knowledge, the first simplified spatial model of the human mitotic inner and outer kinetochore that also includes the spindle assembly pathway.

3.2. The HMK Model

We develop a 3D model of the human mitotic kinetochore (inner and outer) in addition to the spindle assembly checkpoint pathway. This model is based on published data from the literature (interaction, proximity and geometry data). Using a rule-based modeling technique in space, we explore a possible structural kinetochore layout assemble. We apply different model variants, namely, unattached kinetochore, attached kinetochore, single microtubule and multiple microtubules.

3.2.1. Model and Simulation Assumptions

We specify the size of the spheres (or chain of spheres), since proteins have a rather similar amino acid density [139,140]. We adjust the spherical volume of each CCAN protein, due to its molecular mass relative to the density of histone H3 (Table 5). Our coarse-grained simulator allows us to model detailed molecule structures. Therefore, we consider the most known structures as a chain with similar or different parts (e.g., [68,78,141,142]) and all other proteins' structures as spheres, namely, CenpC,-T,-Q, Mis12-, Madl:Mad2-, Ndc80-, RZZ-, APC- and Ska-complexes and microtubules (Tables 5 and 6). The binding domains (listed in Table 6 and shown in Figure 11) are translated into reaction rules (as mentioned in Section 2.2). Because we are not interested in a transient behavior, we start with randomly chosen positions and simulate the system 6 × 106 time-steps and take only the final state for our analysis. After this time, only small changes could be observed. In our model, we simulated the time it needed to form a rough structure twice (the actual structure, but not all elementary molecules are bound), which took an average 3 × 106 time-steps).

For unattached kinetochore model variants, we used 25 different molecular species and 10 templates (CenpC,-T,-Q, Mis12-, Ndc80-, Mad1:Mad2-, RZZ- and APC-complexes), as in Table 5 and 6. For the attached kinetochore model variant, we also include two templates for the Ska-complex and microtubule(s), which remove SAC proteins from the kinetochore. They are distributed randomly in the reactor volume: (x = (−400Å; 400Å), y = (−400Å; 800Å), z = (−400Å; 400Å)). At each time-step, all molecules are addressed to move freely according to Brownian motion (we dump the relative position of each particle every 5 × 103 time-step). The two nucleosomes containing either H3 [143] or CenpA [144] are rigid molecules and have fixed positions. Each of the nucleosomes is represented by eight simulation particles that are bound to each other rigidly. If two elementary molecules, listed in the reaction table, come close together (depending on the length of their binding site), they bind regarding the defined rule under the conditions of Section 2.2. Initially, only the seven nucleosomes are able to bind anything.

Switching the SAC signaling on and off is controlled by the switching binary parameters (remove some reactions). For instance, in the “Template model”, the formation of Mad1:C-Mad2:O-Mad2* can take place only as long as the kinetochore is unattached [135].

Figure 11. Map of all interactions used for the Human Mitotic Kinetochore (HMK) model (see also Table 6). The nodes in this graph represent a protein or complex, while the edges depict interactions between them. The colors and names of the vertices are the same as in Figures 9 and 12. Square shapes are the two nucleosomes, which are the anchor points for our model calculations. The CenpA nucleosome contains CenpA1, CenpA2, H41, H42, H2A1, H2A2, H2B1 and H2B2. The H3 nucleosome contains H31, H32, H43, H44, H2A3, H2A4, H2B3 and H2B4.
Figure 11. Map of all interactions used for the Human Mitotic Kinetochore (HMK) model (see also Table 6). The nodes in this graph represent a protein or complex, while the edges depict interactions between them. The colors and names of the vertices are the same as in Figures 9 and 12. Square shapes are the two nucleosomes, which are the anchor points for our model calculations. The CenpA nucleosome contains CenpA1, CenpA2, H41, H42, H2A1, H2A2, H2B1 and H2B2. The H3 nucleosome contains H31, H32, H43, H44, H2A3, H2A4, H2B3 and H2B4.
Cells 02 00506 g011 1024

3.2.2. Simulation Outcome

We first consider a simple kinetochore, which is not yet attached. In other words, we modeled the inner and the outer kinetochore along with the SAC signaling (checkpoint is active) and no microtubules present. We aim to test if there is a possible way and under which setting a rosette-like structure can be assembled.

In our setting, for the realization of a complete hexagonal rosette-shaped structure, we set the number of every elementary molecule and chain-molecule to six, except CenpN and CenpA, which are largely absent from kinetochores during mitosis [61]. We define the reactor size and locate the CenpA containing nucleosome in the middle on a fixed position. The other six H3 containing nucleosomes are placed evenly around the CenpA with a fixed distance of 14 nm. As the exact nucleosomes orientation is unknown, but the position must keep fixed, a rotation around the center of each nucleosome was added, so that it is free to align during the assembly process. All molecules and structural templates (CenpT, -C, -Q, APC complex and MCC complex) undergo Brownian motion in a centering drag-fix (every time-step, a force is added, which causes every particle to be slightly dragged into a sphere around the center of the reactor), which ensured the availability of molecules to ‘react’ and no uniform distribution in the whole reactor.

The simulations result in six bridges, connecting two of the nucleosomes, with many cross-links. We found that the overall rosette-like chromatin structure can be clearly assembled under our HMK model assumptions (see Figure 9A,B and Supplementary Materials Video 1). We went further to see if this structure in principle can solely be formed when the kinetochore is unattached and the SAC mechanism is on. To do this, we used the same model setting as before and added the Ska complex and simplified template for a microtubule (Table 5). We also kept the same assumptions, except the change in the SAC signaling, which is switched off (inactive). In other words, some SAC moduli, like the “Template model”, are switched off once the microtubule is attached. Additionally, microtubule attachment removes the SAC pathway away from the kinetochore. Our simulation clearly shows a well-defined rosette-like structure (see Figure 9C,D and Supplementary Materials Video 2), where the Ska complex is presented in a w-shape dimer, as recently has been proposed [122].

We asked what happens if we consider three microtubules instead of a single microtubule along with a three-fold increase of protein copies. The simulation resulted in forming obscure rosette-like shapes after all microtubules have attached (Figure 12A,C,D and Supplementary Materials Video 3). This led us to go more thoroughly into analyzing the effect of microtubules. We re-run the simulation, where only two microtubules were available and attached with a three-fold protein amount. Interestingly, in this case, no rosette-shape was formed (Figure 12B and Supplementary Materials Video 4).

Taken together, a rosette-like chromatin structure can be assembled for both an unattached kinetochore and an attached kinetochore to single microtubule. In the case of two or three attached microtubules, we could not observe rosette-structures in simulation. The later rises the possibility that microtubules influence the chromatin-structure after attachments, which may be independent of SAC-component removal.

Figure 12. Multiple rosette-like structures assembly in mitosis. (A) Shows three rosette-like structures attached to three microtubules; (B) Same as in (A), where only two microtubules are present and attached with many cross-links occurring; (C) Shows that the assembly of the well-defined rosette-structures cannot be obtained for the multiple microtubules attached (A); (D) Top view of the simulation process shows the arrangement of the microtubules in (A). Simulations with multiple microtubules took about three hours.
Figure 12. Multiple rosette-like structures assembly in mitosis. (A) Shows three rosette-like structures attached to three microtubules; (B) Same as in (A), where only two microtubules are present and attached with many cross-links occurring; (C) Shows that the assembly of the well-defined rosette-structures cannot be obtained for the multiple microtubules attached (A); (D) Top view of the simulation process shows the arrangement of the microtubules in (A). Simulations with multiple microtubules took about three hours.
Cells 02 00506 g012 1024

3.2.3. Analyzing the Simulation Output of the HKM Model

In this section, we show how to apply some analysis methods (as described in Section 2.7) to the human mitotic kinetochore structure. ¿From these analyses, we do not aim to draw out a biological conclusion, as there are no empirical data available on mitotic kinetochore structure for comparison. We shall instead raise some speculations that could be of interest for experimentalists to test.

We ran 200 simulations of an unattached kinetochore model variant with 6 × 106 time-steps. For demonstration purposes, we focus on two features: First, how often is a reaction taking place during the 200 simulations (Figure 13). Second, we analyze the structural properties of the mitotic kinetochore using dendrograms (Figure 10).

Figure 13. Histogram showing percent of number of possible bindings. We record all realized bonds at the final time-step (6 × 106) of each of the 200 simulations. The maximum usually is 1,200, because every protein occurs six times per simulation, except CenpA (once) and CenpN (two times). In the graphic presented here, the relative frequency of every possible binding is depicted. The histogram shows that all reactions were often realized, except Mps1-Hec1 and Zwint-Mis12 (for details, see Section 3.2.3. Simulation time for all 200 experiments is 2–3 days, due to the fact that some of them can be calculated in parallel.
Figure 13. Histogram showing percent of number of possible bindings. We record all realized bonds at the final time-step (6 × 106) of each of the 200 simulations. The maximum usually is 1,200, because every protein occurs six times per simulation, except CenpA (once) and CenpN (two times). In the graphic presented here, the relative frequency of every possible binding is depicted. The histogram shows that all reactions were often realized, except Mps1-Hec1 and Zwint-Mis12 (for details, see Section 3.2.3. Simulation time for all 200 experiments is 2–3 days, due to the fact that some of them can be calculated in parallel.
Cells 02 00506 g013 1024

We have six copies of all protein (except CenpA and CenpN); therefore, we did record how many overall reactions take place during the 200 simulations (a maximum of 1,200 times for each protein complex, and a maximum of 200 and 400 times for CenpA and CenpN, respectively). We found that all reactions take place most of time, except two interactions, which are: Mps1-Hec1 and Zwint-Mis12 (Figure 13). It has been suggested that in-vivo interaction between Hec1 and Mps1 requires additional modifications [145]. We did not consider any additional modifications in our model, and we see the interaction of only about 10% of the maximal possible interactions (Figure 13). This is indeed interesting and consistent with the experimental results [145]. The reaction, Zwint-Mis12, is happening about 30% during overall simulations; this is due to the geometrical constraint, where Zwint is far a way from Mis12, which makes it difficult to interact during each simulation. Instead, Zwint binds more often to Knl1 [101], which is consistent to our model output.

It is, however, not clear how many of each protein copy interacts during each simulation. To study this issue, we did record each single copy protein interaction during each simulation run. We show the result of the two typical examples for the Hec1-Mps1 and Zwint-Mis12 interaction (Figure 14). The distribution of the Hec1-Mps1 reaction of protein copies (Figure 14) shows that during the simulations, only a single copy (30%) interacts or barely a second copy (10%) of Mps1 molecules bind to Hec1 (Figure 14, right panel). Zwint-Mis12 has another behavior, where three protein copies make their reaction happen often (25%–40%).

Figure 14. Analysis of the bindings Zwint-Mis12 and Hec1-Mps1. Studying Figure 13 reveals that two bonds (Zwint-Mis12 and Hec1-Mps1) are often absent. This bond formation can happen up to six times per simulation, because each of the proteins is present exactly six times. Therefore, it is interesting in how many simulations which number of these bonds is formed. These histograms show the distribution of the amount of the Zwint-Mis12 bonds (left) and of the Hec1-Mps1 bonds (right) that are realized during the 200 simulations. The X-axis refers to the number of realized bindings (Zwint-Mis12/Hec1-Mps1) in one simulation. The Y-axis refers to the amount of simulations. The Zwint-Mis12 bond it typically happening one to three times per simulation (two bonds are formed in 40% of the cases). The Hec1-Mps1 bond is not realized at all in 65% of the cases.
Figure 14. Analysis of the bindings Zwint-Mis12 and Hec1-Mps1. Studying Figure 13 reveals that two bonds (Zwint-Mis12 and Hec1-Mps1) are often absent. This bond formation can happen up to six times per simulation, because each of the proteins is present exactly six times. Therefore, it is interesting in how many simulations which number of these bonds is formed. These histograms show the distribution of the amount of the Zwint-Mis12 bonds (left) and of the Hec1-Mps1 bonds (right) that are realized during the 200 simulations. The X-axis refers to the number of realized bindings (Zwint-Mis12/Hec1-Mps1) in one simulation. The Y-axis refers to the amount of simulations. The Zwint-Mis12 bond it typically happening one to three times per simulation (two bonds are formed in 40% of the cases). The Hec1-Mps1 bond is not realized at all in 65% of the cases.
Cells 02 00506 g014 1024

It has been reported that the S-phase simulation model [56] has three families of structures, where over the simulations, always a single reaction was missing (CenpA/B, CenpB/W or CenpW/H3). We did similar structural analysis for our HKM mitosis model using both the RMSD and the paired RMSD distance metrics and generated a dendrogram using the UPGMA method (Un-weighted Pair Group Method with Arithmetic Mean) [57]. Our dendrogram (Figure 10) indicates that during mitosis, there is solely one family of structures. Thus, we support the idea that the mitotic kinetochore has one-family structures that are similar to each other. We justify the reason behind getting multiple structure for the S-phase model [56] as for the use of simple spheric molecular structures instead of considering detailed structural geometry for some important proteins and complexes. Hence, under the same geometry setting, a bridge between CenpA,-B, -W a H3 is impossible (the sum of the diameters is 7.5 nm, while the distance between the two nucleosomes is 14 nm).

Taken together, our model is consistent with the literature [145], supporting the idea that the interaction between Hec1 and Mps1 requires extra mechanism to take place. Additionally, our simulations suggest that the mitotic kinetochore has a single structure.

4. Discussion and Conclusions

In this study, we have presented, in a systematic, way how to apply a spatial rule-based approach to structural problems in molecular systems given interaction data and geometrical information. We have shown how various data sources can be integrated through a rule-based reaction network formalism and the specification of molecular geometries, including bond geometries. A molecule can be represented at different levels of detail. If nothing is known, molecules are represented as a sphere. Otherwise, arbitrary structures can be considered by structure templates (e.g., CenpC,-T,-Q and APC in our example).

One advantage of the spatial rule-based approach is a modular separation of the description of the reaction network from the molecule geometry (Figure 15). This means that the same description can be used for rule-based models that do not involve spatial properties.

4.1. Application Example

For demonstration, we applied our method to model the mitotic inner and outer kinetochore (HMK) for several variants of attached and unattached microtubules. Our analysis shows that a rosette-like chromatin structure can be assembled for both the unattached case or when a single microtubule is attached. In the case of two or three attached microtubules, we could not observe rosette-structures in simulation. With simulations of this process, we can obtain novel hints and inspirations for potential mechanisms. For example, in our simulation, microtubule attachment influences the rosette-shape, which might have a functional role additionally to the removal of SAC components. Furthermore, our model is consistent with the literature [145] supporting the idea that the interaction between Mps1 and Hec1 requires extra mechanism to take place.

4.2. Rule-Based Simulation Challenges

Even though our spatial, rule-based simulation approach solves some problems, many unsolved challenges remain: To begin with, there is a constraint on the systems that can be modeled with our current software implementation: at the moment, we cannot easily incorporate structural changes in proteins, e.g., a modification that would lead to different bond angles or different bond distances. While many systems, like the presented kinetochore model, can be modeled without these structural changes, we will include this feature in a future version by allowing a reaction that replaces one molecule with another, while keeping the bonds of this molecule intact.

Furthermore, from the modeling point of view, it would often be a great simplification if the BNGL language would allow the dynamic hierarchical definition of new elementary molecules, as proposed by Lemons et al. [146]. For example, a complex group of elementary molecules, like the CenpC,-T,-Q and APC from our example in Section 3, that is repeatedly referred to, might be defined as a new elementary molecule.

Figure 15. Illustration of modeling approaches in systems biology. Schematic representation summarizing our unconventional approach (in green), the classical or conventional approach (in red) and an outlook to future improvements (in yellow, dashed). ODE and PDE stand for ordinary and partial differential equation, respectively, whereby all other types of differential equations are implicitly included in this pathway, such as delay or fractional differential equation. SSA refers to the stochastic simulation algorithm and SDE refers to the general stochastic differential equation, which can be of any type (ordinary or partial).
Figure 15. Illustration of modeling approaches in systems biology. Schematic representation summarizing our unconventional approach (in green), the classical or conventional approach (in red) and an outlook to future improvements (in yellow, dashed). ODE and PDE stand for ordinary and partial differential equation, respectively, whereby all other types of differential equations are implicitly included in this pathway, such as delay or fractional differential equation. SSA refers to the stochastic simulation algorithm and SDE refers to the general stochastic differential equation, which can be of any type (ordinary or partial).
Cells 02 00506 g015 1024

4.3. Analysis Challenges

After correctly setting up a meaningful simulation run, there are still many challenges ahead in understanding the simulation results: In addition to the analysis techniques presented in Section 2.7, many others are conceivable. For example, it might be sensible to reproduce experimental measurements, like FRET, FRAP or mutant studies, to have a more direct comparison between simulation and reality. On the other side, naturally for a rule-based reaction system, the same pattern definition that is used to specify the left-hand side of a reaction rule might be applied to count the number of molecules with a specific property in the reactor [13]. However, even simply determining the concentration of a specific chemical pattern poses an interesting problem: different counting schemes would lead to strongly differing numbers with different semantics. Imagine having a single long polymer in simulation and looking for the number of a “few-molecules-subset” pattern appearing in the reactor. Either the whole complex molecule could be counted once or any position fulfilling the pattern requirements could be counted or only non-overlapping patterns could be counted. Even counting non-overlapping patterns is not unique, because the outcome can depend on where the first pattern was placed.

Furthermore, the methods presented in Section 2.7 can be used as building blocks of more complex experimental setups. Due to their numeric nature, these setups can be automatized to a high degree. This allows experimental procedures that involve an—by human standards—intractable number of parameter sets. For example, one could use the paired RMSD to show that a number of models produce qualitatively the same structure. By iteratively removing reactions that do not alter the structure beyond some threshold, one can derive minimal models that yield a certain structure. Alternatively, one could define a meta-model of possible reactions and combine reactions known from wet-lab experiments with randomly chosen ones to automatically discover the model that is closest to a known wild-type structure. By restricting the paired RMSD to a subset of the elementary molecules, one can apply this method even in case of partial structural knowledge.

4.4. Future Challenges

A future challenge for systems biology is to develop other approaches that should allow for the derivation of properties without the need of simulation (Figure 15, yellow path). This could be based on abstract interpretation [147149], coarse-graining [150153], chemical organization theory [33,154] or model checking [155158]. An overview of how our method relates to classical modeling and novel algebraic methods is presented in Figure 15. The same rule-base reaction network specification can feed into different analysis and simulation pipelines (Figure 15 red, green and yellow).

Rule-based modeling is already a step into the direction of re-usable models. The same is true for the hierarchical models [146]. Nonetheless, often, models have to be built again from scratch, when other aspects should be included. Rebuilding a model or making many changes are time-consuming. Furthermore, they have a specific language (ODE, SBML, etc.) which is not easily understood by non-modelers. To avoid the problem of these specific languages, an alternative approach, which is based on knowledge (called knowledge-based), could be employed. Our rule-based modeling in space approach serves as a first step towards a knowledge-based approach, since tables that include biological information are the input to this approach, where changes can easily be made. A future step would be to make the input to the rule-based models simpler by including biological sentences and searching for the missing information from databases and validating the model with mutations from these databases. Challenges in multi-scale modeling are not limited to systems biology, but also in many other fields, like in chemistry, social science, political systems and economics (e.g., [159162]).

Acknowledgments

We thank Stephan Diekmann for fruitful discussion. This work was supported by the German Research Foundation priority programs, InKoMBio (SPP 1395, Grant DI 852/10-1), the European Commissions NeuNeu project (248992) and the HIERATIC project (062098/14).

Conflict of Interest

The authors declare no conflict of interest.

References

  1. Perpelescu, M.; Fukagawa, T. The ABCs of CENPs. Chromosoma 2011, 120, 425–446. [Google Scholar]
  2. Jaspersen, S.L.; Winey, M. The budding yeast spindle pole body: Structure, duplication, and function. Annu. Rev. Cell Dev. Biol 2004, 20, 1–28. [Google Scholar]
  3. Hlavacek, W.S.; Faeder, J.R.; Blinov, M.L.; Perelson, A.S.; Goldstein, B. The complexity of complexes in signal transduction. Biotechnol. Bioeng 2003, 84, 783–794. [Google Scholar]
  4. Harris, L.A.; Hogg, J.; Faeder, J.R. Compartmental Rule-Based Modeling of Biochemical Systems. Proceedings of the 2009 Winter Simulation Conference (WSC), Austin, TX, USA, 13–16 December 2009; pp. 908–919.
  5. Klipp, E.; Liebermeister, W.; Wierling, C.; Kowald, A.; Lehrach, H.; Herwig, R. Systems Biology; Wiley-VCH: Weihnheim, Germany, 2009. [Google Scholar]
  6. Faeder, J.R.; Blinov, M.L.; Hlavacek, W.S. Rule-based modeling of biochemical systems with BioNetGen. Methods Mol. Biol 2009, 500, 113–167. [Google Scholar]
  7. Faeder, J.R.; Blinov, M.L.; Hlavacek, W.S. Graphical Rule-based Representation of Signal-transduction Networks. Proceedings of the ACM Symposium on Applied Computing, Santa Fe, NM, USA, 13–17 March 2005; pp. 133–140.
  8. Blinov, M.L.; Faeder, J.R.; Goldstein, B.; Hlavacek, W.S. BioNetGen: Software for rule-based modeling of signal transduction based on the interactions of molecular domains. Method Biochem. Anal 2004, 20, 3289–3291. [Google Scholar]
  9. Klann, M.; Koeppl, H. Spatial simulations in systems biology: From molecules to cells. Int. J. Mol. Sci 2012, 13, 7798–7827. [Google Scholar]
  10. Faeder, J.R. Toward a comprehensive language for biological systems. BMC Biol. 2011, 9. [Google Scholar]
  11. Machado, D.; Costa, R.S.; Rocha, M.; Ferreira, E.C.; Tidor, B.; Rocha, I. Modeling formalisms in systems biology. AMB Express 2011, 1. [Google Scholar] [CrossRef]
  12. Dittrich, P.; Ziegler, J.; Banzhaf, W. Artificial chemistries—A review. Artif. Life 2001, 7, 225–275. [Google Scholar]
  13. Gruenert, G.; Ibrahim, B.; Lenser, T.; Lohel, M.; Hinze, T.; Dittrich, P. Rule-based spatial modeling with diffusing, geometrically constrained molecules. BMC Bioinforma. 2010, 11. [Google Scholar] [CrossRef]
  14. Plimpton, S. Fast parallel algorithms for short-range molecular dynamics. J. Comput. Phys 1995, 117, 1–19. [Google Scholar]
  15. Santaguida, S.; Musacchio, A. The life and miracles of kinetochores. Embo J 2009, 28, 2511–2531. [Google Scholar]
  16. Thompson, S.L.; Bakhoum, S.F.; Compton, D.A. Mechanisms of chromosomal instability. Curr. Biol 2010, 20, R285–R295. [Google Scholar]
  17. Cimini, D.; Degrassi, F. Aneuploidy: A matter of bad connections. Trends Cell Biol 2005, 15, 442–451. [Google Scholar]
  18. Williams, B.R.; Prabhu, V.R.; Hunter, K.E.; Glazier, C.M.; Whittaker, C.A.; Housman, D.E.; Amon, A. Aneuploidy affects proliferation and spontaneous immortalization in mammalian cells. Science 2008, 322, 703–709. [Google Scholar]
  19. Suijkerbuijk, S.J.; Kops, G.J. Preventing aneuploidy: The contribution of mitotic checkpoint proteins. Biochim. Biophys. Acta 2008, 1786, 24–31. [Google Scholar]
  20. Holland, A.J.; Cleveland, D.W. Boveri revisited: Chromosomal instability, aneuploidy and tumorigenesis. Nat. Rev. Mol. Cell Biol 2009, 10, 478–487. [Google Scholar]
  21. Li, M.; Fang, X.; Wei, Z.; York, J.P.; Zhang, P. Loss of spindle assembly checkpoint-mediated inhibition of Cdc20 promotes tumorigenesis in mice. J. Cell Biol 2009, 185, 983–994. [Google Scholar]
  22. Danos, V.; Laneve, C. Formal molecular biology. Lect. Notes Comput. Sci 2004, 325, 69–110. [Google Scholar]
  23. Doncic, A.; Ben-Jacob, E.; Barkai, N. Evaluating putative mechanisms of the mitotic spindle checkpoint. Proc. Natl. Acad. Sci. USA 2005, 102, 6332–6337. [Google Scholar]
  24. Biosystemanalyse. Available online: http://www.biosys.uni-jena.de/ (accessed on July 2013).
  25. Brown, J.H.; Jardetzky, T.S.; Gorga, J.C.; Stern, L.J.; Urban, R.G.; Strominger, J.L.; Wiley, D.C. Three-dimensional structure of the human class II histocompatibility antigen HLA-DR1. Nature 1993, 364, 33–39. [Google Scholar]
  26. Palczewski, K.; Kumasaka, T.; Hori, T.; Behnke, C.; Motoshima, H.; Fox, B.; LeTrong, I.; Teller, D.; Okada, T.; Stenkamp, R.; et al. Crystal structure of rhodopsin: A G protein-coupled receptor. Science 2000, 4, 739–745. [Google Scholar]
  27. Vogel, R.; Mahalingam, M.; Ludeke, S.; Huber, T.; Siebert, E.; Sakmar, T.P. Functional role of the “ionic lock”—An interhelical hydrogen-bond network in family A heptahelical receptors. J. Mol. Biol 2008, 380, 648–655. [Google Scholar]
  28. Standfuss, J.; Zaitseva, E.; Mahalingam, M.; Vogel, R. Structural impact of the E113Q counterion mutation on the activation and deactivation pathways of the G protein-coupled receptor rhodopsin. J. Mol. Biol 2008, 380, 145–157. [Google Scholar]
  29. Cross, G.H.; Reeves, A.A.; Brand, S.; Popplewell, J.F.; Peel, L.L.; Swann, M.J.; Freeman, N.J. A new quantitative optical biosensor for protein characterisation. Biosens. Bioelectron 2003, 19, 383–390. [Google Scholar]
  30. Moritz, M.; Braunfeld, M.B.; Guenebaut, V.; Heuser, J.; Agard, D.A. Structure of the gamma-tubulin ring complex: A template for microtubule nucleation. Nat. Cell Biol 2000, 2, 365–370. [Google Scholar]
  31. Wiese, C.; Zheng, Y. A new function for the gamma-tubulin ring complex as a microtubule minus-end cap. Nat. Cell Biol 2000, 2, 358–364. [Google Scholar]
  32. Keating, T.J.; Borisy, G.G. Immunostructural evidence for the template mechanism of microtubule nucleation. Nat. Cell Biol 2000, 2, 352–357. [Google Scholar]
  33. Kreyssig, P.; Escuela, G.; Reynaert, B.; Veloz, T.; Ibrahim, B.; Dittrich, P. Cycles and the qualitative evolution of chemical systems. PLoS One 2012, 7, e45772. [Google Scholar]
  34. Deng, C.; Xiong, X.; Krutchinsky, A.N. Unifying fluorescence microscopy and mass spectrometry for studying protein complexes in cells. Mol. Cell Proteomics 2009, 8, 1413–1423. [Google Scholar]
  35. Magde, D.; Elson, E.; Webb, W.W. Thermodynamic fluctuations in a reacting system-Measurement by fluorescence correlation spectroscopy. Phys. Rev. Lett 1972, 29, 705–708. [Google Scholar]
  36. Foldes-Papp, Z. What it means to measure a single molecule in a solution by fluorescence fluctuation spectroscopy. Exp. Mol. Pathol 2006, 80, 209–218. [Google Scholar]
  37. Elson, E.L. Fluorescence correlation spectroscopy: Past, present, future. Biophys. J 2011, 101, 2855–2870. [Google Scholar]
  38. Ishikawa-Ankerhold, H.C.; Ankerhold, R.; Drummen, G.P. Advanced fluorescence microscopy techniques—FRAP, FLIP, FLAP, FRET and FLIM. Molecules 2012, 17, 4047–4132. [Google Scholar]
  39. Fields, S.; Song, O. A novel genetic system to detect protein-protein interactions. Nature 1989, 340, 245–246. [Google Scholar]
  40. Braun, P.; Tasan, M.; Dreze, M.; Barrios-Rodiles, M.; Lemmens, I.; Yu, H.; Sahalie, J.M.; Murray, R.R.; Roncari, L.; de Smet, A.S.; et al. An experimentally derived confidence score for binary protein-protein interactions. Nat. Methods 2009, 6, 91–97. [Google Scholar]
  41. Monti, M.; Orru, S.; Pagnozzi, D.; Pucci, P. Interaction proteomics. Biosci. Rep 2005, 25, 45–56. [Google Scholar]
  42. Phee, B.K.; Shin, D.H.; Cho, J.H.; Kim, S.H.; Kim, J.I.; Lee, Y.H.; Jeon, J.S.; Bhoo, S.H.; Hahn, T.R. Identification of phytochrome-interacting protein candidates in Arabidopsis thaliana by co-immunoprecipitation coupled with MALDI-TOF MS. Proteomics 2006, 6, 3671–3680. [Google Scholar]
  43. Ren, L.; Emery, D.; Kaboord, B.; Chang, E.; Qoronfleh, M.W. Improved immunomatrix methods to detect protein: Protein interactions. J. Biochem. Biophys. Methods 2003, 57, 143–157. [Google Scholar]
  44. Puig, O.; Caspary, E.; Rigaut, G.; Rutz, B.; Bouveret, E.; Bragado-Nilsson, E.; Wilm, M.; Seraphin, B. The tandem affinity purification (TAP) method: A general procedure of protein complex purification. Methods 2001, 24, 218–229. [Google Scholar]
  45. Kuntz, I.D.; Blaney, J.M.; Oatley, S.J.; Langridge, R.; Ferrin, T.E. A geometric approach to macromolecule-ligand interactions. J. Mol. Biol 1982, 161, 269–288. [Google Scholar]
  46. Pazos, F.; Valencia, A. Similarity of phylogenetic trees as indicator of protein-protein interaction. Protein Eng 2001, 14, 609–614. [Google Scholar]
  47. Snel, B.; Lehmann, G.; Bork, P.; Huynen, M.A. STRING: A web-server to retrieve and display the repeatedly occurring neighbourhood of a gene. Nucleic Acids Res 2000, 28, 3442–3444. [Google Scholar]
  48. Obuse, C.; Iwasaki, O.; Kiyomitsu, T.; Goshima, G.; Toyoda, Y.; Yanagida, M. A conserved Mis12 centromere complex is linked to heterochromatic HP1 and outer kinetochore protein Zwint-1. Nat. Cell Biol 2004, 6, 1135–1141. [Google Scholar]
  49. Weidtkamp-Peters, S.; Lenser, T.; Negorev, D.; Gerstner, N.; Hofmann, T.G.; Schwanitz, G.; Hoischen, C.; Maul, G.; Dittrich, P.; Hemmerich, P. Dynamics of component exchange at PML nuclear bodies. J. Cell Sci 2008, 121, 2731–2743. [Google Scholar]
  50. Förster, T. Intermolecular energy migration and fluorescence. Ann. Phys 1948, 437, 55–75. [Google Scholar]
  51. Jares-Erijman, E.A.; Jovin, T.M. FRET imaging. Nat. Biotechnol 2003, 21, 1387–1395. [Google Scholar]
  52. Periasamy, A.; Day, R.N. Visualizing protein interactions in living cells using digitized GFP imaging and FRET microscopy. Methods Cell Biol 1999, 58, 293–314. [Google Scholar]
  53. Hevekerl, H.; Spielmann, T.; Chmyrov, A.; Widengren, J. Förster resonance energy transfer beyond 10 nm: Exploiting the triplet state kinetics of organic fluorophores. Ann. Phys 1948, 2, 55–75. [Google Scholar]
  54. Grünert, G.; Dittrich, P. Using the SRSim Software for Spatial and Rule-Based Modeling of Combinatorially Complex Biochemical Reaction Systems. In Membrane Computing; Gheorghe, M., Hinze, T., Paun, G., Rozenberg, G., Salomaa, A., Eds.; Springer: Berlin/Heidelberg, Germany, 2011; Volume 6501, pp. 240–256. [Google Scholar]
  55. Humphrey, W.; Dalke, A.; Schulten, K. VMD—Visual molecular dynamics. J.Mol. Graphics 1996, 14, 33–38. [Google Scholar]
  56. Tschernyschkow, S.; Herda, S.; Gruenert, G.; Döring, V.; Gorlich, D.; Hofmeister, A.; Hoischen, C.; Dittrich, P.; Diekmann, S.; Ibrahim, B. Rule-based modeling and simulations of the inner kinetochore structure. In Prog. Biophys. Mol. Biol. 2013; press. [Google Scholar]
  57. Sokal, R.R.; Michener, C.D. A statistical method for evaluating systematic relationships. Kans. Univ. Sci. Bull 1958, 38, 1409–1438. [Google Scholar]
  58. Morin, M.M.; Moret, B.M. NETGEN: Generating phylogenetic networks with diploid hybrids. Method Biochem. Anal 2006, 22, 1921–1923. [Google Scholar]
  59. Ibrahim, B.; Dittrich, P.; Diekmann, S.; Schmitt, E. Mad2 binding is not sufficient for complete Cdc20 sequestering in mitotic transition control (an in silico study). Biophys. Chem 2008, 134, 93–100. [Google Scholar]
  60. Orthaus, S.; Biskup, C.; Hoffmann, B.; Hoischen, C.; Ohndorf, S.; Benndorf, K.; Diekmann, S. Assembly of the inner kinetochore proteins CENP-A and CENP-B in living human cells. ChemBioChem 2008, 9, 77–92. [Google Scholar]
  61. Hellwig, D.; Emmerth, S.; Ulbricht, T.; Döring, V.; Hoischen, C.; Martin, R.; Samora, C.P.; McAinsh, A.D.; Carroll, C.W.; Straight, A.F.; et al. Dynamics of CENP-N kinetochore binding during the cell cycle. J. Cell Sci 2011, 124, 3871–3883. [Google Scholar]
  62. Carroll, C.W.; Silva, M.C.; Godek, K.M.; Jansen, L.E.; Straight, A.F. Centromere assembly requires the direct recognition of CENP-A nucleosomes by CENP-N. Nat. Cell Biol 2009, 11, 896–902. [Google Scholar]
  63. Carroll, C.W.; Milks, K.J.; Straight, A.F. Dual recognition of CENP-A nucleosomes is required for centromere assembly. J. Cell Biol 2010, 189, 1143–1155. [Google Scholar]
  64. Przewloka, M.R.; Venkei, Z.; Bolanos-Garcia, V.M.; Debski, J.; Dadlez, M.; Glover, D.M. CENP-C is a structural platform for kinetochore assembly. Curr. Biol 2011, 21, 399–405. [Google Scholar]
  65. Eskat, A.; Deng, W.; Hofmeister, A.; Rudolphil, S.; Emmerth, S.; Hellwig, D.; Ulbricht, T.; Döring, V.; Bancroft, J.M.; McAinsh, A.D.; et al. Step-wise assembly, maturation and dynamic behavior of the human CENP-P/O/R/Q/U kinetochore sub-complex. PLoS One 2012, 7, e44717. [Google Scholar]
  66. Hellwig, D.; Hoischen, C.; Ulbricht, T.; Diekmann, S. Acceptor-photobleaching FRET analysis of core kinetochore and NAC proteins in living human cells. Eur. Biophys. J 2009, 38, 781–791. [Google Scholar]
  67. Suzuki, N.; Nakano, M.; Nozaki, N.; Egashira, S.I.; Okazaki, T.; Masumoto, H. CENP-B interacts with CENP-C domains containing Mif2 regions responsible for centromere localization. J. Biol. Chem 2004, 279, 5934–5946. [Google Scholar]
  68. Nishino, T.; Takeuchi, K.; Gascoigne, K.E.; Suzuki, A.; Hori, T.; Oyama, T.; Morikawa, K.; Cheeseman, I.M.; Fukagawa, T. CENP-T-W-S-X forms a unique centromeric chromatin structure with a histone-like fold. Cell 2012, 148, 487–501. [Google Scholar]
  69. Amano, M.; Suzuki, A.; Hori, T.; Backer, C.; Okawa, K.; Cheeseman, I.M.; Fukagawa, T. The CENP-S complex is essential for the stable assembly of outer kinetochore structure. J. Cell Biol 2009, 186, 173–182. [Google Scholar]
  70. Hori, T.; Amano, M.; Suzuki, A.; Backer, C.B.; Welburn, L.P.; Dong, Y.; McEwen, B.F.; Shang, W.H.; Suzuki, E.; Okawa, K.; et al. CCAN makes multiple contacts with centromeric DNA to provide distinct pathways to the outer kinetochore. Cell 2008, 135, 1039–1052. [Google Scholar]
  71. Obuse, C.; Iwasaki, O.; Kiyomitsu, T.; Goshima, G.; Toyoda, Y.; Yanagida, M. A conserved Mis12 centromere complex is linked to heterochromatic HP1 and outer kinetochore protein Zwint-1. Nat. Cell Biol 2004, 6, 1135–1141. [Google Scholar]
  72. Petrovic, A.; Pasqualato, S.; Dube, P.; Krenn, V.; Santaguida, S.; Cittaro, D.; Monzani, S.; Massimiliano, L.; Keller, J.; Tarricone, A.; et al. The MIS12 complex is a protein interaction hub for outer kinetochore assembly. J. Cell Biol 2010, 190, 835–852. [Google Scholar]
  73. Bock, L.J.; Pagliuca, C.; Kobayashi, N.; Grove, R.A.; Oku, Y.; Shrestha, K.; Alfieri, C.; Golfieri, C.; Oldani, A.; Dal Maschio, M.; et al. Cnn1 inhibits the interactions between the KMN complexes of the yeast kinetochore. Nat. Cell Biol 2012, 14, 614–624. [Google Scholar]
  74. McCleland, M.L.; Kallio, M.J.; Barrett-Wilt, G.A.; Kestner, C.A.; Shabanowitz, J.; Hunt, D.F.; Gorbsky, G.J.; Stukenberg, P.T. The vertebrate Ndc80 complex contains Spc24 and Spc25 homologs, which are required to establish and maintain kinetochore-microtubule attachment. Curr.Biol 2004, 14, 131–137. [Google Scholar]
  75. Janke, C.; Ortiz, J.; Lechner, J.; Shevchenko, A.; Shevchenko, A.; Magiera, M.M.; Schramm, C.; Schiebel, E. The budding yeast proteins Spc24p and Spc25p interact with Ndc80p and Nuf2p at the kinetochore and are important for kinetochore clustering and checkpoint control. EMBO J 2001, 20, 111–191. [Google Scholar]
  76. Bharadwaj, R.; Qi, W.; Yu, H. Identification of two novel components of the human NDC80 kinetochore complex. J. Biol. Chem 2004, 279, 13076–13085. [Google Scholar]
  77. Schleiffer, A.; Maier, M.; Litos, G.; Lampert, E.; Hornung, P.; Mechtler, K.; Westermann, S. CENP-T proteins are conserved centromere receptors of the Ndc80 complex. Nat. Cell Biol 2012, 14, 604–613. [Google Scholar]
  78. Nishino, T.; Rago, E.; Hori, T.; Tomii, K.; Cheeseman, I.M.; Fukagawa, T. CENP-T provides a structural platform for outer kinetochore assembly. EMBO J 2013, 32, 424–436. [Google Scholar]
  79. De Antoni, A.; Pearson, C.G.; Cimini, D.; Canman, J.C.; Sala, V.; Nezi, L.; Mapelli, M.; Sironi, L.; Faretta, M.; Salmon, E.D.; et al. The Mad1/Mad2 complex as a template for Mad2 activation in the spindle assembly checkpoint. Curr. Biol 2005, 15, 214–225. [Google Scholar]
  80. Lad, L.; Lichtsteiner, S.; Hartman, J.J.; Wood, K.W.; Sakowicz, R. Kinetic analysis of Mad2-Cdc20 formation: Conformational changes in Mad2 are catalyzed by a C-Mad2-ligand complex. Adv. Exp. Med. Biol 2009, 48, 9503–9515. [Google Scholar]
  81. Luo, X.; Tang, Z.; Rizo, J.; Yu, H. The Mad2 spindle checkpoint protein undergoes similar major conformational changes upon binding to either Mad1 or Cdc20. Mol. Cell 2002, 9, 59–71. [Google Scholar]
  82. Fang, G. Checkpoint protein BubR1 acts synergistically with Mad2 to inhibit anaphase-promoting complex. Mol. Biol. Cell 2002, 13, 755–766. [Google Scholar]
  83. Lara-Gonzalez, P.; Scott, M.I.; Diez, M.; Sen, O.; Taylor, S.S. BubR1 blocks substrate recruitment to the APC/C in a KEN-box-dependent manner. J. Cell Sci 2011, 124, 4332–345. [Google Scholar]
  84. Davenport, J.; Harris, L.D.; Goorha, R. Spindle checkpoint function requires Mad2-dependent Cdc20 binding to the Mad3 homology domain of BubR1. Exp. Cell Res 2006, 312, 1831–1842. [Google Scholar]
  85. Kulukian, A.; Han, J.S.; Cleveland, D.W. Unattached kinetochores catalyze production of an anaphase inhibitor that requires a Mad2 template to prime Cdc20 for BubR1 binding. Dev. Cell 2009, 16, 105–117. [Google Scholar]
  86. Foster, S.A.; Morgan, D.O. The APC/C subunit Mnd2/Apc15 promotes Cdc20 autoubiquitination and spindle assembly checkpoint inactivation. Mol. Cell 2012, 47, 921–932. [Google Scholar]
  87. Zhang, Y.; Lees, E. Identification of an overlapping binding domain on Cdc20 for Mad2 and anaphase-promoting complex: Model for spindle checkpoint regulation. Mol. Cell. Biol 2001, 21, 5190–5199. [Google Scholar]
  88. Chen, R.H.; Brady, D.M.; Smith, D.; Murray, A.W.; Hardwick, K.G. The spindle checkpoint of budding yeast depends on a tight complex between the Mad1 and Mad2 proteins. Mol. Biol. Cell 1999, 10, 2607–2618. [Google Scholar]
  89. Sironi, L.; Melixetian, M.; Faretta, M.; Prosperini, E.; Helin, K.; Musacchio, A. Mad2 binding to Mad1 and Cdc20, rather than oligomerization, is required for the spindle checkpoint. EMBO J 2001, 20, 6371–6382. [Google Scholar]
  90. Chung, E.; Chen, R.H. Spindle checkpoint requires Mad1-bound and Mad1-free Mad2. Mol. Biol. Cell 2002, 13, 1501–1511. [Google Scholar]
  91. Buffin, E.; Lefebvre, C.; Huang, J.; Gagou, M.E.; Karess, R.E. Recruitment of Mad2 to the kinetochore requires the Rod/Zw10 complex. Curr. Biol 2005, 15, 856–861. [Google Scholar]
  92. Chan, G.K.; Jablonski, S.A.; Starr, D.A.; Goldberg, M.L.; Yen, T.J. Human Zw10 and ROD are mitotic checkpoint proteins that bind to kinetochores. Nat. Cell Biol 2000, 2, 944–947. [Google Scholar]
  93. Kim, S.; Sun, H.; Tomchick, D.R.; Yu, H.; Luo, X. Structure of human Mad1 C-terminal domain reveals its involvement in kinetochore targeting. Proc. Natl. Acad. Sci. USA 2012, 109, 6549–6554. [Google Scholar]
  94. Taylor, S.S.; Ha, E.; McKeon, F. The human homologue of Bub3 is required for kinetochore localization of Bub1 and a Mad3/Bub1-related protein kinase. J. Cell Biol 1998, 142, 1–11. [Google Scholar]
  95. Wang, X.; Babu, J.R.; Harden, J.M.; Jablonski, S.A.; Gazi, M.H.; Lingle, W.L.; de Groen, P.C.; Yen, T.J.; van Deursen, J.M. The mitotic checkpoint protein hBUB3 and the mRNA export factor hRAE1 interact with GLE2p-binding sequence (GLEBS)-containing proteins. J. Biol. Chem 2001, 276, 26559–26567. [Google Scholar]
  96. Sudakin, V.; Chan, G.K.; Yen, T.J. Checkpoint inhibition of the APC/C in HeLa cells is mediated by a complex of BUBR1, BUB3, CDC20, and MAD2. J. Cell Biol 2001, 154, 925–936. [Google Scholar]
  97. Larsen, N.A.; A1-Bassam, J.; Wei, R.R.; Harrison, S.C. Structural analysis of Bub3 interactions in the mitotic spindle checkpoint. Proc. Natl. Acad. Sci. USA 2007, 104, 1201–1206. [Google Scholar]
  98. Skoufias, D.A.; Andreassen, P.R.; Lacroix, F.B.; Wilson, L.; Margolis, R.L. Mammalian mad2 and bub1/bubR1 recognize distinct spindle-attachment and kinetochore-tension checkpoints. Proc. Natl. Acad. Sci. USA 2001, 98, 4492–4497. [Google Scholar]
  99. Kiyomitsu, T.; Obuse, C.; Yanagida, M. Human Blinkin/AF15q14 is required for chromosome alignment and the mitotic checkpoint through direct interaction with Bub1 and BubR1. Dev. Cell 2007, 13, 663–676. [Google Scholar]
  100. Krenn, V.; Wehenkel, A.; Li, X.; Santaguida, S.; Musacchio, A. Structural analysis reveals features of the spindle checkpoint kinase Bub1-kinetochore subunit Knl1 interaction. J. Cell Biol 2012, 196, 451–467. [Google Scholar]
  101. Kiyomitsu, T.; Murakami, H.; Yanagida, M. Protein interaction domain mapping of human kinetochore protein Blinkin reveals a consensus motif for binding of spindle assembly checkpoint proteins Bub1 and BubR1. Mol. Cell. Biol 2011, 31, 998–1011. [Google Scholar]
  102. Bolanos-Garcia, V.M.; Lischetti, T.; Matak-Vinkovic, D.; Cota, E.; Simpson, P.J.; Chirgadze, D.Y.; Spring, D.R.; Robinson, C.V.; Nilsson, J.; Blundell, T.L. Structure of a Blinkin-BUBR1 complex reveals an interaction crucial for kinetochore-mitotic checkpoint regulation via an unanticipated binding Site. Structure 2011, 19, 1691–1700. [Google Scholar]
  103. Izawa, D.; Pines, J. How APC/C-Cdc20 changes its substrate specificity in mitosis. Nat. Cell Biol 2011, 13, 223–233. [Google Scholar]
  104. Herzog, F.; Primorac, I.; Dube, P.; Lenart, P.; Sander, B.; Mechtler, K.; Stark, H.; Peters, J.M. Structure of the anaphase-promoting complex/cyclosome interacting with a mitotic checkpoint complex. Science 2009, 323, 1477–1481. [Google Scholar]
  105. Sedgwick, G.G.; Hayward, D.G.; di Fiore, B.; Pardo, M.; Yu, L.; Pines, J.; Nilsson, J. Mechanisms controlling the temporal degradation of Nek2A and Kif18A by the APC/C-Cdc20 complex. EMBO J 2013, 32, 303–314. [Google Scholar]
  106. Hutchins, J.R.; Toyoda, Y.; Hegemann, B.; Poser, I.; Heriche, J.K.; Sykora, M.M.; Augsburg, M.; Hudecz, O.; Buschhorn, B.A.; Bulkescher, J.; et al. Systematic analysis of human protein complexes identifies chromosome segregation proteins. Science 2010, 328, 593–599. [Google Scholar]
  107. Lee, S.; Thebault, P.; Freschi, L.; Beaufils, S.; Blundell, T.L.; Landry, C.R.; Bolanos-Garcia, V.M.; Elowe, S. Characterization of spindle checkpoint kinase Mps1 reveals domain with functional and structural similarities to tetratricopeptide repeat motifs of Bub1 and BubR1 checkpoint kinases. J. Biol. Chem 2012, 287, 5988–6001. [Google Scholar]
  108. Kops, G.J.; Kim, Y.; Weaver, B.A.; Mao, Y.; McLeod, I.; Yates, J.R.; Tagaya, M.; Cleveland, D.W. ZW10 links mitotic checkpoint signaling to the structural kinetochore. J. Cell Biol 2005, 169, 49–60. [Google Scholar]
  109. Jelluma, N.; Dansen, T.B.; Sliedrecht, T.; Kwiatkowski, N.P.; Kops, G.J. Release of Mps1 from kinetochores is crucial for timely anaphase onset. J. Cell Biol 2010, 191, 281–290. [Google Scholar]
  110. Kemmler, S.; Stach, M.; Knapp, M.; Ortiz, J.; Pfannstiel, J.; Ruppert, T.; Lechner, J. Mimicking Ndc80 phosphorylation triggers spindle assembly checkpoint signalling. EMBO J 2009, 28, 1099–1110. [Google Scholar]
  111. Wang, H.; Hu, X.; Ding, X.; Dou, Z.; Yang, Z.; Shaw, A.W.; Teng, M.; Cleveland, D.W.; Goldberg, M.L.; Niu, L.; et al. Human Zwint-1 specifies localization of Zeste White 10 to kinetochores and is essential for mitotic checkpoint signaling. J. Biol. Chem 2004, 279, 54590–54598. [Google Scholar]
  112. Starr, D.A.; Saffery, R.; Li, Z.; Simpson, A.E.; Choo, K.H.; Yen, T.J.; Goldberg, M.L. HZwint-1, a novel human kinetochore component that interacts with HZW10. J. Cell Sci 2000, 113, 1939–1950. [Google Scholar]
  113. Cheeseman, I.M.; Niessen, S.; Anderson, S.; Hyndman, F.; Yates, J.R.; Oegema, K.; Desai, A. A conserved protein network controls assembly of the outer kinetochore and its ability to sustain tension. Genes Dev 2004, 18, 2255–2268. [Google Scholar]
  114. Starr, D.A.; Williams, B.C.; Hays, T.S.; Goldberg, M.L. ZW10 helps recruit dynactin and dynein to the kinetochore. J. Cell Biol 1998, 142, 763–774. [Google Scholar]
  115. Williams, B.C.; Li, Z.; Liu, S.; Williams, E.V.; Leung, G.; Yen, T.J.; Goldberg, M.L. Zwilch, a new component of the ZW10/ROD complex required for kinetochore functions. Mol. Biol. Cell 2003, 14, 1379–1391. [Google Scholar]
  116. Civril, F.; Wehenkel, A.; Giorgi, F.M.; Santaguida, S.; di Fonzo, A.; Grigorean, G.; Ciccarelli, F.D.; Musacchio, A. Structural analysis of the RZZ complex reveals common ancestry with multisubunit vesicle tethering machinery. Structure 2010, 18, 616–626. [Google Scholar]
  117. Okada, M.; Cheeseman, I.M.; Hori, T.; Okawa, K.; McLeod, I.X.; Yates, J.R.; Desai, A.; Fukagawa, T. The CENP-H-I complex is required for the efficient incorporation of newly synthesized CENP-A into centromeres. Nat. Cell Biol 2006, 8, 446–457. [Google Scholar]
  118. Dalai, Y.; Bui, M. Down the rabbit hole of centromere assembly and dynamics. Curr. Opin. Cell Biol 2010, 22, 392–402. [Google Scholar]
  119. Black, B.E.; Cleveland, D.W. Epigenetic centromere propagation and the nature of CENP-A nucleosomes. Cell 2011, 144, 471–479. [Google Scholar]
  120. Maiato, H.; DeLuca, J.; Salmon, E.D.; Earnshaw, W.C. The dynamic kinetochore-microtubule interface. J. Cell Sci 2004, 117, 5461–5477. [Google Scholar]
  121. Cheeseman, I.M.; Desai, A. Molecular architecture of the kinetochore-microtubule interface. Nat. Rev. Mol. Cell Biol 2008, 9, 33–46. [Google Scholar]
  122. Jeyaprakash, A.A.; Santamaria, A.; Jayachandran, U.; Chan, Y.W.; Benda, C.; Nigg, E.A.; Conti, E. Structural and functional organization of the Ska complex, a key component of the kinetochore-microtubule interface. Mol. Cell 2012, 46, 274–286. [Google Scholar]
  123. Minshull, J.; Sun, H.; Tonks, N.K.; Murray, A.W. A MAP kinase-dependent spindle assembly checkpoint in Xenopus egg extracts. Cell 1994, 79, 475–486. [Google Scholar]
  124. King, R.W.; Peters, J.M.; Tugendreich, S.; Rolfe, M.; Hieter, P.; Kirschner, M.W. A 20S complex containing CDC27 and CDC16 catalyzes the mitosis-specific conjugation of ubiquitin to cyclin B. Cell 1995, 81, 279–288. [Google Scholar]
  125. Sethi, N.; Monteagudo, M.C.; Koshland, D.; Hogan, E.; Burke, D.J. The CDC20 gene product of Saccharomyces cerevisiae, a beta-transducin homolog, is required for a subset of microtubule-dependent cellular processes. Mol. Cell. Biol 1991, 11, 5592–5602. [Google Scholar]
  126. Sudakin, V.; Ganoth, D.; Dahan, A.; Heller, H.; Hershko, J.; Luca, F.C.; Ruderman, J.V.; Hershko, A. The cyclosome, a large complex containing cyclin-selective ubiquitin ligase activity, targets cyclins for destruction at the end of mitosis. Mol. Biol. Cell 1995, 6, 185–197. [Google Scholar]
  127. Shirayama, M.; Zachariae, W.; Ciosk, R.; Nasmyth, K. The Polo-like kinase Cdc5p and the WD-repeat protein Cdc20p/fizzy are regulators and substrates of the anaphase promoting complex in Saccharomyces cerevisiae. EMBO J 1998, 17, 1336–1349. [Google Scholar]
  128. Li, R.; Murray, A.W. Feedback control of mitosis in budding yeast. Cell 1991, 66, 519–531. [Google Scholar]
  129. Hoyt, M.A.; Totis, L.; Roberts, B.T. S. cerevisiae genes required for cell cycle arrest in response to loss of microtubule function. Cell 1991, 66, 507–517. [Google Scholar]
  130. Fisk, H.A.; Mattison, C.P.; Winey, M. A field guide to the Mps1 family of protein kinases. Cell Cycle 2004, 3, 439–442. [Google Scholar]
  131. Lu, Y.; Wang, Z.; Ge, L.; Chen, N.; Liu, H. The RZZ complex and the spindle assembly checkpoint. Cell Struct. Funct 2009, 34, 31–45. [Google Scholar]
  132. Musacchio, A.; Salmon, E.D. The spindle-assembly checkpoint in space and time. Nat. Rev. Mol. Cell Biol 2007, 8, 379–393. [Google Scholar]
  133. Lohel, M.; Ibrahim, B.; Diekmann, S.; Dittrich, P. The role of localization in the operation of the mitotic spindle assembly checkpoint. Cell Cycle 2009, 8, 2650–2660. [Google Scholar]
  134. Ibrahim, B.; Schmitt, E.; Dittrich, P.; Diekmann, S. In silico study of kinetochore control, amplification, and inhibition effects in MCC assembly. Biosystems 2009, 95, 35–50. [Google Scholar]
  135. Ibrahim, B.; Diekmann, S.; Schmitt, E.; Dittrich, P. In-silico modeling of the mitotic spindle assembly checkpoint. PLoS One 2008, 3, el555. [Google Scholar]
  136. Ibrahim, B.; Dittrich, P.; Diekmann, S.; Schmitt, E. Stochastic effects in a compartmental model for mitotic checkpoint regulation. J. Integr. Bioinform. 2007, 4. [Google Scholar] [CrossRef]
  137. Simonetta, M.; Manzoni, R.; Mosca, R.; Mapelli, M.; Massimiliano, L.; Vink, M.; Novak, B.; Musacchio, A.; Ciliberto, A. The influence of catalysis on mad2 activation dynamics. PLoS Biol 2009, 7, e10. [Google Scholar]
  138. Caydasi, A.K.; Lohel, M.; Gruenert, G.; Dittrich, P.; Pereira, G.; Ibrahim, B. Dynamical model of the Spindle Position Checkpoint. Mol. Syst. Biol. 2012, 8. [Google Scholar] [CrossRef]
  139. Hoischen, C.; Bussiek, M.; Langowski, J.; Diekmann, S. Escherichia coli low-copy-number plasmid R1 centromere parC forms a U-shaped complex with its binding protein ParR. Nucleic Acids Res. 2008, 36, 607–615. [Google Scholar]
  140. Pietrasanta, L.I.; Thrower, D.; Hsieh, W.; Rao, S.; Stemmann, O.; Lechner, J.; Carbon, J.; Hansma, H. Probing the Saccharomyces cerevisiae centromeric DNA (CEN DNA)-binding factor 3 (CBF3) kinetochore complex by using atomic force microscopy. Proc. Natl. Acad. Sci. USA 1999, 96, 3757–3762. [Google Scholar]
  141. Screpanti, E.; de Antoni, A.; Alushin, G.M.; Petrovic, A.; Melis, T.; Nogales, E.; Musacchio, A. Direct binding of Cenp-C to the Mis12 complex joins the inner and outer kinetochore. Curr. Biol 2011, 21, 391–398. [Google Scholar]
  142. Kang, Y.H.; Park, C.H.; Kim, T.S.; Soung, N.K.; Bang, J.K.; Kim, B.Y.; Park, J.E.; Lee, K.S. Mammalian polo-like kinase 1-dependent regulation of the PBIP1-CENP-Q complex at kinetochores. J. Biol. Chem. 2011, 286, 19744–19757. [Google Scholar]
  143. Luger, K.; Mader, A.W.; Richmond, R.K.; Sargent, D.F.; Richmond, T.J. Crystal structure of the nucleosome core particle at 2.8 A resolution. Nature 1997, 389, 251–260. [Google Scholar]
  144. Tachiwana, H.; Kagawa, W.; Shiga, T.; Osakabe, A.; Miya, Y.; Saito, K.; Hayashi-Takanaka, Y.; Oda, T.; Sato, M.; Park, S.Y.; et al. Crystal structure of the human centromeric nucleosome containing CENP-A. Nature 2011, 476, 232–235. [Google Scholar]
  145. Martin-Lluesma, S.; Stucke, V.M.; Nigg, E.A. Role of Hec1 in spindle checkpoint signaling and kinetochore recruitment of Mad1/Mad2. Science 2002, 297, 2267–2270. [Google Scholar]
  146. Lemons, N.W.; Hu, B.; Hlavacek, W.S. Hierarchical graphs for rule-based modeling of biochemical systems. BMC Bioinforma. 2011, 12. [Google Scholar] [CrossRef]
  147. Feret, J.; Danos, V.; Krivine, J.; Harmer, R.; Fontana, W. Internal coarse-graining of molecular systems. Proc. Natl. Acad. Sci. USA 2009, 106, 6453–6458. [Google Scholar]
  148. Danos, V.; Feret, J.; Fontana, W.; Krivine, J. Abstract Interpretation of Cellular Signalling Networks. In Lecture Notes Computer Science; Logozzo, F., Peled, D., Zuck, L.D., Eds.; Springer: Berlin/Heidelberg, Germany, 2008; Volume 4905, pp. 83–97. [Google Scholar]
  149. Borisov, N.M.; Markevich, N.I.; Hoek, J.B.; Kholodenko, B.N. Trading the micro-world of combinatorial complexity for the macro-world of protein interaction domains. Biosystems 2006, 83, 152–166. [Google Scholar]
  150. Conzelmann, H.; Saez-Rodriguez, J.; Sauter, T.; Kholodenko, B.; Gilles, E. A domain-oriented approach to the reduction of combinatorial complexity in signal transduction networks. BMC Bioinforma. 2006, 7. [Google Scholar] [CrossRef]
  151. Conzelmann, H.; Fey, D.; Gilles, E.D. Exact model reduction of combinatorial reaction networks. BMC Syst. Biol. 2008, 2. [Google Scholar] [CrossRef]
  152. Koschorreck, M.; Conzelmann, H.; Ebert, S.; Ederer, M.; Gilles, E.D. Reduced modeling of signal transduction—A modular approach. BMC Bioinforma. 2007, 8. [Google Scholar] [CrossRef]
  153. Kamerlin, S.C.; Vicatos, S.; Dryga, A.; Warshel, A. Coarse-grained (multiscale) simulations in studies of biophysical and chemical systems. Annu. Rev. Phys. Chem 2011, 62, 41–64. [Google Scholar]
  154. Kreyssig, P.; Dittrich, P. Fragments and chemical organisations. Electr. Notes Theor. Comput. Sci 2011, 272, 19–41. [Google Scholar]
  155. Chen, T.; Han, T.; Kwiatkowska, M. On the complexity of model checking interval-valued discrete time markov chains. Inf. Process. Lett 2013, 113, 210–216. [Google Scholar]
  156. Kwiatkowska, M.; Parker, D. Advances in Probabilistic Model Checking. In Software Safety and Security-Tools for Analysis and Verification; Nipkow, T., Grumberg, O., Hauptmann, B., Eds.; IOS Press: Marktoberdorf, Germany, 2012; Volume 33, pp. 126–151. [Google Scholar]
  157. Heath, J.; Kwiatkowska, M.; Norman, G.; Parker, D.; Tymchyshyn, O. Probabilistic model checking of complex biological pathways. Lect. Notes Comput. Sci 2008, 391, 239–257. [Google Scholar]
  158. Forejt, V.; Kwiatkowska, M.; Parker, D. Pareto Curves for Probabilistic Model Checking. Proceeding of the 10th International Symposium on Automated Technology for Verification and Analysis, Thiruvananthapuram, India, 3–6 October 2012; pp. 317–332.
  159. Giavitto, J.L.; Michel, O.; Cohen, J. Pattern-matching and rewriting rules for group indexed data structures. ACM SIGPLAN Not 2002, 37, 76–87. [Google Scholar]
  160. Assayag, G. Computer Assisted Composition Today. Proceedings of the Symposium on Music and Computers, Corfu, Greece, 23–25 October 1998.
  161. Benko, G.; Flamm, C.; Stadler, P.F. A graph-based toy model of chemistry. J. Chem. Inf. Comput. Sci 2003, 43, 1085–1093. [Google Scholar]
  162. You, C.H.; Holder, L.B.; Cook, D.J. Graph-Based Data Mining in Dynamic Networks: Empirical Comparison of Compression-Based and Frequency-Based Subgraph Mining. Proceedings of the 2008 IEEE International Conference on Data Mining Workshops, Pisa, Italy, 15–19 December 2008; pp. 929–938.

Supplementary Materials

  • Video 1: The unattached kinetochore model.

  • Video 2: The attached kinetochore to single microtubule model.

  • Video 3: The attached kinetochore to three microtubules model.

  • Video 4: The attached kinetochore to two microtubules model.

  • BioNetGen language (BNGL) sources files: An example of complete sources files for the unattached kinetochore model variant (Video 1 has been generated with these codes).

  • Supplementary File 1:

    Supplementary (ZIP, 20783 KB)

  • Share and Cite

    MDPI and ACS Style

    Ibrahim, B.; Henze, R.; Gruenert, G.; Egbert, M.; Huwald, J.; Dittrich, P. Spatial Rule-Based Modeling: A Method and Its Application to the Human Mitotic Kinetochore. Cells 2013, 2, 506-544. https://doi.org/10.3390/cells2030506

    AMA Style

    Ibrahim B, Henze R, Gruenert G, Egbert M, Huwald J, Dittrich P. Spatial Rule-Based Modeling: A Method and Its Application to the Human Mitotic Kinetochore. Cells. 2013; 2(3):506-544. https://doi.org/10.3390/cells2030506

    Chicago/Turabian Style

    Ibrahim, Bashar, Richard Henze, Gerd Gruenert, Matthew Egbert, Jan Huwald, and Peter Dittrich. 2013. "Spatial Rule-Based Modeling: A Method and Its Application to the Human Mitotic Kinetochore" Cells 2, no. 3: 506-544. https://doi.org/10.3390/cells2030506

    Article Metrics

    Back to TopTop