Langevin dynamics
In physics, Langevin dynamics is an approach to the mathematical modeling of the dynamics of molecular systems using the Langevin equation. It was originally developed by French physicist Paul Langevin. The approach is characterized by the use of simplified models while accounting for omitted degrees of freedom by the use of stochastic differential equations. Langevin dynamics simulations are a kind of Monte Carlo simulation.[1]
Overview
[edit]Real world molecular systems occur in air or solvents, rather than in isolation, in a vacuum. Jostling of solvent or air molecules causes friction, and the occasional high velocity collision will perturb the system. Langevin dynamics attempts to extend molecular dynamics to allow for these effects. Also, Langevin dynamics allows temperature to be controlled as with a thermostat, thus approximating the canonical ensemble.
Langevin dynamics mimics the viscous aspect of a solvent. It does not fully model an implicit solvent; specifically, the model does not account for the electrostatic screening and also not for the hydrophobic effect. For denser solvents, hydrodynamic interactions are not captured via Langevin dynamics.
For a system of particles with masses , with coordinates that constitute a time-dependent random variable, the resulting Langevin equation is[2][3] where is the particle interaction potential; is the gradient operator such that is the force calculated from the particle interaction potentials; the dot is a time derivative such that is the velocity and is the acceleration; is the damping constant (units of reciprocal time), also known as the collision frequency; is the temperature, is the Boltzmann constant; and is a delta-correlated stationary Gaussian process with zero-mean, called Gaussian white noise, satisfying
Here, is the Dirac delta.
Stochastic Differential Formulation
[edit]Considering the covariance of standard Brownian motion or Wiener process , we can find that
Define the covariance matrix of the derivative as So under the sense of covariance we can say that
Without loss of generality, let the mass , , then the original SDE will become
Overdamped Langevin dynamics
[edit]If the main objective is to control temperature, care should be exercised to use a small damping constant . As grows, it spans from the inertial all the way to the diffusive (Brownian) regime. The Langevin dynamics limit of non-inertia is commonly described as Brownian dynamics. Brownian dynamics can be considered as overdamped Langevin dynamics, i.e. Langevin dynamics where no average acceleration takes place. Under this limit we have , the original SDE then will becomes
The translational Langevin equation can be solved using various numerical methods [4][5] with differences in the sophistication of analytical solutions, the allowed time-steps, time-reversibility (symplectic methods), in the limit of zero friction, etc.
The Langevin equation can be generalized to rotational dynamics of molecules, Brownian particles, etc. A standard (according to NIST[6]) way to do it is to leverage a quaternion-based description of the stochastic rotational motion.[7][8]
Applications
[edit]Langevin thermostat
[edit]Langevin thermostat[9] is a type of Thermostat algorithm in molecular dynamics, which is used to simulate a canonical ensemble (NVT) under a desired temperature. It integrates the following Langevin equation of motion:
is the deterministic force term; is the friction coefficient and is the friction or damping term; the last term is the random force term (: Boltzmann constant, : temperature). This equation allows the system to couple with an imaginary "heat bath": the kinetic energy of the system dissipates from the friction/damping term, and gain from random force/fluctuation; the strength of coupling is controlled by . This equation can be simulated with SDE solvers such as Euler–Maruyama method, where the random force term is replaced by a Gaussian random number in every integration step (variance , : time step), or Langevin Leapfrog integration, etc. This method is also known as Langevin Integrator.[10]
Langevin Monte Carlo
[edit]The overdamped Langevin equation gives
Here, is the diffusion coefficient from Einstein relation. As proven with Fokker-Planck equation, under appropriate conditions, the stationary distribution of is Boltzmann distribution .
Since that , this equation is equivalent to the following form:
And the distribution of follows . In other words, Langevin dynamics drives particles towards a stationary distribution along a gradient flow, due to the term, while still allowing for some random fluctuations. This provides a Markov Chain Monte Carlo method that can be used to sample data from a target distribution , known as Langevin Monte Carlo.
In many applications, we have a desired distribution from which we would like to sample , but direct sampling might be challenging or inefficient. Langevin Monte Carlo offers another way to sample by sampling a Markov chain in accordance with the Langevin dynamics whose stationary state is . The Metropolis-adjusted Langevin algorithm (MALA) is an example : Given a current state , the MALA method proposes a new state using the Langevin dynamics above. The proposal is then accepted or rejected based on the Metropolis-Hastings algorithm. The incorporation of the Langevin dynamics in the choice of provides greater computational efficiency, since the dynamics drive the particles into regions of higher probability and are thus more likely to be accepted. Read more in Metropolis-adjusted Langevin algorithm.
Score-based generative model
[edit]Langevin dynamics is one of the basis of score-based generative models.[11][12] From (overdamped) Langevin dynamics,
A generative model aims to generate samples that follow (unknown data distribution) . To achieve that, a score-based model learns an approximate score function (a process called score matching). With access to a score function, samples are generated by the following iteration,[11][12]
with . As and , the generated converge to the target distribution . Score-based models use as an approximation.[11]
Relation to Other Theories
[edit]Klein-Kramers equation
[edit]As a stochastic differential equation(SDE), Langevin dynamics equation, has its corresponding partial differential equation(PDE), Klein-Kramers equation, a special Fokker–Planck equation that governs the probability distribution of the particles in the phase space. The original Langevin dynamics equation can be reformulated as the following first order SDEs: Now consider the following cases and their law of :
1. with
2. with
Consider a general function of momentum and position
The expectation value of the function will be
Taking derivative with respect to time , and applying Itô's formula, we have which can be simplified to Integration by parts on right hand side, due to vanishing density for infinite momentum or velocity we have This equation holds for arbitrary $\Psi$, so we require the density to satisfy This equation is called the Klein-Kramers equation, a special version of Fokker Planck equation. It's a partial differential equation that describes the evolution of probability density of the system in the phase space.
Fokker Planck equation
[edit]For the overdamped limit, we have , so the evolution of system can be reduced to the position subspace. Following similar logic we can prove that the SDE for position, corresponds to the Fokker Planck equation for probability density
Fluctuation-dissipation theorem
[edit]Consider Langevin dynamics of a free particle (i.e. ), then the equation for momentum will become
the analytical solution to this SDE is
thus the average value of second moment of momentum will becomes (here we apply the Itô isometry) That is, the limiting behavior when time approaches positive infinity, the momentum fluctuation of this system is related to the energy dissipation (friction term parameter ) of this system. Combining this result with Equipartition theorem, which relates the average value of kinetic energy of particles with temperature
we can determines the value of the variance in applications like Langevin thermostat.
This is consistent with the original definition assuming .
Path Integral
[edit]Path Integral Formulation comes from Quantum Mechanics. But for a Langevin SDE we can also induce a corresponding path integral. Considering the following Overdamped Langevin equation under, where without loss of generality we take ,
Discretize and define , we get
Therefore the propagation probability will be Applying Fourier Transform of delta function, and we will get The second part is a Gaussian Integral, which yields Now consider the probability from initial to final . take the limit of ,we will get
See also
[edit]- Hamiltonian mechanics
- Statistical mechanics
- Implicit solvation
- Stochastic differential equations
- Langevin equation
- Langevin Monte Carlo
- Klein–Kramers equation
References
[edit]- ^ Namiki, Mikio (2008-10-04). Stochastic Quantization. Springer Science & Business Media. p. 176. ISBN 978-3-540-47217-9.
- ^ Schlick, Tamar (2002). Molecular Modeling and Simulation. Springer. p. 480. ISBN 0-387-95404-X.
- ^ Pastor, R.W. (1994). "Techniques and Applications of Langevin Dynamics Simulations". In Luckhurst, G.R.; Veracini, C.A. (eds.). The Molecular Dynamics of Liquid Crystals. NATO ASI Series. Vol. 431. Dordrecht: Springer. pp. 85–138. doi:10.1007/978-94-011-1168-3_5. ISBN 978-94-010-4509-4.
- ^ Tanygin, Bogdan; Melchionna, Simone (2024). "Comparison of effective and stable Langevin dynamics integrators". Computer Physics Communications. 299: 109152. arXiv:2304.09030. Bibcode:2024CoPhC.29909152T. doi:10.1016/j.cpc.2024.109152. ISSN 0010-4655.
- ^ Leimkuhler, Benedict; Matthews, Charles (2013). "Robust and efficient configurational molecular sampling via Langevin dynamics". The Journal of Chemical Physics. 138 (17). arXiv:1304.3269. Bibcode:2013JChPh.138q4102L. doi:10.1063/1.4802990. PMID 23656109.
- ^ "Wayback Machine". tsapps.nist.gov.
- ^ Omelyan, Igor P. (1998-01-01). "On the numerical integration of motion for rigid polyatomics: The modified quaternion approach". Computers in Physics. 12 (1): 97–103. arXiv:physics/9901028. Bibcode:1998ComPh..12...97O. doi:10.1063/1.168642. ISSN 0894-1866.
- ^ Groot, Robert D.; Warren, Patrick B. (1997-09-15). "Dissipative particle dynamics: Bridging the gap between atomistic and mesoscopic simulation". The Journal of Chemical Physics. 107 (11): 4423–4435. Bibcode:1997JChPh.107.4423G. doi:10.1063/1.474784. ISSN 0021-9606.
- ^ Allen, Michael P.; Tildesley, Dominic J. (2017-08-15). Computer Simulation of Liquids. Oxford University Press. ISBN 978-0-19-252470-6.
- ^ "21. Integrators — OpenMM User Guide 8.2 documentation". docs.openmm.org. Retrieved 2025-05-12.
- ^ a b c "Generative Modeling by Estimating Gradients of the Data Distribution | Yang Song". yang-song.net. Retrieved 2025-05-12.
- ^ a b Song, Yang; Sohl-Dickstein, Jascha; Kingma, Diederik P.; Kumar, Abhishek; Ermon, Stefano; Poole, Ben (2020). "Score-Based Generative Modeling through Stochastic Differential Equations". arXiv:2011.13456 [cs.LG].