Numerical methods in molecular dynamics and multiscale problems

Size: px
Start display at page:

Download "Numerical methods in molecular dynamics and multiscale problems"

Transcription

1 Numerical methods in molecular dynamics and multiscale problems Two examples T. Lelièvre CERMICS - Ecole des Ponts ParisTech & MicMac project-team - INRIA Horizon Maths December 2012

2 Introduction The aim of molecular dynamics simulations is to understand the relationships between the macroscopic properties of a molecular system and its atomistic features. In particular, one would like to to evaluate numerically macroscopic quantities from models at the microscopic scale. Some examples of macroscopic quantities: (i) Thermodynamics quantities (averages of some observables over configurations): stress, heat capacity, free energy,... E µ (ϕ(x)). (ii) Dynamical quantities (averages of some observables over trajectories): transition rates, transition path... E(F((X t ) t 0 )).

3 Introduction A real example: Diffusion of adatoms on a surface. (A. Voter). Los Alamos

4 Introduction Many applications in various fields: biology, physics, chemistry, materials science. Molecular dynamics computations consume today a lot of CPU time. A molecular dynamics model amounts essentially in choosing a potential V which associates to a configuration (x 1,...,x N ) = x R 3N an energy V(x 1,...,x N ). (N is large!). In the canonical (NVT) ensemble, configurations are distributed according to the Boltzmann-Gibbs probability measure: dµ(x) = Z 1 exp( βv(x)) dx, where Z = exp( βv(x)) dx is the partition function and β = (k B T) 1 is proportional to the inverse of the temperature.

5 Introduction To sample µ, ergodic dynamics wrt to µ are used. A typical example is the over-damped Langevin (or gradient) dynamics: dx t = V(X t ) dt + 2β 1 dw t. This is a simple gradient descent dynamics, perturbed by noise. To compute dynamical quantities, these are also typically the dynamics of interest. Thus, E µ (ϕ(x)) 1 T T 0 ϕ(x t ) dt and E(F((X t ) t 0 )) 1 N N F((X m t ) t 0 ). m=1

6 Introduction Difficulty: In practice, X t is a metastable process, so that the convergence to equilibrium is very slow. Timescale of the microscopic process: s. TImescale of the macroscopic process: from 10 6 s to 10 2 s. A 2d schematic picture: Xt 1 is a slow variable (a metastable dof) of the system. x 2 V(x 1, x 2 ) X 1 t x 1 t

7 Introduction We will present some algorithms using parallel architectures to circumvent the central numerical difficulty: metastability For computing thermodynamics quantities, there is a clear classification of available methods, and the difficulties are now well understood (in particular for free energy computations, see for example the review [TL, Rousset, Stoltz, 2010]). On the opposite, computing efficiently dynamical quantities remains a challenge.

8 Introduction Outline of the talk: 1. The Parallel Replica dynamics: This is one instance of an algorithm to generate efficiently metastable dynamics. 2. A multiscale parareal algorithm: How to use a reduced description to accelerate dynamical microscopic simulations? Remark: There are many other techniques: splitting techniques (FFS, TIS), hyperdynamics and temperature accelerated dynamics [Voter, Fichthorn], the string method [E, Ren, Vanden-Eijnden], transition path sampling methods [Chandler, Bolhuis, Dellago], milestoning techniques [Elber, Schuette, Vanden-Eijnden], etc...

9 The Parallel Replica Algorithm

10 The Parallel Replica Algorithm The Parallel Replica Algorithm, proposed by A.F. Voter in 1998, is a method to get efficiently a "coarse-grained projection" of a dynamics. Let us consider again the overdamped Langevin dyanmics: dx t = V(X t ) dt + 2β 1 dw t and let assume that we are given a smooth mapping S : R d N which to a configuration in R d associates a state number. Think of a numbering of the wells of the potential V. The aim of the parallel replica dynamics is to generate very efficiently a trajectory (S t ) t 0 which has (almost) the same law as (S(X t )) t 0.

11 The Parallel Replica Algorithm Decorrelation step: run the dynamics on a reference walker...

12 The Parallel Replica Algorithm Decorrelation step:... until it remains trapped for a time τ corr.

13 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

14 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

15 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

16 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

17 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

18 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

19 The Parallel Replica Algorithm Dephasing step: generate new initial conditions in the state.

20 The Parallel Replica Algorithm Parallel step: run independent trajectories in parallel...

21 The Parallel Replica Algorithm Parallel step:... and detect the first transition event.

22 The Parallel Replica Algorithm Parallel step: update the time clock: T simu = T simu + NT.

23 The Parallel Replica Algorithm A new decorrelation step starts...

24 The Parallel Replica Algorithm New decorrelation step

25 The Parallel Replica Algorithm In summary, three steps: Decorrelation step: does the reference walker remain trapped in a set? Dephasing step: prepare many initial conditions in this trapping set. Parallel step: detect the first escaping event. Some numerical simulations...

26 The Parallel Replica Algorithm Question: Why does this work? Why is there no error introduced by the parallel step? This is related to the very general question: why does the state to state dynamics is (almost) Markovian?

27 The quasi-stationary distribution Answer: there exists a probability distribution ν (the QSD) attached to each state, such that: If the process X t remains in the well for a sufficiently long time, then X t is distributed according to ν. If the process starts from ν, then, (i) the exit time is exponentially distributed and (ii) independent from the exit point. This justifies the algorithm.

28 The quasi-stationary distribution Error estimate: Let T W denote the exit time from W for the stochastic process X t. Then, for τ corr C λ 2 λ 1, sup E(f(T W t,x TW ) T W τ corr ) E ν (f(t W,X TW )) f, f L 1 C exp( (λ 2 λ 1 )τ corr ), where λ 2 < λ 1 < 0 are the two first eigenvalues of L = div ( V +β 1 ) with absorbing boundary conditions on W.

29 The Parallel Replica Algorithm: conclusions In summary, We know what τ corr should be, and thus: (i) we can try to estimate it and (ii) we can apply this algorithm to other fields. The algorithm is efficient if the typical time it takes to leave the well is much smaller than the typical time it takes to reach the local equilibrium (QSD). (This is a spectral gap requirement.)

30 A multiscale parareal algorithm: the main idea We would like to describe an algorithm which consists in coupling a macroscopic model with a microscopic model in order to efficiently generate the microscopic dynamics. The macroscopic model is the predictor, and the microscopic model is the corrector. Question 1: obtaining a reduced description. Question 2: using it in a multiscale parareal algorithm.

31 Effective dynamics Recall the original dynamics dx t = V(X t ) dt + 2β 1 dw t. We are given a smooth one dimensional function ξ : R d R. Problem: propose a Markovian dynamics (say on z t R) that approximates the dynamics (ξ(x t )) t 0.

32 Construction of the effective dynamics By Itô, one has dξ(x t ) = ( V ξ+β 1 ξ)(x t ) dt+ 2β 1 ξ(x t ) ξ(x t) ξ(x t ) dw t First attempt: d z t = b(t, z t ) dt + 2β 1 σ(t, z t ) db t with ( ) b(t, z) = E ( V ξ +β 1 ξ)(x t ) ξ(x t ) = z ( ) σ 2 (t, z) = E ξ 2 (X t ) ξ(x t ) = z. Then, for all time t 0, L(ξ(X t )) = L( z t )! But b and σ are untractable numerically...

33 By Itô, one has Construction of the effective dynamics dξ(x t ) = ( V ξ+β 1 ξ)(x t ) dt+ 2β 1 ξ(x t ) ξ(x t) ξ(x t ) dw t The effective dynamics: dz t = b(z t ) dt + 2β 1 σ(z t ) db t with ) b(z) = E µ (( V ξ +β 1 ξ)(x) ξ(x) = z ) σ 2 (z) = E µ ( ξ 2 (X) ξ(x) = z. Related approaches: Mori-Zwanzig and projection operator formalism [E/Vanden-Eijnden,...], asymptotic approaches [Papanicolaou, Freidlin, Pavliotis/Stuart,...].

34 Typically ρ R. The proof [Legoll, TL] is PDE-based. It is inspired by a decomposition of the entropy proposed in [Grunewald/Otto/Villani/Westdickenberg], and entropy estimates. Error analysis: time marginals The effective dynamics is ergodic (detailed balanced) wrt ξ µ. Moreover Under the assumptions ( ξ = Cte for simplicity): (H1) The conditional probability measures µ( ξ(x) = z) satisfy a Logarithmic Sobolev Inequality with constant ρ, (H2) Bounded coupling assumption: V V V L κ, (H3) The probability measure µ satisfies a Logarithmic Sobolev Inequality with constant R, Then, C > 0, t 0, L(ξ(X t )) L(z t ) TV ( ) κ ( ) C min H(L(X 0 ) µ) H(L(X t ) µ), exp( β 1 Rt). ρ

35 A multiscale parareal algorithm The basic algorithm is very much inspired by the parareal algorithm [Lions, Maday Turinici]. Let us present it in a very simple setting: Consider the fine dynamics: ẋ = αx + p T y, ẏ = 1 (qx Ay). ǫ The variable u = (x, y) contains a slow variable x R and a fast variable y R d 1. Associated to that dynamics, we have an expensive fine propagator F t over the time range t. Under appropriate assumption, a natural coarse dynamics (ǫ 0) on x is: Ẋ = (α+p T A 1 q)x. Associated to that dynamics, we have a cheap coarse propagator G t over the time range t.

36 The algorithm Let us now present the algorithm Let u(0) = u 0 be the initial condition. 1. Initialization: a) Compute {X0 n} 0 n N sequentially by using the coarse propagator: X 0 0 = R(u 0 ), X n+1 0 = G t (X n 0). b) Lift the macroscopic approximation to the microscopic level: u 0 0 = u 0 and, for all 1 n N, u n 0 = L(X n 0).

37 2. Assume that, for some k 0, the sequences { uk n } { } 0 n N and X n k are known. To compute these sequences at the 0 n N iteration k + 1, a) For all 0 n N 1, compute (in parallel) using the coarse and the fine-scale propagators X n+1 k = G t (Xk), n u n+1 k = F t (uk). n b) For all 0 n N 1, evaluate the jumps (the difference between the two propagated values) at the macroscopic level: J n+1 k = R(u n+1 k ) X n+1 k. c) Compute { } Xk+1 n sequentially by 0 n N Xk+1 0 = R(u 0 ), X n+1 k+1 = G t(xk+1)+j n n+1 k. d) Compute { u n+1 } k+1 by matching the result of the local 0 n N 1 microscopic computation, u n+1 k, on the corrected macroscopic state X n+1 k+1 : uk+1 0 = u 0 and, for all 0 n N 1, u n+1 n+1 k+1 = P(Xk+1, un+1 k ).

38 Error analysis In the simple setting above, the restriction, lifting and matching operators we use are: R(x, y) = x, L(X) = (X,(A 1 q)x) and P(X,(x, y)) = (X, y). Let us assume that F t and G t are exact. Then the errors on the macroscopic variable and the microscopic variable are: for all k 0, for all k 0, sup Xk n Ru(t n) Cǫ 1+ k/2, 0 n N sup uk n u(t n) Cǫ 1+ k/2, 0 n N

39 Numerical results E N k / x(tn) e N k / u(tn) k = 0 k = 1 k = 2 k = 3 k = 4 k = 5 k = ǫ ǫ Work in progress: extensions to nonlinear problems, stochastic problems,...

40 Conclusion Notice that the numerical methods we have presented are based on some dimension reduction and coarse-graining techniques (through the functions ξ or S). They are easy to parallelize. Two useful mathematical tools to quantify metastability: LSI and QSD.

41 Conclusion A few references: C. Le Bris, T. Lelièvre, M. Luskin and D. Perez, A mathematical formalization of the parallel replica dynamics, Monte Carlo Methods and Applications, 18(2), , F. Legoll and T. Lelièvre, Effective dynamics using conditional expectations, Nonlinearity, 23, , F. Legoll, T. Lelièvre and G. Samaey, A micro-macro parareal algorithm: application to singularly perturbed ordinary differential equations,

Effective dynamics for the (overdamped) Langevin equation

Effective dynamics for the (overdamped) Langevin equation Effective dynamics for the (overdamped) Langevin equation Frédéric Legoll ENPC and INRIA joint work with T. Lelièvre (ENPC and INRIA) Enumath conference, MS Numerical methods for molecular dynamics EnuMath

More information

Tensorized Adaptive Biasing Force method for molecular dynamics

Tensorized Adaptive Biasing Force method for molecular dynamics Tensorized Adaptive Biasing Force method for molecular dynamics Virginie Ehrlacher 1, Tony Lelièvre 1 & Pierre Monmarché 2 1 CERMICS, Ecole des Ponts ParisTech & MATHERIALS project, INRIA 2 Laboratoire

More information

Energie libre et dynamique réduite en dynamique moléculaire

Energie libre et dynamique réduite en dynamique moléculaire Energie libre et dynamique réduite en dynamique moléculaire Frédéric Legoll Ecole des Ponts ParisTech et INRIA http://cermics.enpc.fr/ legoll Travaux en collaboration avec T. Lelièvre (Ecole des Ponts

More information

The parallel replica method for Markov chains

The parallel replica method for Markov chains The parallel replica method for Markov chains David Aristoff (joint work with T Lelièvre and G Simpson) Colorado State University March 2015 D Aristoff (Colorado State University) March 2015 1 / 29 Introduction

More information

Parallel-in-time integrators for Hamiltonian systems

Parallel-in-time integrators for Hamiltonian systems Parallel-in-time integrators for Hamiltonian systems Claude Le Bris ENPC and INRIA Visiting Professor, The University of Chicago joint work with X. Dai (Paris 6 and Chinese Academy of Sciences), F. Legoll

More information

Importance splitting for rare event simulation

Importance splitting for rare event simulation Importance splitting for rare event simulation F. Cerou Frederic.Cerou@inria.fr Inria Rennes Bretagne Atlantique Simulation of hybrid dynamical systems and applications to molecular dynamics September

More information

Advanced computational methods X Selected Topics: SGD

Advanced computational methods X Selected Topics: SGD Advanced computational methods X071521-Selected Topics: SGD. In this lecture, we look at the stochastic gradient descent (SGD) method 1 An illustrating example The MNIST is a simple dataset of variety

More information

Finite temperature analysis of stochastic networks

Finite temperature analysis of stochastic networks Finite temperature analysis of stochastic networks Maria Cameron University of Maryland USA Stochastic networks with detailed balance * The generator matrix L = ( L ij ), i, j S L ij 0, i, j S, i j j S

More information

3.320 Lecture 23 (5/3/05)

3.320 Lecture 23 (5/3/05) 3.320 Lecture 23 (5/3/05) Faster, faster,faster Bigger, Bigger, Bigger Accelerated Molecular Dynamics Kinetic Monte Carlo Inhomogeneous Spatial Coarse Graining 5/3/05 3.320 Atomistic Modeling of Materials

More information

Distributed Learning based on Entropy-Driven Game Dynamics

Distributed Learning based on Entropy-Driven Game Dynamics Distributed Learning based on Entropy-Driven Game Dynamics Bruno Gaujal joint work with Pierre Coucheney and Panayotis Mertikopoulos Inria Aug., 2014 Model Shared resource systems (network, processors)

More information

SDEs in large dimension and numerical methods Part 1: Sampling the canonical distribution

SDEs in large dimension and numerical methods Part 1: Sampling the canonical distribution SDEs in large dimension and numerical methods Part 1: Sampling the canonical distribution T. Lelièvre CERMICS - Ecole des Ponts ParisTech & Matherials project-team - INRIA RICAM Winterschool, December

More information

Two recent works on molecular systems out of equilibrium

Two recent works on molecular systems out of equilibrium Two recent works on molecular systems out of equilibrium Frédéric Legoll ENPC and INRIA joint work with M. Dobson, T. Lelièvre, G. Stoltz (ENPC and INRIA), A. Iacobucci and S. Olla (Dauphine). CECAM workshop:

More information

arxiv: v2 [math.na] 20 Dec 2016

arxiv: v2 [math.na] 20 Dec 2016 SAIONARY AVERAGING FOR MULI-SCALE CONINUOUS IME MARKOV CHAINS USING PARALLEL REPLICA DYNAMICS ING WANG, PER PLECHÁČ, AND DAVID ARISOFF arxiv:169.6363v2 [math.na 2 Dec 216 Abstract. We propose two algorithms

More information

On different notions of timescales in molecular dynamics

On different notions of timescales in molecular dynamics On different notions of timescales in molecular dynamics Origin of Scaling Cascades in Protein Dynamics June 8, 217 IHP Trimester Stochastic Dynamics out of Equilibrium Overview 1. Motivation 2. Definition

More information

Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0

Introduction to multiscale modeling and simulation. Explicit methods for ODEs : forward Euler. y n+1 = y n + tf(y n ) dy dt = f(y), y(0) = y 0 Introduction to multiscale modeling and simulation Lecture 5 Numerical methods for ODEs, SDEs and PDEs The need for multiscale methods Two generic frameworks for multiscale computation Explicit methods

More information

DIFFUSION MAPS, REDUCTION COORDINATES AND LOW DIMENSIONAL REPRESENTATION OF STOCHASTIC SYSTEMS

DIFFUSION MAPS, REDUCTION COORDINATES AND LOW DIMENSIONAL REPRESENTATION OF STOCHASTIC SYSTEMS DIFFUSION MAPS, REDUCTION COORDINATES AND LOW DIMENSIONAL REPRESENTATION OF STOCHASTIC SYSTEMS R.R. COIFMAN, I.G. KEVREKIDIS, S. LAFON, M. MAGGIONI, AND B. NADLER Abstract. The concise representation of

More information

Homework 3 due Friday, April 26. A couple of examples where the averaging principle from last time can be done analytically.

Homework 3 due Friday, April 26. A couple of examples where the averaging principle from last time can be done analytically. Stochastic Averaging Examples Tuesday, April 23, 2013 2:01 PM Homework 3 due Friday, April 26. A couple of examples where the averaging principle from last time can be done analytically. Based on the alternative

More information

On continuous time contract theory

On continuous time contract theory Ecole Polytechnique, France Journée de rentrée du CMAP, 3 octobre, 218 Outline 1 2 Semimartingale measures on the canonical space Random horizon 2nd order backward SDEs (Static) Principal-Agent Problem

More information

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is

The dynamics of small particles whose size is roughly 1 µmt or. smaller, in a fluid at room temperature, is extremely erratic, and is 1 I. BROWNIAN MOTION The dynamics of small particles whose size is roughly 1 µmt or smaller, in a fluid at room temperature, is extremely erratic, and is called Brownian motion. The velocity of such particles

More information

Speeding up Convergence to Equilibrium for Diffusion Processes

Speeding up Convergence to Equilibrium for Diffusion Processes Speeding up Convergence to Equilibrium for Diffusion Processes G.A. Pavliotis Department of Mathematics Imperial College London Joint Work with T. Lelievre(CERMICS), F. Nier (CERMICS), M. Ottobre (Warwick),

More information

Nonlinear representation, backward SDEs, and application to the Principal-Agent problem

Nonlinear representation, backward SDEs, and application to the Principal-Agent problem Nonlinear representation, backward SDEs, and application to the Principal-Agent problem Ecole Polytechnique, France April 4, 218 Outline The Principal-Agent problem Formulation 1 The Principal-Agent problem

More information

Approches mathématiques pour la simulation multi-échelle des matériaux

Approches mathématiques pour la simulation multi-échelle des matériaux p. 1/2 Approches mathématiques pour la simulation multi-échelle des matériaux Claude Le Bris Ecole des Ponts and Inria, FRANCE http://cermics.enpc.fr/ lebris based on a series of works by F. Legoll, T.

More information

Theory and applications of random Poincaré maps

Theory and applications of random Poincaré maps Nils Berglund nils.berglund@univ-orleans.fr http://www.univ-orleans.fr/mapmo/membres/berglund/ Random Dynamical Systems Theory and applications of random Poincaré maps Nils Berglund MAPMO, Université d'orléans,

More information

Phase transitions for particles in R 3

Phase transitions for particles in R 3 Phase transitions for particles in R 3 Sabine Jansen LMU Munich Konstanz, 29 May 208 Overview. Introduction to statistical mechanics: Partition functions and statistical ensembles 2. Phase transitions:

More information

ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics

ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics ChE 210B: Advanced Topics in Equilibrium Statistical Mechanics Glenn Fredrickson Lecture 1 Reading: 3.1-3.5 Chandler, Chapters 1 and 2 McQuarrie This course builds on the elementary concepts of statistical

More information

Grand Canonical Formalism

Grand Canonical Formalism Grand Canonical Formalism Grand Canonical Ensebmle For the gases of ideal Bosons and Fermions each single-particle mode behaves almost like an independent subsystem, with the only reservation that the

More information

1. Introduction Systems evolving on widely separated time-scales represent a challenge for numerical simulations. A generic example is

1. Introduction Systems evolving on widely separated time-scales represent a challenge for numerical simulations. A generic example is COMM. MATH. SCI. Vol. 1, No. 2, pp. 385 391 c 23 International Press FAST COMMUNICATIONS NUMERICAL TECHNIQUES FOR MULTI-SCALE DYNAMICAL SYSTEMS WITH STOCHASTIC EFFECTS ERIC VANDEN-EIJNDEN Abstract. Numerical

More information

Greedy algorithms for high-dimensional non-symmetric problems

Greedy algorithms for high-dimensional non-symmetric problems Greedy algorithms for high-dimensional non-symmetric problems V. Ehrlacher Joint work with E. Cancès et T. Lelièvre Financial support from Michelin is acknowledged. CERMICS, Ecole des Ponts ParisTech &

More information

Monte Carlo methods in molecular dynamics.

Monte Carlo methods in molecular dynamics. T. Lelièvre, Rencontres EDP/Proba, Octobre 2009 p. 1 Monte Carlo methods in molecular dynamics. Tony Lelièvre CERMICS, Ecole Nationale des Ponts et Chaussées, France, MicMac team, INRIA, France. http://cermics.enpc.fr/

More information

Stochastic Volatility and Correction to the Heat Equation

Stochastic Volatility and Correction to the Heat Equation Stochastic Volatility and Correction to the Heat Equation Jean-Pierre Fouque, George Papanicolaou and Ronnie Sircar Abstract. From a probabilist s point of view the Twentieth Century has been a century

More information

Separation of Variables in Linear PDE: One-Dimensional Problems

Separation of Variables in Linear PDE: One-Dimensional Problems Separation of Variables in Linear PDE: One-Dimensional Problems Now we apply the theory of Hilbert spaces to linear differential equations with partial derivatives (PDE). We start with a particular example,

More information

Computer Intensive Methods in Mathematical Statistics

Computer Intensive Methods in Mathematical Statistics Computer Intensive Methods in Mathematical Statistics Department of mathematics johawes@kth.se Lecture 16 Advanced topics in computational statistics 18 May 2017 Computer Intensive Methods (1) Plan of

More information

RATIO BASED PARALLEL TIME INTEGRATION (RAPTI) FOR INITIAL VALUE PROBLEMS

RATIO BASED PARALLEL TIME INTEGRATION (RAPTI) FOR INITIAL VALUE PROBLEMS RATIO BASED PARALLEL TIME INTEGRATION (RAPTI) FOR INITIAL VALUE PROBLEMS Nabil R. Nassif Noha Makhoul Karam Yeran Soukiassian Mathematics Department, American University of Beirut IRISA, Campus Beaulieu,

More information

Lecture 10: Singular Perturbations and Averaging 1

Lecture 10: Singular Perturbations and Averaging 1 Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.243j (Fall 2003): DYNAMICS OF NONLINEAR SYSTEMS by A. Megretski Lecture 10: Singular Perturbations and

More information

A mathematical framework for Exact Milestoning

A mathematical framework for Exact Milestoning A mathematical framework for Exact Milestoning David Aristoff (joint work with Juan M. Bello-Rivas and Ron Elber) Colorado State University July 2015 D. Aristoff (Colorado State University) July 2015 1

More information

A quantum heat equation 5th Spring School on Evolution Equations, TU Berlin

A quantum heat equation 5th Spring School on Evolution Equations, TU Berlin A quantum heat equation 5th Spring School on Evolution Equations, TU Berlin Mario Bukal A. Jüngel and D. Matthes ACROSS - Centre for Advanced Cooperative Systems Faculty of Electrical Engineering and Computing

More information

Entropy-dissipation methods I: Fokker-Planck equations

Entropy-dissipation methods I: Fokker-Planck equations 1 Entropy-dissipation methods I: Fokker-Planck equations Ansgar Jüngel Vienna University of Technology, Austria www.jungel.at.vu Introduction Boltzmann equation Fokker-Planck equations Degenerate parabolic

More information

Math 456: Mathematical Modeling. Tuesday, April 9th, 2018

Math 456: Mathematical Modeling. Tuesday, April 9th, 2018 Math 456: Mathematical Modeling Tuesday, April 9th, 2018 The Ergodic theorem Tuesday, April 9th, 2018 Today 1. Asymptotic frequency (or: How to use the stationary distribution to estimate the average amount

More information

Introduction to asymptotic techniques for stochastic systems with multiple time-scales

Introduction to asymptotic techniques for stochastic systems with multiple time-scales Introduction to asymptotic techniques for stochastic systems with multiple time-scales Eric Vanden-Eijnden Courant Institute Motivating examples Consider the ODE {Ẋ = Y 3 + sin(πt) + cos( 2πt) X() = x

More information

F r (t) = 0, (4.2) F (t) = r= r a (t)

F r (t) = 0, (4.2) F (t) = r= r a (t) Chapter 4 Stochastic Equations 4.1 Langevin equation To explain the idea of introduction of the Langevin equation, let us consider the concrete example taken from surface physics: motion of an atom (adatom)

More information

Hierarchical Modeling of Complicated Systems

Hierarchical Modeling of Complicated Systems Hierarchical Modeling of Complicated Systems C. David Levermore Department of Mathematics and Institute for Physical Science and Technology University of Maryland, College Park, MD lvrmr@math.umd.edu presented

More information

Endogenous Information Choice

Endogenous Information Choice Endogenous Information Choice Lecture 7 February 11, 2015 An optimizing trader will process those prices of most importance to his decision problem most frequently and carefully, those of less importance

More information

Local vs. Nonlocal Diffusions A Tale of Two Laplacians

Local vs. Nonlocal Diffusions A Tale of Two Laplacians Local vs. Nonlocal Diffusions A Tale of Two Laplacians Jinqiao Duan Dept of Applied Mathematics Illinois Institute of Technology Chicago duan@iit.edu Outline 1 Einstein & Wiener: The Local diffusion 2

More information

MACROSCOPIC VARIABLES, THERMAL EQUILIBRIUM. Contents AND BOLTZMANN ENTROPY. 1 Macroscopic Variables 3. 2 Local quantities and Hydrodynamics fields 4

MACROSCOPIC VARIABLES, THERMAL EQUILIBRIUM. Contents AND BOLTZMANN ENTROPY. 1 Macroscopic Variables 3. 2 Local quantities and Hydrodynamics fields 4 MACROSCOPIC VARIABLES, THERMAL EQUILIBRIUM AND BOLTZMANN ENTROPY Contents 1 Macroscopic Variables 3 2 Local quantities and Hydrodynamics fields 4 3 Coarse-graining 6 4 Thermal equilibrium 9 5 Two systems

More information

NUMERICAL ANALYSIS OF PARALLEL REPLICA DYNAMICS

NUMERICAL ANALYSIS OF PARALLEL REPLICA DYNAMICS NUMERICAL ANALYSIS OF PARALLEL REPLICA DYNAMICS GIDEON SIMPSON AND MITCHELL LUSKIN Abstract Parallel replica dynamics is a method for accelerating the computation of processes characterized by a sequence

More information

Estimating Accuracy in Classical Molecular Simulation

Estimating Accuracy in Classical Molecular Simulation Estimating Accuracy in Classical Molecular Simulation University of Illinois Urbana-Champaign Department of Computer Science Institute for Mathematics and its Applications July 2007 Acknowledgements Ben

More information

Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio ( )

Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio ( ) Mathematical Methods for Neurosciences. ENS - Master MVA Paris 6 - Master Maths-Bio (2014-2015) Etienne Tanré - Olivier Faugeras INRIA - Team Tosca November 26th, 2014 E. Tanré (INRIA - Team Tosca) Mathematical

More information

Derivation of the GENERIC form of nonequilibrium thermodynamics from a statistical optimization principle

Derivation of the GENERIC form of nonequilibrium thermodynamics from a statistical optimization principle Derivation of the GENERIC form of nonequilibrium thermodynamics from a statistical optimization principle Bruce Turkington Univ. of Massachusetts Amherst An optimization principle for deriving nonequilibrium

More information

Estimating exit rate for rare event dynamical systems by extrapolation

Estimating exit rate for rare event dynamical systems by extrapolation Zuse Institute Berlin Takustr. 7 14195 Berlin Germany JANNES QUER 1 AND MARCUS WEBER 1 Estimating exit rate for rare event dynamical systems by extrapolation 1 Zuse Institute Berlin ZIB Report 15-54 (revised

More information

Optimum protocol for fast-switching free-energy calculations

Optimum protocol for fast-switching free-energy calculations PHYSICAL REVIEW E 8, 7 Optimum protocol for fast-switching free-energy calculations Philipp Geiger and Christoph Dellago* Faculty of Physics, University of Vienna, Boltzmanngasse 5, 9 Vienna, Austria Received

More information

Onsager theory: overview

Onsager theory: overview Onsager theory: overview Pearu Peterson December 18, 2006 1 Introduction Our aim is to study matter that consists of large number of molecules. A complete mechanical description of such a system is practically

More information

Lecture 6: Bayesian Inference in SDE Models

Lecture 6: Bayesian Inference in SDE Models Lecture 6: Bayesian Inference in SDE Models Bayesian Filtering and Smoothing Point of View Simo Särkkä Aalto University Simo Särkkä (Aalto) Lecture 6: Bayesian Inference in SDEs 1 / 45 Contents 1 SDEs

More information

Mathematical analysis of an Adaptive Biasing Potential method for diffusions

Mathematical analysis of an Adaptive Biasing Potential method for diffusions Mathematical analysis of an Adaptive Biasing Potential method for diffusions Charles-Edouard Bréhier Joint work with Michel Benaïm (Neuchâtel, Switzerland) CNRS & Université Lyon 1, Institut Camille Jordan

More information

A random perturbation approach to some stochastic approximation algorithms in optimization.

A random perturbation approach to some stochastic approximation algorithms in optimization. A random perturbation approach to some stochastic approximation algorithms in optimization. Wenqing Hu. 1 (Presentation based on joint works with Chris Junchi Li 2, Weijie Su 3, Haoyi Xiong 4.) 1. Department

More information

Convergence exponentielle uniforme vers la distribution quasi-stationnaire de processus de Markov absorbés

Convergence exponentielle uniforme vers la distribution quasi-stationnaire de processus de Markov absorbés Convergence exponentielle uniforme vers la distribution quasi-stationnaire de processus de Markov absorbés Nicolas Champagnat, Denis Villemonais Séminaire commun LJK Institut Fourier, Méthodes probabilistes

More information

Gillespie s Algorithm and its Approximations. Des Higham Department of Mathematics and Statistics University of Strathclyde

Gillespie s Algorithm and its Approximations. Des Higham Department of Mathematics and Statistics University of Strathclyde Gillespie s Algorithm and its Approximations Des Higham Department of Mathematics and Statistics University of Strathclyde djh@maths.strath.ac.uk The Three Lectures 1 Gillespie s algorithm and its relation

More information

Introduction Statistical Thermodynamics. Monday, January 6, 14

Introduction Statistical Thermodynamics. Monday, January 6, 14 Introduction Statistical Thermodynamics 1 Molecular Simulations Molecular dynamics: solve equations of motion Monte Carlo: importance sampling r 1 r 2 r n MD MC r 1 r 2 2 r n 2 3 3 4 4 Questions How can

More information

Multiscale Modeling of Epitaxial Growth Processes: Level Sets and Atomistic Models

Multiscale Modeling of Epitaxial Growth Processes: Level Sets and Atomistic Models Multiscale Modeling of Epitaxial Growth Processes: Level Sets and Atomistic Models Russel Caflisch 1, Mark Gyure 2, Bo Li 4, Stan Osher 1, Christian Ratsch 1,2, David Shao 1 and Dimitri Vvedensky 3 1 UCLA,

More information

Chapter 1 Direct Modeling for Computational Fluid Dynamics

Chapter 1 Direct Modeling for Computational Fluid Dynamics Chapter 1 Direct Modeling for Computational Fluid Dynamics Computational fluid dynamics (CFD) is a scientific discipline, which aims to capture fluid motion in a discretized space. The description of the

More information

Accelerated Quantum Molecular Dynamics

Accelerated Quantum Molecular Dynamics Accelerated Quantum Molecular Dynamics Enrique Martinez, Christian Negre, Marc J. Cawkwell, Danny Perez, Arthur F. Voter and Anders M. N. Niklasson Outline Quantum MD Current approaches Challenges Extended

More information

Exact Simulation of Diffusions and Jump Diffusions

Exact Simulation of Diffusions and Jump Diffusions Exact Simulation of Diffusions and Jump Diffusions A work by: Prof. Gareth O. Roberts Dr. Alexandros Beskos Dr. Omiros Papaspiliopoulos Dr. Bruno Casella 28 th May, 2008 Content 1 Exact Algorithm Construction

More information

in Bounded Domains Ariane Trescases CMLA, ENS Cachan

in Bounded Domains Ariane Trescases CMLA, ENS Cachan CMLA, ENS Cachan Joint work with Yan GUO, Chanwoo KIM and Daniela TONON International Conference on Nonlinear Analysis: Boundary Phenomena for Evolutionnary PDE Academia Sinica December 21, 214 Outline

More information

Lecture No 1 Introduction to Diffusion equations The heat equat

Lecture No 1 Introduction to Diffusion equations The heat equat Lecture No 1 Introduction to Diffusion equations The heat equation Columbia University IAS summer program June, 2009 Outline of the lectures We will discuss some basic models of diffusion equations and

More information

Bridging the Gap between Center and Tail for Multiscale Processes

Bridging the Gap between Center and Tail for Multiscale Processes Bridging the Gap between Center and Tail for Multiscale Processes Matthew R. Morse Department of Mathematics and Statistics Boston University BU-Keio 2016, August 16 Matthew R. Morse (BU) Moderate Deviations

More information

Brownian Motion. 1 Definition Brownian Motion Wiener measure... 3

Brownian Motion. 1 Definition Brownian Motion Wiener measure... 3 Brownian Motion Contents 1 Definition 2 1.1 Brownian Motion................................. 2 1.2 Wiener measure.................................. 3 2 Construction 4 2.1 Gaussian process.................................

More information

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS

PROBABILITY: LIMIT THEOREMS II, SPRING HOMEWORK PROBLEMS PROBABILITY: LIMIT THEOREMS II, SPRING 218. HOMEWORK PROBLEMS PROF. YURI BAKHTIN Instructions. You are allowed to work on solutions in groups, but you are required to write up solutions on your own. Please

More information

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems.

Goal. Robust A Posteriori Error Estimates for Stabilized Finite Element Discretizations of Non-Stationary Convection-Diffusion Problems. Robust A Posteriori Error Estimates for Stabilized Finite Element s of Non-Stationary Convection-Diffusion Problems L. Tobiska and R. Verfürth Universität Magdeburg Ruhr-Universität Bochum www.ruhr-uni-bochum.de/num

More information

SPDEs, criticality, and renormalisation

SPDEs, criticality, and renormalisation SPDEs, criticality, and renormalisation Hendrik Weber Mathematics Institute University of Warwick Potsdam, 06.11.2013 An interesting model from Physics I Ising model Spin configurations: Energy: Inverse

More information

ICES REPORT Parareal methods for highly oscillatory ordinary differential equations

ICES REPORT Parareal methods for highly oscillatory ordinary differential equations ICES REPORT 15-6 March 215 Parareal methods for highly oscillatory ordinary differential equations by G. Ariel, S. Kim, and R. Tsai The Institute for Computational Engineering and Sciences The University

More information

Local smoothing and Strichartz estimates for manifolds with degenerate hyperbolic trapping

Local smoothing and Strichartz estimates for manifolds with degenerate hyperbolic trapping Local smoothing and Strichartz estimates for manifolds with degenerate hyperbolic trapping H. Christianson partly joint work with J. Wunsch (Northwestern) Department of Mathematics University of North

More information

More Empirical Process Theory

More Empirical Process Theory More Empirical Process heory 4.384 ime Series Analysis, Fall 2008 Recitation by Paul Schrimpf Supplementary to lectures given by Anna Mikusheva October 24, 2008 Recitation 8 More Empirical Process heory

More information

Modeling and Analysis of Dynamic Systems

Modeling and Analysis of Dynamic Systems Modeling and Analysis of Dynamic Systems Dr. Guillaume Ducard Fall 2017 Institute for Dynamic Systems and Control ETH Zurich, Switzerland G. Ducard c 1 / 57 Outline 1 Lecture 13: Linear System - Stability

More information

String method for the Cahn-Hilliard dynamics

String method for the Cahn-Hilliard dynamics String method for the Cahn-Hilliard dynamics Tiejun Li School of Mathematical Sciences Peking University tieli@pku.edu.cn Joint work with Wei Zhang and Pingwen Zhang Outline Background Problem Set-up Algorithms

More information

A Backward Particle Interpretation of Feynman-Kac Formulae

A Backward Particle Interpretation of Feynman-Kac Formulae A Backward Particle Interpretation of Feynman-Kac Formulae P. Del Moral Centre INRIA de Bordeaux - Sud Ouest Workshop on Filtering, Cambridge Univ., June 14-15th 2010 Preprints (with hyperlinks), joint

More information

Nested Stochastic Simulation Algorithm for Chemical Kinetic Systems with Disparate Rates. Abstract

Nested Stochastic Simulation Algorithm for Chemical Kinetic Systems with Disparate Rates. Abstract Nested Stochastic Simulation Algorithm for Chemical Kinetic Systems with Disparate Rates Weinan E Department of Mathematics and PACM, Princeton University, Princeton, NJ 08544, USA Di Liu and Eric Vanden-Eijnden

More information

Weak convergence and large deviation theory

Weak convergence and large deviation theory First Prev Next Go To Go Back Full Screen Close Quit 1 Weak convergence and large deviation theory Large deviation principle Convergence in distribution The Bryc-Varadhan theorem Tightness and Prohorov

More information

Multiscale dynamical systems and parareal algorithms

Multiscale dynamical systems and parareal algorithms Colloquium du CERMICS Multiscale dynamical systems and parareal algorithms Bjorn Engquist (University of Texas at Austin) 7juin2018 Multiscale dynamical systems and parareal algorithms Bjorn Engquist,

More information

Energy Barriers and Rates - Transition State Theory for Physicists

Energy Barriers and Rates - Transition State Theory for Physicists Energy Barriers and Rates - Transition State Theory for Physicists Daniel C. Elton October 12, 2013 Useful relations 1 cal = 4.184 J 1 kcal mole 1 = 0.0434 ev per particle 1 kj mole 1 = 0.0104 ev per particle

More information

The Parallel Replica Method for Simulating Long Trajectories of Markov Chains

The Parallel Replica Method for Simulating Long Trajectories of Markov Chains D. Aristoff et al. (2014) ParRep for Simulating Markov Chains, Applied Mathematics Research express, Vol. 2014, No. 2, pp. 332 352 Advance Access publication August 12, 2014 doi:10.1093/amrx/abu005 The

More information

Height fluctuations for the stationary KPZ equation

Height fluctuations for the stationary KPZ equation Firenze, June 22-26, 2015 Height fluctuations for the stationary KPZ equation P.L. Ferrari with A. Borodin, I. Corwin and B. Vető arxiv:1407.6977; To appear in MPAG http://wt.iam.uni-bonn.de/ ferrari Introduction

More information

Lecture 14: Advanced Conformational Sampling

Lecture 14: Advanced Conformational Sampling Lecture 14: Advanced Conformational Sampling Dr. Ronald M. Levy ronlevy@temple.edu Multidimensional Rough Energy Landscapes MD ~ ns, conformational motion in macromolecules ~µs to sec Interconversions

More information

Une approche hypocoercive L 2 pour l équation de Vlasov-Fokker-Planck

Une approche hypocoercive L 2 pour l équation de Vlasov-Fokker-Planck Une approche hypocoercive L 2 pour l équation de Vlasov-Fokker-Planck Jean Dolbeault dolbeaul@ceremade.dauphine.fr CEREMADE CNRS & Université Paris-Dauphine http://www.ceremade.dauphine.fr/ dolbeaul (EN

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility), 4.2-4.4 (explicit examples of eigenfunction methods) Gardiner

More information

Lecture 12: Detailed balance and Eigenfunction methods

Lecture 12: Detailed balance and Eigenfunction methods Miranda Holmes-Cerfon Applied Stochastic Analysis, Spring 2015 Lecture 12: Detailed balance and Eigenfunction methods Readings Recommended: Pavliotis [2014] 4.5-4.7 (eigenfunction methods and reversibility),

More information

Dynamical systems with Gaussian and Levy noise: analytical and stochastic approaches

Dynamical systems with Gaussian and Levy noise: analytical and stochastic approaches Dynamical systems with Gaussian and Levy noise: analytical and stochastic approaches Noise is often considered as some disturbing component of the system. In particular physical situations, noise becomes

More information

CHAPTER V. Brownian motion. V.1 Langevin dynamics

CHAPTER V. Brownian motion. V.1 Langevin dynamics CHAPTER V Brownian motion In this chapter, we study the very general paradigm provided by Brownian motion. Originally, this motion is that a heavy particle, called Brownian particle, immersed in a fluid

More information

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

Parameter Estimation of Mathematical Models Described by Differential Equations

Parameter Estimation of Mathematical Models Described by Differential Equations Parameter Estimation p.1/12 Parameter Estimation of Mathematical Models Described by Differential Equations Hossein Zivaripiran Department of Computer Science University of Toronto Outline Parameter Estimation

More information

Non-equilibrium phase transitions

Non-equilibrium phase transitions Non-equilibrium phase transitions An Introduction Lecture III Haye Hinrichsen University of Würzburg, Germany March 2006 Third Lecture: Outline 1 Directed Percolation Scaling Theory Langevin Equation 2

More information

New ideas in the non-equilibrium statistical physics and the micro approach to transportation flows

New ideas in the non-equilibrium statistical physics and the micro approach to transportation flows New ideas in the non-equilibrium statistical physics and the micro approach to transportation flows Plenary talk on the conference Stochastic and Analytic Methods in Mathematical Physics, Yerevan, Armenia,

More information

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li Numerical Methods for ODEs Lectures for PSU Summer Programs Xiantao Li Outline Introduction Some Challenges Numerical methods for ODEs Stiff ODEs Accuracy Constrained dynamics Stability Coarse-graining

More information

Towards a Theory of Transition Paths

Towards a Theory of Transition Paths Journal of Statistical Physics, Vol. 123, No. 3, May 2006 ( C 2006 ) DOI: 10.1007/s10955-005-9003-9 Towards a Theory of Transition Paths Weinan E 1 and Eric Vanden-Eijnden 2 Received July 19, 2005; accepted

More information

On the fast convergence of random perturbations of the gradient flow.

On the fast convergence of random perturbations of the gradient flow. On the fast convergence of random perturbations of the gradient flow. Wenqing Hu. 1 (Joint work with Chris Junchi Li 2.) 1. Department of Mathematics and Statistics, Missouri S&T. 2. Department of Operations

More information

Monte Carlo methods for kinetic equations

Monte Carlo methods for kinetic equations Monte Carlo methods for kinetic equations Lecture 4: Hybrid methods and variance reduction Lorenzo Pareschi Department of Mathematics & CMCS University of Ferrara Italy http://utenti.unife.it/lorenzo.pareschi/

More information

Theoretical Tutorial Session 2

Theoretical Tutorial Session 2 1 / 36 Theoretical Tutorial Session 2 Xiaoming Song Department of Mathematics Drexel University July 27, 216 Outline 2 / 36 Itô s formula Martingale representation theorem Stochastic differential equations

More information

Hypocoercivity for kinetic equations with linear relaxation terms

Hypocoercivity for kinetic equations with linear relaxation terms Hypocoercivity for kinetic equations with linear relaxation terms Jean Dolbeault dolbeaul@ceremade.dauphine.fr CEREMADE CNRS & Université Paris-Dauphine http://www.ceremade.dauphine.fr/ dolbeaul (A JOINT

More information

Brownian motion and the Central Limit Theorem

Brownian motion and the Central Limit Theorem Brownian motion and the Central Limit Theorem Amir Bar January 4, 3 Based on Shang-Keng Ma, Statistical Mechanics, sections.,.7 and the course s notes section 6. Introduction In this tutorial we shall

More information

Anomalous Transport and Fluctuation Relations: From Theory to Biology

Anomalous Transport and Fluctuation Relations: From Theory to Biology Anomalous Transport and Fluctuation Relations: From Theory to Biology Aleksei V. Chechkin 1, Peter Dieterich 2, Rainer Klages 3 1 Institute for Theoretical Physics, Kharkov, Ukraine 2 Institute for Physiology,

More information

TRANSPORT IN POROUS MEDIA

TRANSPORT IN POROUS MEDIA 1 TRANSPORT IN POROUS MEDIA G. ALLAIRE CMAP, Ecole Polytechnique 1. Introduction 2. Main result in an unbounded domain 3. Asymptotic expansions with drift 4. Two-scale convergence with drift 5. The case

More information

Capacitary inequalities in discrete setting and application to metastable Markov chains. André Schlichting

Capacitary inequalities in discrete setting and application to metastable Markov chains. André Schlichting Capacitary inequalities in discrete setting and application to metastable Markov chains André Schlichting Institute for Applied Mathematics, University of Bonn joint work with M. Slowik (TU Berlin) 12

More information