Está en la página 1de 5

Periodic boundary conditions - Wikipedia https://en.wikipedia.

org/wiki/Periodic_boundary_conditions

Periodic boundary conditions


Periodic boundary conditions (PBCs) are a set of boundary conditions
which are often chosen for approximating a large (infinite) system by using
a small part called a unit cell. PBCs are often used in computer simulations
and mathematical models. The topology of two-dimensional PBC is equal to
that of a world map of some video games; the geometry of the unit cell
satisfies perfect two-dimensional tiling, and when an object passes through
one side of the unit cell, it re-appears on the opposite side with the same
velocity. In topological terms, the space made by two-dimensional PBCs
can be thought of as being mapped onto a torus (compactification). The
large systems approximated by PBCs consist of an infinite number of unit
cells. In computer simulations, one of these is the original simulation box,
and others are copies called images. During the simulation, only the Periodic boundary conditions in 2D
properties of the original simulation box need to be recorded and
propagated. The minimum-image convention is a common form of PBC
particle bookkeeping in which each individual particle in the simulation interacts with the closest image of the
remaining particles in the system.

One example of periodic boundary conditions can be defined according to smooth real functions by

for all m = 0, 1, 2, ... and for constants and .

In molecular dynamics simulation, PBC are usually applied to calculate bulk gasses, liquids, crystals or mixtures. A
common application uses PBC to simulate solvated macromolecules in a bath of explicit solvent. Born-von Karman
boundary conditions are periodic boundary conditions for a special system.

Contents
1 PBC requirements and artifacts
2 Practical implementation: continuity and the minimum image convention
2.1 (A) Restrict particle coordinates to the simulation box

1 of 5 11/28/2017, 8:32 AM
Periodic boundary conditions - Wikipedia https://en.wikipedia.org/wiki/Periodic_boundary_conditions

2.2 (B) Do not restrict the particle coordinates

3 Unit cell geometries


4 Conserved properties
5 See also
6 Notes
7 References

PBC requirements and artifacts


Three-dimensional PBCs are useful for approximating the behavior of macro-scale systems of gases, liquids, and solids.
Three-dimensional PBCs can also be used to simulate planar surfaces, in which case two-dimensional PBCs are often
more suitable. Two-dimensional PBCs for planar surfaces are also called slab boundary conditions; in this case, PBCs
are used for two Cartesian coordinates (e.g., x and y), and the third coordinate (z) extends to infinity.

PBCs can be used in conjunction with Ewald summation methods (e.g., the particle mesh Ewald method) to calculate
electrostatic forces in the system. However, PBCs also introduce correlational artifacts that do not respect the
translational invariance of the system,[1] and requires constraints on the composition and size of the simulation box.

In simulations of solid systems, the strain field arising from any inhomogeneity in the system will be artificially
truncated and modified by the periodic boundary. Similarly, the wavelength of sound or shock waves and phonons in
the system is limited by the box size.

In simulations containing ionic (Coulomb) interactions, the net electrostatic charge of the system must be zero to avoid
summing to an infinite charge when PBCs are applied. In some applications it is appropriate to obtain neutrality by
adding ions such as sodium or chloride (as counterions) in appropriate numbers if the molecules of interest are
charged. Sometimes ions are even added to a system in which the molecules of interest are neutral, to approximate the
ionic strength of the solution in which the molecules naturally appear. Maintenance of the minimum-image convention
also generally requires that a spherical cutoff radius for nonbonded forces be at most half the length of one side of a
cubic box. Even in electrostatically neutral systems, a net dipole moment of the unit cell can introduce a spurious bulk-
surface energy, equivalent to pyroelectricity in polar crystals.

The size of the simulation box must also be large enough to prevent periodic artifacts from occurring due to the
unphysical topology of the simulation. In a box that is too small, a macromolecule may interact with its own image in a
neighboring box, which is functionally equivalent to a molecule's "head" interacting with its own "tail". This produces
highly unphysical dynamics in most macromolecules, although the magnitude of the consequences and thus the
appropriate box size relative to the size of the macromolecules depends on the intended length of the simulation, the
desired accuracy, and the anticipated dynamics. For example, simulations of protein folding that begin from the native
state may undergo smaller fluctuations, and therefore may not require as large a box, as simulations that begin from a
random coil conformation. However, the effects of solvation shells on the observed dynamics in simulation or in
experiment are not well understood. A common recommendation based on simulations of DNA is to require at least
1 nm of solvent around the molecules of interest in every dimension.[2]

Practical implementation: continuity and the minimum

2 of 5 11/28/2017, 8:32 AM
Periodic boundary conditions - Wikipedia https://en.wikipedia.org/wiki/Periodic_boundary_conditions

image convention
An object which has passed through one face of the simulation box should re-enter through the opposite faceor its
image should do it. Evidently, a strategic decision must be made: Do we (A) fold back particles into the simulation
box when they leave it, or do we (B) let them go on (but compute interactions with the nearest images)? The decision
has no effect on the course of the simulation, but if the user is interested in mean displacements, diffusion lengths, etc.,
the second option is preferable.

(A) Restrict particle coordinates to the simulation box


To implement a PBC algorithm, at least two steps are needed.

Restricting the coordinates is a simple operation which can be described with the following code, where x_size is the
length of the box in one direction (assuming an orthogonal unit cell centered on the origin) and x is the position of the
particle in the same direction:

if (periodic_x) then
if (x < -x_size * 0.5) x = x + x_size
if (x >= x_size * 0.5) x = x - x_size
end if

Distance and vector between objects should obey the minimum image criterion. This can be implemented according to
the following code (in the case of a one-dimensional system where dx is the distance direction vector from object i to
object j):

if (periodic_x) then
dx = x(j) - x(i)
if (dx > x_size * 0.5) dx = dx - x_size
if (dx <= -x_size * 0.5) dx = dx + x_size
endif

For three-dimensional PBCs, both operations should be repeated in all 3 dimensions.

These operations can be written in a much more compact form for orthorhombic cells if the origin is shifted to a corner
of the box. Then we have, in one dimension, for positions and distances respectively:

! After x(i) update without regard to PBC:


x(i) = x(i) - floor(x(i) / x_size) * x_size ! For a box with the origin at the lower left vertex
! Works for x's lying in any image.
dx = x(j) - x(i)
dx = dx - nint(dx / x_size) * x_size

(B) Do not restrict the particle coordinates


Assuming an orthorhombic simulation box with the origin at the lower left forward corner, the minimum image
convention for the calculation of effective particle distances can be calculated with the nearest integer function as
shown above, here as C/C++ code:

x_rsize = 1.0 / x_size; // compute only when box size is set or changed

dx = x[j] - x[i];

3 of 5 11/28/2017, 8:32 AM
Periodic boundary conditions - Wikipedia https://en.wikipedia.org/wiki/Periodic_boundary_conditions

dx -= x_size * nearbyint(dx * x_rsize);

The fastest way of carrying out this operation depends on the processor architecture. If the sign of dx is not relevant,
the method

dx = fabs(dx);
dx -= static_cast<int>(dx * x_rsize + 0.5) * x_size;

was found to be fastest on x86-64 processors in 2013.[3]

For non-orthorhombic cells the situation is more complicated.[4]

In simulations of ionic systems more complicated operations may be needed to handle the long-range Coulomb
interactions spanning several box images, for instance Ewald summation.

Unit cell geometries


PBC requires the unit cell to be a shape that will tile perfectly into a three-dimensional crystal. Thus, a spherical or
elliptical droplet cannot be used. A cube or rectangular prism is the most intuitive and common choice, but can be
computationally expensive due to unnecessary amounts of solvent molecules in the corners, distant from the central
macromolecules. A common alternative that requires less volume is the truncated octahedron.

Conserved properties
Under periodic boundary conditions, the linear momentum of the system is conserved, but Angular momentum is not.
Conventional explanation of this fact is based on Noether's theorem, which states that conservation of angular
momentum follows from rotational invariance of Lagrangian. However in a paper [5] it is shown that this approach is
not consistent. It fails to explain the absence of conservation of angular momentum of a single particle moving in a
periodic cell. Lagrangian of the particle is constant and therefore rotationally invariant, while angular momentum of
the particle is not conserved. This contradiction is caused by the fact that Noether's theorem is usually formulated for
closed systems. The periodic cell exchanges mass momentum, angular momentum, and energy with the neighboring
cells.

When applied to the microcanonical ensemble (constant particle number, volume, and energy, abbreviated NVE),
using PBC rather than reflecting walls slightly alters the sampling of the simulation due to the conservation of total
linear momentum and the position of the center of mass; this ensemble has been termed the "molecular dynamics
ensemble"[6] or the NVEPG ensemble.[7] These additional conserved quantities introduce minor artifacts related to the
statistical mechanical definition of temperature, the departure of the velocity distributions from a Boltzmann
distribution, and violations of equipartition for systems containing particles with heterogeneous masses. The simplest
of these effects is that a system of N particles will behave, in the molecular dynamics ensemble, as a system of N-1
particles. These artifacts have quantifiable consequences for small toy systems containing only perfectly hard particles;
they have not been studied in depth for standard biomolecular simulations, but given the size of such systems, the
effects will be largely negligible.[7]

See also
Helical boundary conditions

4 of 5 11/28/2017, 8:32 AM
Periodic boundary conditions - Wikipedia https://en.wikipedia.org/wiki/Periodic_boundary_conditions

Molecular modeling
Software for molecular mechanics modeling

Notes
1. Cheatham TE, Miller JH, Fox T, Darden PA, Kollman PA. (1995). Molecular Dynamics Simulations on Solvated
Biomolecular Systems: The Particle Mesh Ewald Method Leads to Stable Trajectories of DNA, RNA, and Proteins.
J Am Chem Soc 117:4193.
2. de Souza ON, Ornstein RL. (1997). Effect of periodic box size on aqueous molecular dynamics simulation of a
DNA dodecamer with particle-mesh Ewald method. Biophys J 72(6):2395-7. PMID 9168016
(//www.ncbi.nlm.nih.gov/pubmed/9168016)
3. Deiters, Ulrich K. (2013). "Efficient coding of the minimum image convention". Z. Phys. Chem. 227: 345352.
doi:10.1524/zpch.2013.0311 (//doi.org/10.1524%2Fzpch.2013.0311).
4. Minimum image convention in non-cubic simulation cells (http://www.tcm.phy.cam.ac.uk/~mdt26/talks/zoltan
/min_image_slides.ps.gz)
5. Kuzkin V.A. (2014). On angular momentum balance in particle systems with periodic boundary conditions
(http://onlinelibrary.wiley.com/doi/10.1002/zamm.201400045/abstract), ZAMM, 2014, DOI:
10.1002/zamm.201400045. http://arxiv.org/pdf/1312.7008.pdf
6. Erpenbeck JJ, Wood WW. (1977). Statistical Mechanics, Part B: Time-dependent Processes, Modern Theoretical
Chemistry Vol 6. ed. Berne BJ. Plenum, New York, USA. See pp1-40.
7. Shirts RB, Burt SR, Johnson AM. (2006). Periodic boundary condition induced breakdown of the equipartition
principle and other kinetic effects of finite sample size in classical hard-sphere molecular dynamics simulation. J
Chem Phys 125(16):164102. PMID 17092058 (//www.ncbi.nlm.nih.gov/pubmed/17092058)

References
Schlick T. (2002). Molecular Modeling and Simulation: An Interdisciplinary Guide. Interdisciplinary Applied
Mathematics series, vol. 21. Springer: New York, NY, USA. ISBN 0-387-95404-X. See esp. pp2726.
Rapaport DC. (2004). The Art of Molecular Dynamics Simulation. 2nd ed. Cambridge University Press.
ISBN 0-521-82568-7. See esp. pp1520.
Kuzkin V.A. (2014). On angular momentum balance in particle systems with periodic boundary conditions
(http://onlinelibrary.wiley.com/doi/10.1002/zamm.201400045/abstract), ZAMM, 2014, DOI:
10.1002/zamm.201400045.

Retrieved from "https://en.wikipedia.org/w/index.php?title=Periodic_boundary_conditions&oldid=781695769"

This page was last edited on 22 May 2017, at 18:28.

Text is available under the Creative Commons Attribution-ShareAlike License; additional terms may apply. By using
this site, you agree to the Terms of Use and Privacy Policy. Wikipedia is a registered trademark of the Wikimedia
Foundation, Inc., a non-profit organization.

5 of 5 11/28/2017, 8:32 AM

También podría gustarte