Skip to main content
Nucleic Acids Research logoLink to Nucleic Acids Research
. 2020 Mar 31;48(9):5135–5146. doi: 10.1093/nar/gkaa200

MrDNA: a multi-resolution model for predicting the structure and dynamics of DNA systems

Christopher Maffeo 1,, Aleksei Aksimentiev 1,2,
PMCID: PMC7229838  PMID: 32232413

Abstract

Although the field of structural DNA nanotechnology has been advancing with an astonishing pace, de novo design of complex 3D nanostructures and functional devices remains a laborious and time-consuming process. One reason for that is the need for multiple cycles of experimental characterization to elucidate the effect of design choices on the actual shape and function of the self-assembled objects. Here, we demonstrate a multi-resolution simulation framework, mrdna, that, in 30 min or less, can produce an atomistic-resolution structure of a self-assembled DNA nanosystem. We demonstrate fidelity of our mrdna framework through direct comparison of the simulation results with the results of cryo-electron microscopy (cryo-EM) reconstruction of multiple 3D DNA origami objects. Furthermore, we show that our approach can characterize an ensemble of conformations adopted by dynamic DNA nanostructures, the equilibrium structure and dynamics of DNA objects constructed using off-lattice self-assembly principles, i.e. wireframe DNA objects, and to study the properties of DNA objects under a variety of environmental conditions, such as applied electric field. Implemented as an open source Python package, our framework can be extended by the community and integrated with DNA design and molecular graphics tools.

INTRODUCTION

DNA self-assembly has emerged as a versatile and robust approach to constructing nanoscale systems (1–8). Since its conception (1), methods for designing and synthesizing self-assembled DNA nanostructures have been progressing steadily (2,9–14), advancing to 2D origami nanostructures (4), to three-dimensional (3D) origami (5) and brick (15) assemblies, and to polygon mesh wireframes (16,17). The ease with which one can customize and functionalize DNA nanostructures has catalyzed proof-of-concept developments of a wide range of novel materials (18) and functional objects, including sensors for pH (19), voltage (20) and force (21); nanoscale containers (22,23); masks for nanolithography (24,25); and scaffolds for arranging nanotubes and nanoparticles (26,27). Presently, gigadalton 3D objects can be constructed through hierarchical self-assembly of DNA molecules (28,29) with single-nucleotide precision, which makes DNA nanostructures uniquely amenable for mastering spatial organization at the nanoscale.

Computational prediction of the in situ properties of DNA nanostructures can greatly facilitate the nanostructure design process. Several computational models of DNA nanostructures have been developed already, varying by the amount of detail provided by the computational description. On the coarse end of the spectrum, the CanDo finite element model (30) minimizes the mechanical stress within a DNA origami structure exerted by its pattern of crossovers to provide a fast estimate of its preferred conformation. At the opposite end of the spectrum, all-atom molecular dynamics (MD) simulations have been used to study the structure (31–33) and conductance (34–37) of DNA nanostructures and channels at a much higher computational cost. In between, a number of general purpose coarse-grained (CG) models of DNA are available (38–41), but only very few have been applied specifically to the study of DNA nanostructures (32,42–43) including the CG oxDNA (42,44) model and all-atom, implicit solvent elastic network-guided MD (ENRG-MD) (32) method.

A major objective for computational models of DNA nanostructures is to give the designers quick feedback on the impact of their design choices. The models employed by the coarsest structure prediction tools may not adequately represent DNA, for example, to guide the placement of fluorescent dyes or functionalized groups. CG models do not so far provide insights into the ion conducting and rheological properties of DNA nanostructures. To date, only all-atom MD has been used to computationally examine these properties. On the other hand, higher resolution modeling can be prohibitively slow for routine structural characterization, or for sampling the configurational space of a nanostructure, particularly when the equilibrium, relaxed conformation of an object departs strongly from its initial idealized configuration as obtained from popular CAD tools such as cadnano (45), vHelix (16) or DAEDALUS (17). Although reorienting components of the design prior to simulation can facilitate proper structural relaxation (46), it may be nontrivial to find an appropriate transformation for many structures, especially those containing programmed bends and twists.

Here we present a computational framework that combines low- and high-resolution models of DNA objects to enable fast and accurate predictions of the objects’ structure and dynamics suitable for iterative design applications, Figure 1. Starting from an idealized design of a DNA object, our structure prediction protocol performs rapid relaxation of the design using a low-resolution model. The outcome of the relaxation simulation is further refined through several simulations performed at increasing resolution to produce an accurate, fully atomistic representation of the object’s in situ structure. Our computational framework can also characterize the conformational dynamics of the object at multiple time scales and characterize the behavior of the objects in the presence of external potentials and/or under non-equilibrium conditions.

Figure 1.

Figure 1.

DNA nanostructure design workflow augmented by the multi-resolution modeling framework, mrdna. The top row depicts a traditional design cycle involving several steps that result in a latency of several weeks before feedback is obtained. A DNA origami bundle with a programmed 180° bend (56) is shown as an example. The bottom row illustrates how mrdna can be used to obtain the equilibrium in situ configuration of the DNA nanostructure. The snapshots within the arrow illustrate several stages of a CG simulation trajectory; the structure immediately to the right of the arrow shows the final all-atom configuration. The resulting all-atom structures are directly suitable for subsequent all-atom MD simulations, the right most image shows an example of a solvated all-atom system. TEM and gel images are reproduced from Ref. 56 with permission.

MATERIALS AND METHODS

All CG simulations of DNA origami objects were performed using an in-house developed GPU-accelerated CG simulation package, Atomic Resolution Brownian Dynamics (ARBD) (47). ARBD supports Brownian and Langevin dynamics simulations of systems composed of isotropic point-like particles interacting through tabulated bonded and non-bonded interactions. ARBD simulations are currently configured through system-specific files that the mrdna framework writes automatically.

Overview of the mrdna framework

The mrdna framework is shipped as a Python package that describes DNA nanostructures using several levels of abstraction. At the base level are classes that represent collections of beads or atoms interacting through user-specified bonded and non-bonded potentials. These classes provide a file-based interface to our simulation engine, ARBD. The second level of abstraction provides classes that describe contiguous double-stranded and single-stranded regions or ‘segments’ of DNA that can be joined together through intrahelical, terminal and crossover connections. The spatial configuration of each DNA segment is described by a spline function defined in cartesian coordinates. For dsDNA, an additional four-dimensional spline fit through quaternions optionally provides a parametric representation of the local orientation throughout the duplex. The use of splines allows the classes to generate bead-based models with user-specified resolution. Alternatively the segment classes can generate an atomistic or oxDNA model of the structure. The spline representation mediates conversion from one resolution to another; after a CG simulation is performed, new splines are generated that pass through the coordinates of the beads obtained at the end of the simulation.

The segment classes can be used directly for algorithmic design of DNA nanostructures or can be used to write scripts that automatically convert a model from another software package into an mrdna model. For example, a class was developed using the new cadnano2.5 Python API to read in a cadnano json design file, allowing direct access to the cadnano data structures for conversion to the segment-based model. Similar classes have been developed for converting vHelix mesh models and atomic Protein Data Bank (PDB) files into mrdna models.

Conversion of spline model to bead model

Beads representing interaction sites within double- and single-stranded segments are iteratively placed through the structure and assigned positions within the segment, see Supplementary Figure S1. First, beads are placed at the middle of every intrahelical (or intrastrand) connection. Beads are next placed on both sides of each crossover. When two beads are intrahelically adjacent and placed within the user-provided resolution of the model, they are merged into one bead. Next, beads are placed at the ends of each segment if none already exists. Beads are placed between each pair of existing beads so that the linear density of beads is lower than a user-specified threshold. Finally, the intrahelical distance between adjacent beads is calculated from their positions and used to assign a nucleotide count to each bead. The beads are hierarchically clustered according to the nucleotide count, ensuring a tractable number of bead types is provided to the simulation engine. If the model is generated with a local representation of twist, each dsDNA bead receives an orientation bead shifted by the vector R · (1.5 Å, 0, 0), where the orientation matrix R is obtained from the spline fit through quaternions. If no such spline is available, the orientation is taken to be a rotation of ϕ = n × 34.48° (for a helical rise of 10.44) about the local tangential axis, where n is contour length at the bead given in units of base pairs.

Variable-resolution bead model of DNA nanostructures

Once the beads have been placed throughout a DNA nanostructure, bonded and non-bonded potentials are specified to describe the bead–bead interactions. A tabulated non-bonded potential was developed by iteratively tuning interactions until the osmotic pressure in an array of 256 two-turn DNA helices—each made effectively infinite through periodic boundary conditions—matched the experimental measurements of Rau and Parsegian for DNA in a 25 mM MgCl2 electrolyte (48), see Supplementary Figure S2. If the user supplies a custom Debye length, a correction is applied to the tabulated non-bonded potential corresponding to the difference of Yukawa potentials for the user-supplied and 11.1-Å Debye lengths, the latter representing the ion condition of the Rau and Parsegian data. The non-bonded interaction between any pair of beads is scaled by the nucleotide count of each bead involved. DNA array simulations verified that the pressure was insensitive to the resolution of DNA under 1, 3, 5 and 7 bp/bead conditions, with and without a local representation of the twist. The same potential is used for non-bonded interactions involving ssDNA. For dsDNA, non-bonded exclusions are placed between all pairs of beads intrahelically within 20 bp of one another. Additionally, exclusions are placed between all beads within 3 bp of a crossover bead. For ssDNA, exclusions are placed between pairs of beads in the same strand that are within five nucleotides (nts).

The bonded interactions within the model are realized by harmonic potentials with spring constants and rest lengths determined from known polymer properties of DNA, Supplementary Figure S3. A harmonic bond connects each consecutive pair of beads in a helix or strand with a separation-dependent rest length (3.4 Å/bp or 6.4 Å/nt) and a spring constant derived from the elastic moduli of dsDNA and ssDNA (1000 and 800 pN, respectively) (49). A harmonic angle potential is placed on the angle formed by the bonds between consecutive pairs of beads within a helix or strand with a 0° rest angle and spring constant kp derived from the persistence length of DNA. Specific values of kp were obtained by numerically solving the following equation:

graphic file with name M2.gif (1)

where s is a half of the contour length between the first and the third bead, Lp is the persistence length (taken to be 50 and 1.2 nm for dsDNA and ssDNA), θ is the angle between the beads, kp is the spring constant used in the simulation and β = 1/kBT, where kBT is the thermodynamic temperature.

The mrdna models can be generated with or without a local representation of the orientation of each base pair. When the twist is represented locally, an orientation bead representing the major groove is placed alongside each dsDNA backbone bead, attached to its parent bead by a harmonic potential (1.5 Å rest length; kspring = 30 kcal mol −1 Å−2). A harmonic angle potential (90° rest angle; kspring = 0.5 kp) is placed between consecutive intrahelical beads and each of the orientation beads. A harmonic potential is placed on the dihedral angle formed by each orientation bead, its parent intrahelical bead, the adjacent intrahelical bead and the corresponding orientation bead with a separation-dependent rest angle (10.44 helical rise) and a spring constant ktw(s) designed to produce a 90-nm twist-persistence length for dsDNA to match the measured twist persistence length under tension (50), see Supplementary Figures S3 and S4.

At last, a harmonic bond is placed between intrahelical beads on either side of a junction spanning two helices (such as a DNA origami crossover connection). The spring constant (4 kcal mol−1 Å−2) and the rest length (18.5 Å) of the bond were derived from the distribution of crossover distances observed in atomistic simulations (33). When neither side of the junction occurs at the end of a DNA helix, the junction is assumed to represent a DNA origami crossover, and a heuristic dihedral angle potential is placed on an intrahelical bead on one side of the first junction bead, the first junction bead, the second junction bead and the intrahelical bead on the same side of the junction (kspring = 0.25 kp; default rest angle of zero) to keep the adjacent helices roughly parallel. We chose this rest dihedral angle value, which deviates from the ∼55° value observed experimentally for free Holliday junctions in solution (51), because the junctions in a DNA origami nanostructure have equilibrium angles near to zero (33,52). However, the user may specify their own rest angle so that some off-lattice DNA nanostructures may be modeled that have crossovers occuring in the middle of a helix, such as for gridiron nanostructures (53). If twist is locally represented, an additional harmonic potential is added to the dihedral angle formed on each helix by the junction bead on the opposite helix, the junction bead, the bead adjacent to the junction bead and the junction bead’s orientation bead (kspring = 0.25 kp; rest angle = ±120, depending on the strand) to ensure that the connecting strand on each side of the junction faces the helix on the other side of the junction, Supplementary Figure S5A. In the event that twist is not locally represented, the torsion within each helix is described by a dihedral angle potential applied between the beads forming consecutive junctions in the helix. The rest angle is calculated as described above for the local representation of twist, except if the junctions occur on different strands, 120° will be added to (or removed from) the rest angle if the 5′-to-3′ direction at each junction site points away from (or toward) the other junction, Supplementary Figure S5B. The spring constant is calculated from three springs in series, the first and last taken to be one eight kp for a single nucleotide span to represent some intrinsic, resolution-independent flexibility of the crossovers, and the central spring being calculated as described for the twist dihedral potential when a local twist is applied.

At the time of writing, all potentials are independent of the DNA sequence. Additionally, twist–bend and twist–stretch coupling have been neglected.

RESULTS

Multi-resolution model of self-assembled DNA nanostructures

The mrdna framework performs an automatic multi-stage simulation of a DNA nanostructure starting from its idealized initial configuration, which can come from a variety of sources. Here, we illustrate the basic workflow of mrdna using, as an example, a cadnano (45) design of a curved six-helix bundle.

Starting from a configuration file generated by the design software, Figure 2A, the standard mrdna relaxation procedure begins with the construction of a low-resolution, 5 base pair (bp)/bead CG model, Figure 2B. By default, and throughout this paper, the low-resolution model is generated without a local representation of twist, though this behavior is easily adjusted (see ‘Materials and Methods’ section). The non-bonded interactions between the beads are described by empirical potentials that have been calibrated to reproduce the experimentally measured osmotic pressure of a DNA array in 25 mM MgCl2 electrolyte (48), Supplementary Figure S2.

Figure 2.

Figure 2.

Multiresolution structural relaxation of a curved DNA origami object. (A) Cadnano (45) design of a curved six-helix bundle. A regular pattern of insertions (blue loops) in the two helices on the left and deletions (red crosses) in the two helices on the right induce the curvature (56). (BD) Low-resolution CG simulation of the bundle. In just 40 nanoseconds, the bundle adopts a curved conformation. The bundle is shown using a bead-and-stick representation, where each bead represents 5 bp, on average. (E and F) High-resolution CG simulations of the bundle. A spline-based mapping procedure yields a high-resolution (2 beads per base pair) model by interpolation. The high-resolution model includes a local representation of each base pair’s orientation (teal beads). The twist dihedral angle potential between adjacent orientation beads is smoothly truncated to allow the linking number to relax during a brief, 10 ns simulation (E). A subsequent 10 ns simulation performed without the truncation of the twist potential allows complete relaxation of the bundle (F). (G) Resulting atomic model of the curved six-helix bundle. Canonical base pairs are placed throughout the structure using the spline-based mapping procedure. The images below each of the three CG simulation steps illustrate schematically how the model represents one turn of DNA.

Our model can accommodate other ionic strength conditions at the level of the Debye–Hückel approximation, accounting for ionic strength conditions through a Debye length parameter. The beads within each double- or single-stranded region are connected by harmonic bond and angle potentials with separation-dependent rest-lengths and spring constants derived to match the experimentally measured elastic moduli and persistence lengths, Supplementary Figures S3 and S4. At last, bond, angle and dihedral potentials were defined for the beads at each junction, see ‘Materials and Methods’ section for further details. The resulting model is relaxed from its initial, idealized geometry using the simulation engine, ARBD (47). Figure 2BD illustrate the relaxation simulation of the curved six-helix bundle.

The structure obtained at the end of the above relaxation process is further refined through additional simulations performed using models of increasing resolution. To facilitate the change to a higher (2 beads/bp) resolution, a spline function is first defined to trace the center line of each double- or single-stranded DNA region in the structure obtained at the end of the low-resolution simulation, Figure 2D. The spline function is used to generate the coordinates of the finer resolution model by interpolation, Figure 2E. Two beads are used to represent each base pair of dsDNA: one bead representing the base pair’s center of mass and one representing the base pair’s orientation—the location of the major groove. The initial placement of the orientation beads is equilibrated in a brief simulation using a harmonic dihedral potential that is smoothly truncated at 1 kcal mol−1, which allows the linking number of DNA to change during this equilibration simulation. Following that, the model is simulated using a full (non-truncated) harmonic twist potential, producing a high-resolution equilibrated structure, Figure 2F. Center line and orientation spline fits through the average coordinates obtained at the end of the 2 beads/bp equilibration simulation are used to construct an all-atom structure, Figure 2G. The Methods section provides a complete description of the mapping and model parameterization procedures. It is also possible to use mrdna to generate coarser models that include the local representation of the twist, although doing so may impact the computational performance of the model.

Structure prediction

Using the mrdna framework, one can obtain an equilibrium, fully atomistic structure of a complex DNA origami object that almost perfectly matches a cryo-electron microscopy (cryo-EM) reconstruction in 30 min or less. To demonstrate the accuracy of the model, the ‘pointer’ DNA origami object (52) was simulated for 800 ns (4 million steps) at 5-bp/bead resolution, requiring ∼5 min on an NVIDIA Quadro RTX 5000, see Supplementary Animation 1. The resulting conformations were compared with the high-resolution 3D reconstruction obtained using cryo-EM (52).

To enable comparison of the structures, the simulated configurations were first aligned to the initial, idealized configuration by minimizing the root mean squared deviations (RMSD) of the beads’ coordinates. The bead coordinates from the final 600-ns fragment of the simulation were then averaged, producing a simulation-derived structure, shown in blue in Figure 3A. For visual comparison, the resulting time-averaged 5-bp/bead structure was docked into the cryo-EM density (white) using the brute-force voltool fit algorithm of VMD (54), revealing a good overall match for the global configuration, Figure 3A (top row). To quantitatively monitor the relaxation of the structure in the mrdna simulation, we used, as a reference, the all-atom model (52) produced by flexible fitting of the idealized conformation into the cryo-EM density (55). In addition, we performed an ensemble of 16 simulations as described above, providing a statistical description of the relaxation process. The center of each base pair in the pointer was estimated from each CG trajectory by fitting splines through the bead coordinates (see ‘Materials and Methods’ section).

Figure 3.

Figure 3.

Structure prediction with mrdna. (A) Comparison of the structural models obtained through an mrdna simulation and cryo-EM reconstruction (EMD-2210) of the ‘pointer’ structure (52). The top row depicts the simulated and experimental structures as isosurfaces of the CG bead (blue, 1 bp/Å3 isovalue) and electron (white, 0.08 isovalue) densities, respectively. The bottom row compares the simulated (blue) and experimental (red) all-atom models. In the top row, simulated structural fluctuations are visualized using a semi-transparent surface showing the average density of CG beads during the final 600 ns of a 5-bp/bead simulation. Note that some helices along the periphery of the structure were not resolved in the cryo-EM model (52). (B) RMSD of the center of mass of each base pair in the simulated pointer structure from those of the cryo-EM-derived atomic structure (52) at 5 bp/bead (blue) and 2 beads/bp (orange and green) resolutions. For each resolution, an ensemble of sixteen simulations was performed, the RMSD for each trajectory was computed every 2 ns, and the ensemble of RMSD values was averaged at each moment in time to provide the solid line. The shaded regions around each solid line shows the corresponding standard deviation of the RMSD. The dashed lines depict the RMSD between the ensemble’s average structure and the cryo-EM-derived structure. For all RMSD calculations, the splines traced through the instantaneous configurations were used to determine the position of each base pair. The configurations of the 5-bp/bead ensemble after 400-ns were used to initialize an ensemble of 2-beads/bp simulations (green). (CF) Comparison of the mrdna (blue, 1 bp/Å3 isovalue) and cryo-EM (white, 0.02 isovalue) models of the objects designed and characterized by the Dietz group (28): v-brick structures without (C; EMD-3828) and with (D; EMD-3828) twist correction, the connector block (E; EMD-3827) and the triangular vertex (F; EMD-3826).

The RMSD of the simulated base pair centers from the experimentally derived structure was seen to decrease rapidly at first and more steadily as the simulation progressed, see blue curve in Figure 3B. Because the simulation was performed at 310 K, the ensemble of structures provided a significant spread of values for the instantaneous RMSD of each simulation due to equilibrium fluctuations of the underlying structures, which are averaged out in the cryo-EM reconstruction. To reduce the effect of the fluctuations, we aligned and averaged the base pair coordinates of the sixteen structures at each 2-ns interval to calculate the time-dependent RMSD between the experimental and average simulated structures, which dropped below 1 nm, dashed blue line in Figure 3B. For comparison, we performed the same set of simulations, but using the 2-beads/bp model. Due to the greater number of beads used to represent the structure and the higher density of beads, the high-resolution simulations required substantially more computation, that is, nearly 4 hours to obtain a single 800-ns simulation (20 million steps) on the same hardware, see orange lines in Figure 3B. The relaxation of the structure occured more slowly, but the average structure was even closer to the experimentally derived structure with the structure-averaged RMSD approaching 8 Å by the end of the simulation. Mapping the final configuration of the ensemble-averaged structure into an atomistic model provided an all-atom structure that matched the cryo-EM derived all-atom model very closely, bottom row of Figure 3A. Thus, the mrdna simulation resulted in a model with comparable deviation from the experimentally derived structure (8.3 Å) as the more detailed models, ENRG-MD (32) (9.1 Å) and oxDNA (39,40) (8.4 Å (44)) but at a fraction of the computational cost. It is worth noting that all of the above models yielded exceptional agreement with experiment, considering the reported 1.15-nm resolution of the reconstruction.

Further validation of the mrdna structure prediction protocol was obtained by simulating a set of four honeycomb lattice structures that were recently designed and characterized through 3D cryo-EM reconstructions by the Dietz group (28). The structures included ‘v-brick’ objects, without and with twist correction, a rectangular prism ‘connector’ and a triangular prism ‘vertex’. The protocol described above for the pointer structure was applied to each object, resulting in average models that could be docked very nicely in the corresponding cryo-EM densities, Figure 3CF. The ends of the bricks were seen to spread slightly more in mrdna simulation than in the cryo-EM reconstructions. However, the overall simulated shape—including twist within each prism and, where applicable, the skew between connected prisms—matched the cryo-EM density very closely, Supplementary Animations 2–6.

Many DNA origami objects are designed to bend or twist via a pattern of base pair insertions and deletions (56), Figure 4A. Atomistic (or ENRG-MD) simulations of such objects that start from the idealized configuration can become trapped in a local energy minimum, preventing complete relaxation of the object. The mrdna framework was used to relax an ensemble of curved and twisted structures, Figure 4 B–C. A 5-bp/bead simulation was performed for each bent or twisted structure lasting 200 and 4 μs, respectively, followed by 160 ns of 2-beads/bp simulations. All of the objects relaxed to configurations that closely resembled the experimental transmission electron microscopy (TEM) images, providing qualitative validation of the model. The simulations suggest that the bent nanostructures exhibit increasing left-handed twist with increasing curvature with average out-of-plane angles of 8, 1 and −26° for structures with 60, 120 and 180° bends, respectively, where a positive out-of-plane angle corresponds to a right-handed twist in the curved region of the structure. Such out-of-plane twists may have been difficult to observe experimentally because the nanostructures were deposited on a surface prior to imaging. In addition, we note that the structure designed to have a 180° bend has a slightly lower bend angle in Figure 4B due to the structure’s relatively large out-of-plane angle.

Figure 4.

Figure 4.

Structural relaxation of curved and twisted DNA origami objects. (A) Structures with programmed bends as characterized by TEM in Ref. 56 (top row) and reconstructed at atomic resolution using mrdna (bottom row). From left-to-right, the structures were designed to have a bend of 0°, 60°, 120° and 180°. (B) Bend angle timeseries during 5-bp/bead mrdna relaxation of the structures shown in panel A starting from an initial configuration of a straight rod. Dashed lines depict the target angles. (C) Dependence of the twist angle on the helical rise imposed by crossovers for honeycomb brick origami structures (56) in 5-bp/bead mrdna simulations and as measured using TEM (56). (D) All-atom models of brick origami structures (left, top and bottom) resulting from mrdna simulations starting from an idealized configuration (left, center). The right column shows the corresponding TEM images. (E) Gear nanostructure (56) before (top; 5 bp/bead) and after (center; atomistic) an mrdna simulation. The gear is depicted using a bead-and-stick representation. The bottom panel depicts the corresponding TEM image. (F) Flask nanostructure (57) before (top; 5 bp/bead) and after (center; atomistic) an mrdna simulation. The top panel shows a bead-and-stick representation including long bonds that span the structure. All TEM images were reproduced from Ref. 56 with permission.

The idealized conformation of many DNA nanostructures can sometimes deviate so dramatically from the object’s equilibrated configuration that CG methods, including mrdna, are unable to relax the structure. For example, in its idealized geometry, the flask (57) object from the Yan group is a highly symmetric, flat DNA object that is quickly crushed by intrahelical connections that span the object, see Supplementary Animation 7. To make it possible to model such complicated structures, the mrdna framework has been implemented as a Python package, which allows one to script modifications to a model. For example, many designs are intended to self-assemble into larger assemblies. The scripting interface was used to combine two models of the half-gear design (56), applying a 180° rotation to one of the models and adding intrahelical connections between the two half-gears before simulating for 2 μs with 5 bp/bead and 8 ns with 2 beads/bp, Figure 4E. A second Python script was used to apply a 90° rotation to half of each helix in a DNA flask before running 2-μs, 5-bp/bead and 8-ns, 2-beads/bp simulations, Figure 4F and Suppplementary Animation 8. In both cases, scripting was necessary to prevent the rapid collapse of bonds that span the initially straight structure, which would result in a crushed, tangled model of the structure. The resulting relaxed structure of the gear was seen to closely resemble TEM images of the object, Figure 4D.

Conformational dynamics

DNA origami nanostructures are sometimes designed to adopt multiple conformations. The mrdna framework can be used to predict the average structure and the conformational fluctuations of such objects. For example, the Dietz and Castro groups have designed nanoscale calipers using DNA origami that allow measurement of intermolecular forces between proteins attached to each arm of the caliper (58,59). TEM can be used to determine the distribution of angles of the caliper with and without attached proteins, allowing inference of intermolecular forces. To demonstrate the utility of the mrdna framework for sampling conformational space, three 700-µs simulations (3.5 billion steps each) of the caliper design from the Dietz group were performed using a 5-bp/bead model, Figure 5A and Supplementary Animation 9. The angle between the two arms was extracted at each frame of the simulation trajectory, providing the distribution of the angles between the two arms, Figure 5B. Substantial overlap between the mrdna-generated and experimentally measured distributions was observed, though the mrdna distribution is skewed toward more acute angles.

Figure 5.

Figure 5.

Mrdna simulation of dynamic DNA origami nanostructures. (A) Molecular graphics representation of a DNA origami caliper designed by the Dietz group for measuring inter-nucleosome forces (58). (B) The angle α between the two arms of the caliper in three 5-bp/bead mrdna simulations, starting with the initial angle of 0, 45 or 90°. The caliper angle was computed as the angle between the axes of the arms of the caliper as determined by single-value decomposition (58). Histograms show the distribution of the simulated angles alongside the distribution extracted from the TEM images (58). (C and D) Molecular graphics representation (C) and TEM image (D) of a DNA slider nanostructure designed and characterized by the Castro group (60), reproduced with permission from Ref. 60. (E) The distance between the bearing and the base of the nanostructure during a 5-bp/bead mrdna simulation. Histograms show the distribution of the simulated distances alongside the distribution extracted from the TEM images (60). (F and G) Angle distributions of a Bennett linkage nanostructure designed by the Castro group (62) in 5-bp/bead mrdna simulations. The distributions observed in simulations are plotted alongside the corresponding distributions extracted from single-particle reconstructions of the linkages (63).

The slider origami nanostructure designed by the Castro group (60) was simulated next for 500 μs (5 bp/bead; 2.5 billion steps), Figure 5C and D and Supplementary Animation 10. The slider consists of a large base affixed to a six-helix bundle shaft that threads through a movable bearing, which is tethered on opposite ends to the base and to the tip of the shaft by a total of twelve flexible linkers. While the bearing was seen to dwell ∼5 nm further from the base structure in mrdna simulations with a more narrow distribution than observed experimentally, the position of the bearing is overall in qualitative agreement, Figure 5E. Interestingly, a similar discrepancy was observed for a similar slider design when it was simulated for a very long time using the oxDNA model (61). The simulations using the mrdna framework could be performed quickly and lasted for about 2 days.

At last, we performed simulations (four 700-µs simulations, 3.5 billion steps each) of the DNA origami Bennett linkage designed by the Castro group (62) and imaged using electron tomography (63), Figure 5F and Supplementary Animation 11. Using the 5-bp/bead model, we were able to sample the full range of motion of the Bennett linkage, revealing stochastic transitions between planar and compact configurations. Distributions for the large and small angles (α and β, respectively) between adjacent arms and for the large and small dihedral angles (θ and ϕ, respectively) between the planes formed by adjacent arms were calculated following the overall approach described by the Ren group (63). Briefly, at each frame of the CG simulation trajectory, the axis of each arm was determined using single-value decomposition. The angles between the arm axes directly provided α and β. Cross products between the axes of adjacent arms provided normal vectors for the plane formed by the two arms, allowing the dihedral angles θ and ϕ to be computed from the angle between the normal vectors. The resulting distributions are in approximate agreement with distributions experimentally obtained by the Ren group, Figure 5G. The discrepancies between experiment and simulation could be due to incomplete parameterization of the ssDNA part of the design, a lack of twist–bend and twist–stretch coupling in the model, the use of an isotropic bending modulus, or possibly due to a lack of defects such as fraying or partial melting of the Holliday junctions. Nevertheless, our simulation method can be used to quickly study the structural fluctuations of dynamic DNA nanostructures, providing rapid feedback about the mechanics of a design in place of challenging experimental characterization.

Support for lattice-free DNA nanostructures

The mrdna framework can be used to simulate self-assembled DNA nanostructures produced by lattice-free approaches. The same set of commands that are used to construct the spline/bead-based models of cadnano designs can introduce new types of connections between DNA regions, extending the application of the mrdna framework to other kinds of DNA nanostructures. For example, the mrdna package already includes a code that constructs a multi-resolution model from lists of base pairs, dinucleotide stacks and backbone connections for all the nucleotides in a system. We used that code to simulate a variety of wireframe DNA nanostructures (16) starting directly from their vHelix Maya designs. The resulting CG MD trajectories characterized the amount of structural fluctuations in the designs and produced representative ensembles of equilibrated all-atom structures, Figure 6AC. The results of our mrdna simulations of the vHelix objects showed that the overall geometry of each structure was preserved despite relaxation of the DNA.

Figure 6.

Figure 6.

Mrdna simulations of DNA nanostructures designed using programs other than cadnano. (AC) Structural relaxation of vHelix nanostructures starting from the vHelix maya files obtained from the Högberg group (16). From top-to-bottom, the panels show the configurations of nanostructures prior to the low-resolution CG simulation, the resulting atomistic model and an experimentally obtained TEM image, reproduced with permission from Ref. 16. (DG) Structural relaxation of nanostructures using all-atom PDB models as input for mrdna. The all-atom PDBs of a box (23) (D and E), hemisphere (57) (F) and tetrahedron (17) (G) were obtained from Nanoengineer-1 (65), CanDo (30,57) (original design from cadnano) and DAEDALUS (17). From top-to-bottom, the panels show the configurations of nanostructures prior to the low-resolution CG simulation, the resulting atomistic model and an experimentally obtained TEM image or reconstruction. The box TEM image is reproduced with permission from Ref. 23. Copyright 2012 American Chemical Society. The hemisphere TEM image is reproduced from Ref. 57 with permission from AAAS. The tetrahedron reconstruction is reproduced from Ref. 17 with permission from AAAS.

The mrdna framework also includes an algorithm to automatically identify all backbone connections, base pairs and dinucleotide stacks in an all-atom representation of a DNA nanostructure formatted as a PDB file. This PDB reader module can import the output of many tools that export PDBs, including CanDo (30), Nucleic Acid Builder (64), oxDNA (39,40) (via the convert_to_atomic.py script distributed with oxDNA), Nanoengineer-1 (65) (via our nanoengineer2pdb web service http://bionano.physics.illinois.edu/nanoengineer2pdb), DAEDALUS (17) and Tiamat (66), to automatically generate a corresponding mrdna model. We demonstrate this capability here by relaxing several DNA nanostructures using all-atom PDBs from various sources as inputs, Figure 6DG. The mrdna simulations demonstrated substantial relaxation of the designs away from their idealized initial geometries, with the corresponding final atomistic models having an average RMSD of 24 Å compared to the initial structures. The ability of the mrdna framework to read PDB files immediately allows interfacing with a wide array of design and simulation tools, but not all PDB structures are interpreted perfectly by the framework because base pairs or stacks may be assigned incorrectly. Hence, users are cautioned to carefully examine their resulting models to ensure proper conversion and, where possible, use an original design file as the input source for mrdna.

The atomic configuration resulting from the mrdna simulations could be used to inform design modifications or to perform further refinement of the structure using ENRG-MD (32) implicit solvent simulations or explicit solvent all-atom simulations. Moreover, the mrdna framework can generate all files needed to perform additional relaxation using the oxDNA model. When invoked, mrdna will write sequence-specific oxDNA2 (67) topology and configuration files and an input file that prescribes 1000 steps of minimization to relax the long bonds that are likely to be present in the model, and it will call oxDNA using these files. Then, mrdna writes a second input file for additional relaxation using an MD integrator, again calling oxDNA to run the simulation.

Integration with continuum models

DNA nanostructures are usually designed to operate in the environment of a biological system or in the context of a nanotechnological device. In either case, it is useful to be able to couple a model of a DNA nanostructure to other models because a DNA object’s conformation and function can both be influenced by its environment.

The mrdna framework uses ARBD (47), a GPU-accelerated biomolecular simulation engine, which supports mixed models of point particles and rigid body objects as well as 3D grid potentials. Hence, configuration files written by the mrdna framework can be manually edited to include interactions with additional entities (e.g. cellular proteins or small molecules) that are not described by the package. The scripting interface for the mrdna framework already exposes commands for applying grid-based potentials to DNA nanostructures, allowing one to exert effective forces extracted from continuum models to, for example, simulate DNA nanostructures under the influence of spatially varying electric or plasmonic optical fields (68).

We demonstrate this capability here by simulating the capture of a DNA nanostructure in a nanopipette, Figure 7 and Supplementary Animation 12. The spatial distribution of the electrostatic potential near the pipette under a 300-mV applied bias was obtained using the Comsol continuum model, as described previously (20). The potential was applied to each bead in the system with a weight proportional to the number of nucleotides represented by the bead. In our mrdna simulation, we observe one leg of the DNA nanostructure to be captured initially, followed by a collapse of the wireframe mesh, which allowed the object to pass fully through the aperture of the pipette. While the above simulation is just an illustrative example, we have previously used similar multiscale/multiphysics simulations to obtain a quantitatively correct description of the voltage-dependent deformation of a DNA nanostructure subject to applied electric field of various magnitudes (20). We expect the combination of particle-based simulations with continuum modeling to bring much anticipated advances in the field of plasmonic DNA nanostructures, DNA nanostructures that respond to fluid flow and, eventually, modeling DNA nanostructures in the crowded environment of a biological cell.

Figure 7.

Figure 7.

Coupling continuum models with mrdna simulations. (A) Initial configuration of a simulation system consisting of a vHelix-designed nanostructure (16) near a glass nanopipette under a 300 mV applied bias. The electric potential distribution in and around the pipette was obtained using Comsol as previously reported (20). The electric potential and a steric grid potential representing the presence of the nanopipette are incorporated in the mrdna model as external potentials. (B) Mrdna simulation of the DNA nanostructure capture by a nanopipette. From left to right, snapshots depict the configuration of the system during a 500-ns 5-bp/bead CG simulation.

DISCUSSION

We have presented an automated workflow for the prediction of the in situ structure and conformational dynamics of self-assembled DNA objects. Uniquely, our multi-resolution approach enables fast relaxation of an initial structural model through low-resolution CG simulations, progressive refinement of the structural models through finer-resolution CG simulations and, ultimately, provides a fully atomistic representation of the object’s in situ structure. In comparison to existing computational models of self-assembled DNA nanostructures, our multi-resolution approach is computationally much more efficient, providing relaxed, fully atomistic models of typical 3D DNA origami nanostructures within 30 minutes or less. The quantitative accuracy of the resulting structural model allows the mrdna framework to be used routinely for DNA nanostructure design and prototyping, replacing labor- and time-consuming cryo-EM reconstruction.

By taking into account non-trivial environmental conditions, such as variable ionic strength, applied electric field, non-homogeneous temperature and optical intensity, the framework enables computational study of, not only the structural, but also the functional aspects of the nanostructure designs. The speed of the model also makes it well-suited for the study of structural fluctuations, although slight differences between simulated and experimentally-obtained angle and distance distributions were noted. We speculate that these are caused by small deficiencies in the model, such as the simple polymer description of ssDNA, the treatment of ssDNA–dsDNA junctions and the lack of twist–stretch and twist–bend coupling. The availability of an ensemble of experiments probing the configurational space explored by such nanostructures will prove valuable in future refinements of the model.

The mrdna framework is distributed as an open source Python package (https://gitlab.engr.illinois.edu/tbgl/tools/mrdna), enabling future customization of the algorithms by the end users. A command-line interface allows simulations to be performed and customized with a few keystrokes. The package provides additional capabilities to the users through simple Python scripting, such as the application of geometric transformations to parts of a DNA nanostructure, interfacing with continuum models through 3D grid-specified potentials, and generating or modulating DNA nanostructures algorithmically. A step-by-step guide to using mrdna is available (https://gitlab.engr.illinois.edu/tbgl/tutorials/multi-resolution-dna-nanostructures).

Immediate future developments of the mrdna framework will focus on improving the description of ssDNA–dsDNA junctions, dsDNA nicks and end-stacking interactions. The physical realism of the model will be further enhanced by supplementing the mrdna framework with CG models that explicitly account for the sequence-dependence of DNA elasticity and the possibility of DNA hybridization and dehybridization reactions. Complementing development of ARBD, the framework will be extended to incorporate grid- and particle-based models of proteins and inorganic nanostructures. At last, our multi-resolution simulation framework may be integrated with other DNA nanostructure design and visualization tools to provide near realtime feedback to the designer.

Supplementary Material

gkaa200_Supplemental_Files

ACKNOWLEDGEMENTS

The authors gladly acknowledge supercomputer time provided through XSEDE Allocation Grant MCA05S028, the Blue Waters supercomputer system (UIUC) and the Frontera supercomputer (TACC). The authors thank Shawn Douglas, Hendrik Dietz, Björn Högberg, Tim Liedl and many other practitioners of the structural DNA nanotechnology field for their valuable feedback on the pre-released version of the mrdna framework. A.A. thanks Dongran Han for sharing a cadnano design of the DNA flask. C.M. thanks Carlos Castro for sharing cadnano designs of the slider and Bennet linkage structures. C.M. thanks Hendrik Dietz and Klaus Wagenbauer for sharing cadnano designs of the v-brick, connector block, triangular vertex and caliper structures. C.M. thanks Will Kaufhold for his help debugging the vHelix importer and Chao-Min Huang for adding MagicDNA support for mrdna.

SUPPLEMENTARY DATA

Supplementary Data are available at NAR Online.

FUNDING

National Science Foundation [OAC-1740212, DMR-1827346]; National Institutes of Health [P41-GM104601]. Funding for open access charge: National Science Foundation [DMR-1827346].

Conflict of interest statement. None declared.

REFERENCES

  • 1. Seeman N.C. Nucleic acid junctions and lattices. J. Theor. Biol. 1982; 99:237–247. [DOI] [PubMed] [Google Scholar]
  • 2. Yan H., Park S.H., Finkelstein G., Reif J.H., LaBean T.H.. DNA-templated self-assembly of protein arrays and highly conductive nanowires. Science. 2003; 301:1882–1884. [DOI] [PubMed] [Google Scholar]
  • 3. Lin C., Liu Y., Rinker S., Yan H.. DNA tile based self-assembly: building complex nanoarchitectures. Chemphyschem. 2006; 7:1641–1647. [DOI] [PubMed] [Google Scholar]
  • 4. Rothemund P.W.K. Folding DNA to create nanoscale shapes and patterns. Nature. 2006; 440:297–302. [DOI] [PubMed] [Google Scholar]
  • 5. Douglas S.M., Dietz H., Liedl T., Högberg B., Graf F., Shih W.M.. Self-assembly of DNA into nanoscale three-dimensional shapes. Nature. 2009; 459:414–418. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6. Seeman N.C. Nanomaterials based on DNA. Annu. Rev. Biochem. 2010; 79:65–87. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7. Pinheiro A.V., Han D., Shih W.M., Yan H.. Challenges and opportunities for structural DNA nanotechnology. Nat. Nanotech. 2011; 6:763–772. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8. Seeman N.C., Sleiman H.F.. DNA nanotechnology. Nat. Rev. Mater. 2017; 3:17068–17090. [Google Scholar]
  • 9. Chen J.H., Seeman N.C.. Synthesis from DNA of a molecule with the connectivity of a cube. Nature. 1991; 350:631–633. [DOI] [PubMed] [Google Scholar]
  • 10. Fu T.J., Seeman N.C.. DNA double-crossover molecules. Biochemistry. 1993; 32:3211–3220. [DOI] [PubMed] [Google Scholar]
  • 11. Winfree E., Liu F., Wenzler L.A., Seeman N.C.. Design and self-assembly of two-dimensional DNA crystals. Nature. 1998; 394:539–544. [DOI] [PubMed] [Google Scholar]
  • 12. Mao C., Sun W., Seeman N.C.. Designed two-dimensional DNA holliday junction arrays visualized by atomic force microscopy. J. Am. Chem. Soc. 1999; 121:5437–5443. [Google Scholar]
  • 13. Shih W.M., Quispe J.D., Joyce G.F.. A 1.7-kilobase single-stranded DNA that folds into a nanoscale octahedron. Nature. 2004; 427:618–621. [DOI] [PubMed] [Google Scholar]
  • 14. Seeman N.C. Structural DNA nanotechnology: an overview. Mol. Microbiol. 2005; 303:143–166. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15. Ke Y., Ong L.L., Shih W.M., Yin P.. Three-dimensional structures self-assembled from DNA bricks. Science. 2012; 338:1177–1183. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16. Benson E., Mohammed A., Gardell J., Masich S., Czeizler E., Orponen P., Högberg B.. DNA rendering of polyhedral meshes at the nanoscale. Nature. 2015; 523:441–444. [DOI] [PubMed] [Google Scholar]
  • 17. Veneziano R., Ratanalert S., Zhang K., Zhang F., Yan H., Chiu W., Bathe M.. Designer nanoscale DNA assemblies programmed from the top down. Science. 2016; 352:1534–1534. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18. Maye M.M., Kumara M.T., Nykypanchuk D., Sherman W.B., Gang O.. Switching binary states of nanoparticle superlattices and dimer clusters by DNA strands. Nat. Nanotech. 2010; 5:116–120. [DOI] [PubMed] [Google Scholar]
  • 19. Modi S., Swetha M., Goswami D., Gupta G.D., Mayor S., Krishnan Y.. A DNA nanomachine that maps spatial and temporal pH changes inside living cells. Nat. Nanotech. 2009; 4:325–330. [DOI] [PubMed] [Google Scholar]
  • 20. Hemmig E., Fitzgerald C., Maffeo C., Hecker L., Ochmann S., Aksimentiev A., Tinnefeld P., Keyser U.. Optical voltage sensing using DNA origami. Nano Lett. 2018; 18:1962–1971. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21. Funke J.J., Ketterer P., Lieleg C., Schunter S., Korber P., Dietz H.. Uncovering the forces between nucleosomes using DNA origami. Sci. Adv. 2016; 2:e1600974. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22. Andersen E.S., Dong M., Nielsen M.M., Jahn K., Subramani R., Mamdouh W., Golas M.M., Sander B., Stark H., Oliveira C. et al.. Self-assembly of a nanoscale DNA box with a controllable lid. Nature. 2009; 459:73–76. [DOI] [PubMed] [Google Scholar]
  • 23. Zadegan R.M., Jepsen M.D.E., Thomsen K.E., Okholm A.H., Schaffert D.H., Andersen E.S., Birkedal V., Kjems J.. Construction of a 4 zeptoliters switchable 3D DNA box origami. ACS Nano. 2012; 6:10050–10053. [DOI] [PubMed] [Google Scholar]
  • 24. Kang S.H., Hwang W.S., Lin Z., Kwon S.H., Hong S.W.. A robust highly aligned DNA nanowire array-enabled lithography for graphene nanoribbon transistors. Nano Lett. 2015; 15:7913–7920. [DOI] [PubMed] [Google Scholar]
  • 25. Du K., Park M., Ding J., Hu H., Zhang Z.. Sub-10nm patterning with DNA nanostructures: a short perspective. Nanotech. 2017; 28:442501–442509. [DOI] [PubMed] [Google Scholar]
  • 26. Gopinath A., Miyazono E., Faraon A., Rothemund P.W.. Engineering and mapping nanocavity emission via precision placement of DNA origami. Nature. 2016; 535:401–405. [DOI] [PubMed] [Google Scholar]
  • 27. Kühler P., Roller E.M., Schreiber R., Liedl T., Lohmüller T., Feldmann J.. Plasmonic DNA-origami nanoantennas for surface-enhanced raman spectroscopy. Nano Lett. 2014; 14:2914–2919. [DOI] [PubMed] [Google Scholar]
  • 28. Wagenbauer K.F., Sigl C., Dietz H.. Gigadalton-scale shape-programmable DNA assemblies. Nature. 2017; 552:78–83. [DOI] [PubMed] [Google Scholar]
  • 29. Ong L.L., Hanikel N., Yaghi O.K., Grun C., Strauss M.T., Bron P., Lai-Kee-Him J., Schueder F., Wang B., Wang P. et al.. Programmable self-assembly of three-dimensional nanostructures from 10,000 unique components. Nature. 2017; 552:72–77. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30. Kim D.-N., Kilchherr F., Dietz H., Bathe M.. Quantitative prediction of 3D solution shape and flexibility of nucleic acid nanostructures. Nucleic Acids Res. 2011; 40:2862–2868. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31. Yoo J., Aksimentiev A.. In situ structure and dynamics of DNA origami determined through molecular dynamics simulations. Proc. Natl. Acad. Sci. U.S.A. 2013; 110:20099–20104. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32. Maffeo C., Yoo J., Aksimentiev A.. De novo prediction of DNA origami structures through atomistic molecular dynamics simulation. Nucleic Acids Res. 2016; 44:3013–3019. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33. Slone S., Li C.-Y., Yoo J., Aksimentiev A.. Molecular mechanics of DNA bricks: in situ structure, mechanical properties and ionic conductivity. New J. Phys. 2016; 18:055012–055022. [Google Scholar]
  • 34. Li C.-Y., Hemmig E.A., Kong J., Yoo J., Hernández-Ainsa S., Keyser U.F., Aksimentiev A.. Ionic conductivity, structural deformation, and programmable anisotropy of dna origami in electric field. ACS Nano. 2015; 9:1420–1433. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35. Göpfrich K., Li C.-Y., Mames I., Bhamidimarri S.P., Ricci M., Yoo J., Mames A., Ohmann A., Winterhalter M., Stulz E. et al.. Ion channels made from a single membrane-spanning DNA duplex. Nano Lett. 2016; 16:4665–4669. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36. Göpfrich K., Li C.-Y., Ricci M., Bhamidimarri S.P., Yoo J., Gyenes B., Ohmann A., Winterhalter M., Aksimentiev A., Keyser U.F.. Large-conductance transmembrane porin made from DNA origami. ACS Nano. 2016; 10:8207–8214. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37. Ohmann A., Li C.-Y., Maffeo C., Al-Nahas K., Baumann K.N.B., Keyser U.F., Aksimentiev A.. A synthetic enzyme built from DNA flips 107 lipids per second in biological membranes. Nat. Commun. 2018; 9:2426–2434. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38. Hinckley D.M., Freeman G.S., Whitmer J.K., de Pablo J.J.. An experimentally-informed coarse-grained 3-site-per-nucleotide model of DNA: Structure, thermodynamics, and dynamics of hybridization. J. Chem. Phys. 2013; 139:144903–144917. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39. Ouldridge T.E., Louis A.A., Doye J.P.K.. Structural, mechanical, and thermodynamic properties of a coarse-grained DNA model. J. Chem. Phys. 2011; 134:085101–085122. [DOI] [PubMed] [Google Scholar]
  • 40. Šulc P., Romano F., Ouldridge T.E., Rovigatti L., Doye J.P.K., Louis A.A.. Sequence-dependent thermodynamics of a coarse-grained DNA model. J. Chem. Phys. 2012; 137:135101–135114. [DOI] [PubMed] [Google Scholar]
  • 41. Uusitalo J.J., Ingólfsson H.I., Akhshi P., Tieleman D.P., Marrink S.J.. Martini coarse-grained force field: extension to DNA. J. Chem. Theory Comput. 2015; 11:3932–3945. [DOI] [PubMed] [Google Scholar]
  • 42. Snodin B., Romano F., Rovigatti L., Ouldridge T., Louis A., Doye J.. Direct simulation of the self-assembly of a small DNA origami. ACS Nano. 2016; 10:1724–1737. [DOI] [PubMed] [Google Scholar]
  • 43. Reshetnikov R.V., Stolyarova A.V., Zalevsky A.O., Panteleev D.Y., Pavlova G.V., Klinov D.V., Golovin A.V., Protopopova A.D.. A coarse-grained model for DNA origami. Nucleic Acids Res. 2017; 46:1102–1112. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44. Snodin B.E.K., Schreck J.S., Romano F., Louis A.A., Doye J.P.K.. Coarse-grained modelling of the structural properties of DNA origami. Nucleic Acids Res. 2019; 47:1585–1597. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 45. Douglas S.M., Marblestone A.H., Teerapittayanon S., Vazquez A., Church G.M., Shih W.M.. Rapid prototyping of 3D DNA-origami shapes with caDNAno. Nucleic Acids Res. 2009; 37:5001–5006. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 46. Huang C.-M., Kucinic A., Le J.V., Castro C.E., Su H.-J.. Uncertainty quantification of a DNA origami mechanism using a coarse-grained model and kinematic variance analysis. Nanoscale. 2019; 11:1647–1660. [DOI] [PubMed] [Google Scholar]
  • 47. Comer J., Aksimentiev A.. Predicting the DNA sequence dependence of nanopore ion current using atomic-resolution Brownian dynamics. J. Phys. Chem. C. 2012; 116:3376–3393. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48. Rau D.C., Lee B., Parsegian V.A.. Measurement of the repulsive force between polyelectrolyte molecules in ionic solution: Hydration forces between parallel DNA double helices. Proc. Natl. Acad. Sci. U.S.A. 1984; 81:2621–2625. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 49. Cocco S., Marko J.F., Monasson R.. Theoretical models for single-molecule DNA and RNA experiments: from elasticity to unzipping. Comptes Rendus Physique. 2002; 3:569–584. [Google Scholar]
  • 50. Mosconi F., Allemand J.F., Bensimon D., Croquette V.. Measurement of the torque on a single stretched and twisted DNA using magnetic tweezers. Phys. Rev. Lett. 2009; 102:078301–078304. [DOI] [PubMed] [Google Scholar]
  • 51. Lilley D.M., Clegg R.M.. The structure of the four-way junction in DNA. Annu. Rev. Biophys. Biomol. Struct. 1993; 22:299–328. [DOI] [PubMed] [Google Scholar]
  • 52. Bai X.-C.C., Martin T.G., Scheres S.H.W., Dietz H.. Cryo-EM structure of a 3D DNA-origami object. Proc. Natl. Acad. Sci. U.S.A. 2012; 109:20012–20017. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 53. Han D., Pal S., Yang Y., Jiang S., Nangreave J., Liu Y., Yan H.. DNA gridiron nanostructures based on four-arm junctions. Science. 2013; 339:1412–1415. [DOI] [PubMed] [Google Scholar]
  • 54. Humphrey W., Dalke A., Schulten K.. VMD: Visual molecular dynamics. J. Mol. Graph. 1996; 14:33–38. [DOI] [PubMed] [Google Scholar]
  • 55. Trabuco L.G., Villa E., Mitra K., Frank J., Schulten K.. Flexible fitting of atomic structures into electron microscopy maps using molecular dynamics. Structure. 2008; 16:673–683. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 56. Dietz H., Douglas S.M., Shih W.M.. Folding DNA into twisted and curved nanoscale shapes. Science. 2009; 325:725–730. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 57. Han D., Pal S., Nangreave J., Deng Z., Liu Y., Yan H.. DNA origami with complex curvatures in three-dimensional space. Science. 2011; 332:342–346. [DOI] [PubMed] [Google Scholar]
  • 58. Funke J.J., Ketterer P., Lieleg C., Korber P., Dietz H.. Exploring nucleosome unwrapping using DNA origami. Nano Lett. 2016; 16:7891–7898. [DOI] [PubMed] [Google Scholar]
  • 59. Le J.V., Luo Y., Darcy M.A., Lucas C.R., Goodwin M.F., Poirier M.G., Castro C.E.. Probing nucleosome stability with a DNA origami nanocaliper. ACS Nano. 2016; 10:7073–7084. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 60. Marras A., Zhou L., Kolliopoulos V., Su H., Castro C.. Directing folding pathways for multi-component DNA origami nanostructures with complex topology. New J. Phys. 2016; 18:055005–055013. [Google Scholar]
  • 61. Sharma R., Schreck J.S., Romano F., Louis A.A., Doye J.P.K.. Characterizing the motion of jointed DNA nanostructures using a coarse-grained model. ACS Nano. 2017; 11:12426–12435. [DOI] [PubMed] [Google Scholar]
  • 62. Marras A.E., Zhou L., Su H.-J., Castro C.E.. Programmable motion of DNA origami mechanisms. Proc. Natl. Acad. Sci. U.S.A. 2015; 112:713–718. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 63. Lei D., Marras A.E., Liu J., Huang C.-M., Zhou L., Castro C.E., Su H.-J., Ren G.. Three-dimensional structural dynamics of DNA origami Bennett linkages using individual-particle electron tomography. Nat. Commun. 2018; 9:592–600. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 64. MacKerell A.D. Jr, Bashford D., Bellott M., Dunbrack R.L. Jr., Evanseck J.D., Field M.J., Fischer S., Gao J., Guo H., Ha S. et al.. All-atom empirical potential for molecular modeling and dynamics studies of proteins. J. Phys. Chem. B. 1998; 102:3586–3616. [DOI] [PubMed] [Google Scholar]
  • 65. Nanorex, Inc. 2006; Nanoengineer-1, v.a8.
  • 66. Williams S., Lund K., Lin C., Wonka P., Lindsay S., Yan H.. Goel A, Simmel FC, Sosík P. Tiamat: a three-dimensional editing tool for complex DNA structures. DNA Computing, volume 5347 of Lecture Notes in Computer Science. 2009; Berlin, Heidelberg: Springer; 90–101. [Google Scholar]
  • 67. Snodin B.E., Randisi F., Mosayebi M., Šulc P., Schreck J.S., Romano F., Ouldridge T.E., Tsukanov R., Nir E., Louis A.A. et al.. Introducing improved structural properties and salt dependence into a coarse-grained model of DNA. J. Chem. Phys. 2015; 142:234901–234912. [DOI] [PubMed] [Google Scholar]
  • 68. Belkin M., Chao S.-H., Jonsson M.P., Dekker C., Aksimentiev A.. Plasmonic nanopores for trapping, controlling displacement, and sequencing of DNA. ACS Nano. 2015; 9:10598–10611. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

gkaa200_Supplemental_Files

Articles from Nucleic Acids Research are provided here courtesy of Oxford University Press

RESOURCES