Langevin Dynamics
   HOME

TheInfoList



OR:

In
physics Physics is the scientific study of matter, its Elementary particle, fundamental constituents, its motion and behavior through space and time, and the related entities of energy and force. "Physical science is that department of knowledge whi ...
, 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.


Overview

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 Molecular dynamics (MD) is a computer simulation method for analyzing the Motion (physics), physical movements of atoms and molecules. The atoms and molecules are allowed to interact for a fixed period of time, giving a view of the 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 N particles with masses M, with coordinates X=X(t) that constitute a time-dependent
random variable A random variable (also called random quantity, aleatory variable, or stochastic variable) is a Mathematics, mathematical formalization of a quantity or object which depends on randomness, random events. The term 'random variable' in its mathema ...
, the resulting Langevin equation is M\,\ddot = - \mathbf U(\mathbf) - \gamma\,M\,\dot + \sqrt\,\mathbf(t)\,, where U(\mathbf) is the particle interaction potential; \nabla is the gradient operator such that -\mathbf U(\mathbf) is the force calculated from the particle interaction potentials; the dot is a time derivative such that \dot is the velocity and \ddot is the acceleration; \gamma is the damping constant (units of reciprocal time), also known as the collision frequency; T is the temperature, k_ is the Boltzmann constant; and \mathbf(t) is a delta-correlated stationary Gaussian process with zero-mean, called Gaussian white noise, satisfying \left\langle \mathbf(t) \right\rangle = 0 \left\langle \mathbf(t)\cdot\mathbf(t') \right\rangle = \delta(t - t') Here, \delta is the Dirac delta.


Stochastic Differential Formulation

Considering the covariance of standard Brownian motion or
Wiener process In mathematics, the Wiener process (or Brownian motion, due to its historical connection with Brownian motion, the physical process of the same name) is a real-valued continuous-time stochastic process discovered by Norbert Wiener. It is one o ...
W_t, we can find that \mathbb(W_tW_\tau) = \min(t,\tau) Define the covariance matrix of the derivative as \mathbb(\dot\dot) = \frac\frac\mathbb(W_tW_\tau) = \frac\frac\min(t,\tau) =\delta(t-\tau) So under the sense of covariance we can say that W_t = \mathbf(t)t Without loss of generality, let the mass M = 1, \sigma = \sqrt, then the original SDE will become \dot = -\nabla U(\mathbf)t-\gamma +\sqrt\sigma \mathbf(t)


Overdamped Langevin dynamics

If the main objective is to control temperature, care should be exercised to use a small damping constant \gamma. As \gamma 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 \dot=0, the original SDE then will becomes =-\frac\nabla U(\mathbf)t+\frac \mathbf(t) The translational Langevin equation can be solved using various numerical methods 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
molecule A molecule is a group of two or more atoms that are held together by Force, attractive forces known as chemical bonds; depending on context, the term may or may not include ions that satisfy this criterion. In quantum physics, organic chemi ...
s, Brownian particles, ''etc.'' A standard (according to NIST) way to do it is to leverage a
quaternion In mathematics, the quaternion number system extends the complex numbers. Quaternions were first described by the Irish mathematician William Rowan Hamilton in 1843 and applied to mechanics in three-dimensional space. The algebra of quater ...
-based description of the stochastic rotational motion.


Applications


Langevin thermostat

Langevin thermostat is a type of Thermostat algorithm in
molecular dynamics Molecular dynamics (MD) is a computer simulation method for analyzing the Motion (physics), physical movements of atoms and molecules. The atoms and molecules are allowed to interact for a fixed period of time, giving a view of the dynamics ( ...
, which is used to simulate a canonical ensemble (NVT) under a desired temperature. It integrates the following Langevin equation of motion: M \ddot = -\nabla U(\mathbf) - \gamma \dot + \sqrt \textbf(t) -\nabla U(\mathbf) is the deterministic force term; \gamma is the friction coefficient and \gamma \dot is the friction or damping term; the last term is the random force term (k_B: Boltzmann constant, T: 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 \gamma. 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 \sigma^2 = 2\gamma k_BT/ \Delta t, \Delta t: time step), or Langevin Leapfrog integration, etc. This method is also known as Langevin Integrator.


Langevin Monte Carlo

The overdamped Langevin equation gives \mathbf_t = - \frac \nabla_\mathbf U(\mathbf_t) t + \sqrt W_t Here, D = k_B T / \gamma is the diffusion coefficient from Einstein relation. As proven with Fokker-Planck equation, under appropriate conditions, the stationary distribution of \mathbf x_t is Boltzmann distribution p(\mathbf) \propto e^. Since that \nabla \log p(\mathbf)=-\nabla U(\mathbf)/k_BT, this equation is equivalent to the following form: \mathbf_t = \epsilon \nabla_\mathbf\log p(\mathbf x_t) t + \sqrt W_t And the distribution of \mathbf x_t (t\to \infty) follows p(\mathbf). In other words, Langevin dynamics drives particles towards a stationary distribution p(\mathbf) along a gradient flow, due to the \nabla \log p(\mathbf) term, while still allowing for some random fluctuations. This provides a Markov Chain Monte Carlo method that can be used to sample data \mathbf x from a target distribution p(\mathbf), known as Langevin Monte Carlo. In many applications, we have a desired distribution p(\mathbf) from which we would like to sample \mathbf x, but direct sampling might be challenging or inefficient. Langevin Monte Carlo offers another way to sample \mathbf x \sim p(\mathbf x) by sampling a
Markov chain In probability theory and statistics, a Markov chain or Markov process is a stochastic process describing a sequence of possible events in which the probability of each event depends only on the state attained in the previous event. Informally ...
in accordance with the Langevin dynamics whose stationary state is p(\mathbf). The Metropolis-adjusted Langevin algorithm (MALA) is an example : Given a current state \mathbf x_t, the MALA method proposes a new state \tilde_ 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 \tilde_ provides greater computational efficiency, since the dynamics drive the particles into regions of higher p(\mathbf) probability and are thus more likely to be accepted. Read more in Metropolis-adjusted Langevin algorithm.


Score-based generative model

Langevin dynamics is one of the basis of score-based generative models. From (overdamped) Langevin dynamics, \mathbf_t = \epsilon \nabla_\mathbf \log p(\mathbf x_t) t + \sqrt W_t A
generative model In statistical classification, two main approaches are called the generative approach and the discriminative approach. These compute classifiers by different approaches, differing in the degree of statistical modelling. Terminology is inconsiste ...
aims to generate samples that follow (unknown data distribution) p(\mathbf). To achieve that, a score-based model learns an approximate score function \mathbf_\theta(\mathbf) \approx \nabla_\mathbf \log p(\mathbf) (a process called score matching). With access to a score function, samples are generated by the following iteration, \mathbf_ \gets \mathbf_i + \epsilon \nabla_\mathbf \log p(\mathbf_i) + \sqrt \mathbf_i, \quad i=0,1,\cdots, K with \mathbf_i \sim N(0,1). As \epsilon \to 0 and K \to \infty, the generated \mathbf_K converge to the target distribution p(\mathbf x). Score-based models use \mathbf_\theta(\mathbf) \approx \nabla_\mathbf \log p(\mathbf) as an approximation.


Relation to Other Theories


Klein-Kramers equation

As a stochastic differential equation(SDE), Langevin dynamics equation, has its corresponding
partial differential equation In mathematics, a partial differential equation (PDE) is an equation which involves a multivariable function and one or more of its partial derivatives. The function is often thought of as an "unknown" that solves the equation, similar to ho ...
(PDE), Klein-Kramers equation, a special Fokker–Planck equation that governs the
probability distribution In probability theory and statistics, a probability distribution is a Function (mathematics), function that gives the probabilities of occurrence of possible events for an Experiment (probability theory), experiment. It is a mathematical descri ...
of the particles in the phase space. The original Langevin dynamics equation can be reformulated as the following first order SDEs: \mathbf = \mathbf t \mathbf = -\gamma\mathbft-\nabla U(\mathbf) t+\sqrt\sigma \mathbf(t) Now consider the following cases and their law of (\mathbf,\mathbf): 1.\mathbf = \mathbf t , \mathbf = -\gamma\mathbf t-\nabla U(\mathbf) t+\sqrt\sigma \mathbf(t) with (\mathbf_0,\mathbf_0)\sim\rho_0 2. \frac = -\mathbf\nabla_\rho+\nabla_(\gamma\mathbf\rho+\nabla_U(\mathbf)\rho)+\nabla_^2(\sigma_^2\rho) with \rho(t=0,\mathbf,\mathbf)=\rho_0 Consider a general function of momentum and position \Psi_t = \Psi(\mathbf,\mathbf) The expectation value of the function will be \mathbb Psi_t= \int \rho(t,\mathbf,\mathbf)\Psi(\mathbf,\mathbf) \mathbf \mathbf Taking derivative with respect to time t, and applying Itô's formula, we have \mathbb frac\Psi(\mathbf,\mathbf) =\mathbb nabla_ \Psi\frac + \nabla_\Psi\frac + \sigma_T^2\nabla_^2\Psi\frac( \mathbf(t))^2/math> which can be simplified to \int (\frac\rho)\Psi(\mathbf,\mathbf) \mathbf\mathbf =\mathbb \nabla_ \Psi)\mathbf + \nabla_\Psi(-\gamma\mathbf-\nabla_U(\mathbf)) + \sigma_T^2\nabla_^2\Psi/math> Integration by parts on right hand side, due to vanishing density for infinite momentum or velocity we have (\frac\rho)\Psi(\mathbf,\mathbf) \mathbf\mathbf = \int(-\mathbf\nabla_\rho+\nabla_(\gamma\mathbf\rho+\nabla_U(\mathbf)\rho)+\nabla_^2(\sigma_^2\rho) )\Psi(\mathbf,\mathbf)\mathbf\mathbf This equation holds for arbitrary $\Psi$, so we require the density to satisfy \frac = -\mathbf\nabla_\rho+\nabla_(\gamma\mathbf\rho+\nabla_U(\mathbf)\rho)+\nabla_^2(\sigma_^2\rho) 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

For the overdamped limit, we have \mathbf = 0, so the evolution of system can be reduced to the position subspace. Following similar logic we can prove that the SDE for position, \mathbf = -\frac\nabla U(\mathbf) t +\sqrt\frac\mathbf(t) t corresponds to the Fokker Planck equation for probability density \frac = \nabla_(\frac\nabla_U(\mathbf)\rho(t,\mathbf))+\Delta_\mathbf(\frac\rho(t,\mathbf))


Fluctuation-dissipation theorem

Consider Langevin dynamics of a free particle (i.e. U(\mathbf)=0 ), then the equation for momentum will become \mathbf = -\frac \mathbft +\frac \mathbf_t the analytical solution to this SDE is \mathbf = \mathbf_0e^+\frac\int_0^t ^\mathbf_t' thus the average value of second moment of momentum will becomes (here we apply the Itô isometry) \mathbb(\mathbf^2) = \mathbf^2_0^+ \frac(1-^)\overset\frac 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 \gamma ) of this system. Combining this result with
Equipartition theorem In classical physics, classical statistical mechanics, the equipartition theorem relates the temperature of a system to its average energy, energies. The equipartition theorem is also known as the law of equipartition, equipartition of energy, ...
, which relates the average value of
kinetic energy In physics, the kinetic energy of an object is the form of energy that it possesses due to its motion. In classical mechanics, the kinetic energy of a non-rotating object of mass ''m'' traveling at a speed ''v'' is \fracmv^2.Resnick, Rober ...
of particles with
temperature Temperature is a physical quantity that quantitatively expresses the attribute of hotness or coldness. Temperature is measurement, measured with a thermometer. It reflects the average kinetic energy of the vibrating and colliding atoms making ...
\langle v^2\rangle = k_T we can determines the value of the variance \sigma in applications like Langevin thermostat. \sigma^2/\gamma = k_B T \to \sigma = \sqrt This is consistent with the original definition assuming M=1.


Path Integral

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 \gamma = \sigma = 1 , = -\nabla U()t +\sqrtW_t Discretize and define t_n = n\Delta t , we get _ -_ + \nabla U()\Delta t= \sqrt(W_-W_)\sim \mathcal(0,2\sqrt) Therefore the propagation probability will be P(_, _) = \int \xi \frac^ \delta(_ -_ + \nabla U()\Delta t-\xi) Applying Fourier Transform of delta function, and we will get P = \int \frac^\int \xi \frac^^ The second part is a
Gaussian Integral The Gaussian integral, also known as the Euler–Poisson integral, is the integral of the Gaussian function f(x) = e^ over the entire real line. Named after the German mathematician Carl Friedrich Gauss, the integral is \int_^\infty e^\,dx = \s ...
, which yields P = \int \frac^^ Now consider the probability from initial X_0 to final X_n. P(\mathbf_n, \mathbf_0) = \int \frac\prod_i^ k_i ^ take the limit of \Delta t\to 0,we will get P(\mathbf_n, \mathbf_0) = \int \mathcal ^


See also

*
Hamiltonian mechanics In physics, Hamiltonian mechanics is a reformulation of Lagrangian mechanics that emerged in 1833. Introduced by Sir William Rowan Hamilton, Hamiltonian mechanics replaces (generalized) velocities \dot q^i used in Lagrangian mechanics with (gener ...
*
Statistical mechanics In physics, statistical mechanics is a mathematical framework that applies statistical methods and probability theory to large assemblies of microscopic entities. Sometimes called statistical physics or statistical thermodynamics, its applicati ...
* Implicit solvation * Stochastic differential equations * Langevin equation * Langevin Monte Carlo *
Klein–Kramers equation In physics and mathematics, the Oskar Klein, Klein–Hans Kramers, Kramers equation or sometimes referred as Kramers–Subrahmanyan_Chandrasekhar, Chandrasekhar equation is a partial differential equation that describes the probability density funct ...


References

{{reflist


External links


Langevin Dynamics (LD) Simulation
Classical mechanics Statistical mechanics Dynamical systems Symplectic geometry