1 Quantum Monte Carlo Methods Jian-Sheng Wang Dept of Computational Science, National University of Singapore.

Slides:



Advertisements
Similar presentations
Review Of Statistical Mechanics
Advertisements

Lecture 13: Conformational Sampling: MC and MD Dr. Ronald M. Levy Contributions from Mike Andrec and Daniel Weinstock Statistical Thermodynamics.
Monte Carlo Methods and Statistical Physics
Introduction to Molecular Orbitals
Chapter 3 Electronic Structures
Ch 11. Sampling Models Pattern Recognition and Machine Learning, C. M. Bishop, Summarized by I.-H. Lee Biointelligence Laboratory, Seoul National.
Modern Monte Carlo Methods: (2) Histogram Reweighting (3) Transition Matrix Monte Carlo Jian-Sheng Wang National University of Singapore.
Lecture 3: Markov processes, master equation
Graduate School of Information Sciences, Tohoku University
BAYESIAN INFERENCE Sampling techniques
1 CE 530 Molecular Simulation Lecture 8 Markov Processes David A. Kofke Department of Chemical Engineering SUNY Buffalo
Computational statistics 2009 Random walk. Computational statistics 2009 Random walk with absorbing barrier.
1 Cluster Monte Carlo Algorithms & softening of first-order transition by disorder TIAN Liang.
Lattice regularized diffusion Monte Carlo
Monte Carlo Simulation of Ising Model and Phase Transition Studies
Quantum Monte Carlo for Electronic Structure Paul Kent Group Meeting - Friday 6th June 2003.
Wavefunctions and Energy Levels Since particles have wavelike properties cannot expect them to behave like point-like objects moving along precise trajectories.
Monte Carlo Methods in Partial Differential Equations.
6. Markov Chain. State Space The state space is the set of values a random variable X can take. E.g.: integer 1 to 6 in a dice experiment, or the locations.
Simulation of Random Walk How do we investigate this numerically? Choose the step length to be a=1 Use a computer to generate random numbers r i uniformly.
Advanced methods of molecular dynamics Monte Carlo methods
Computational Solid State Physics 計算物性学特論 第9回 9. Transport properties I: Diffusive transport.
Monte Carlo Methods: Basics
Classical and Quantum Monte Carlo Methods Or: Why we know as little as we do about interacting fermions Erez Berg Student/Postdoc Journal Club, Oct
Monte-Carlo simulations of the structure of complex liquids with various interaction potentials Alja ž Godec Advisers: prof. dr. Janko Jamnik and doc.
Computational Solid State Physics 計算物性学特論 第8回 8. Many-body effect II: Quantum Monte Carlo method.
Introduction to Monte Carlo Simulation. What is a Monte Carlo simulation? In a Monte Carlo simulation we attempt to follow the `time dependence’ of a.
F.F. Assaad. MPI-Stuttgart. Universität-Stuttgart Numerical approaches to the correlated electron problem: Quantum Monte Carlo.  The Monte.
Outline Review of extended ensemble methods (multi-canonical, Wang-Landau, flat-histogram, simulated tempering) Replica MC Connection to parallel tempering.
Quantum Monte Carlo Simulations of Mixed 3 He/ 4 He Clusters Dario Bressanini Universita’ degli.
9. Convergence and Monte Carlo Errors. Measuring Convergence to Equilibrium Variation distance where P 1 and P 2 are two probability distributions, A.
Dario Bressanini UNAM, Mexico City, Universita’ dell’Insubria, Como, Italy Introduction to Quantum Monte.
8. Selected Applications. Applications of Monte Carlo Method Structural and thermodynamic properties of matter [gas, liquid, solid, polymers, (bio)-macro-
Monte Carlo Methods So far we have discussed Monte Carlo methods based on a uniform distribution of random numbers on the interval [0,1] p(x) = 1 0  x.
Time-dependent Schrodinger Equation Numerical solution of the time-independent equation is straightforward constant energy solutions do not require us.
Path integral Monte Carlo
5. Formulation of Quantum Statistics
1 Cluster Monte Carlo Algorithms: Jian-Sheng Wang National University of Singapore.
NCN nanoHUB.org Wagner The basics of quantum Monte Carlo Lucas K. Wagner Computational Nanosciences Group University of California, Berkeley In collaboration.
Path Integral Quantum Monte Carlo Consider a harmonic oscillator potential a classical particle moves back and forth periodically in such a potential x(t)=
13. Extended Ensemble Methods. Slow Dynamics at First- Order Phase Transition At first-order phase transition, the longest time scale is controlled by.
7. Angular Momentum The order in which you rotate things makes a difference,  1  2   2  1 We can use this to work out commutation relations for the.
7. Metropolis Algorithm. Markov Chain and Monte Carlo Markov chain theory describes a particularly simple type of stochastic processes. Given a transition.
Last hour: Electron Spin Triplet electrons “avoid each other”, the WF of the system goes to zero if the two electrons approach each other. Consequence:
1/18/2016Atomic Scale Simulation1 Definition of Simulation What is a simulation? –It has an internal state “S” In classical mechanics, the state = positions.
A. Ambrosetti, F. Pederiva and E. Lipparini
Javier Junquera Importance sampling Monte Carlo. Cambridge University Press, Cambridge, 2002 ISBN Bibliography.
Vibrational Motion Harmonic motion occurs when a particle experiences a restoring force that is proportional to its displacement. F=-kx Where k is the.
Physical Fluctuomatics (Tohoku University) 1 Physical Fluctuomatics 13th Quantum-mechanical extensions of probabilistic information processing Kazuyuki.
Lecture 14: Advanced Conformational Sampling Dr. Ronald M. Levy Statistical Thermodynamics.
Kevin Stevenson AST 4762/5765. What is MCMC?  Random sampling algorithm  Estimates model parameters and their uncertainty  Only samples regions of.
Lecture 9. Many-Electron Atoms
Computational Physics (Lecture 11) PHY4061. Variation quantum Monte Carlo the approximate solution of the Hamiltonian Time Independent many-body Schrodinger’s.
Computational Physics (Lecture 10) PHY4370. Simulation Details To simulate Ising models First step is to choose a lattice. For example, we can us SC,
Ch.1. Elementary Quantum Chemistry
Introduction to Quantum Monte Carlo Methods 2! Claudio Attaccalite.
The Monte Carlo Method/ Markov Chains/ Metropolitan Algorithm from sec in “Adaptive Cooperative Systems” -summarized by Jinsan Yang.
Physical Fluctuomatics 13th Quantum-mechanical extensions of probabilistic information processing Kazuyuki Tanaka Graduate School of Information Sciences,
Computational Physics (Lecture 10)
Advanced Statistical Computing Fall 2016
 Heisenberg’s Matrix Mechanics Schrödinger’s Wave Mechanics
Introduction to Quantum Monte Carlo Methods
Maria Okuniewski Nuclear Engineering Dept.
10. Quantum Monte Carlo Methods
Markov chain monte carlo
Monte Carlo Methods in Scientific Computing
7. Metropolis Algorithm.
DIAGRAMMATIC MONTE CARLO:
VQMC J. Planelles.
Presentation transcript:

1 Quantum Monte Carlo Methods Jian-Sheng Wang Dept of Computational Science, National University of Singapore

2 Outline Introduction to Monte Carlo method Diffusion Quantum Monte Carlo Application to Quantum Dots Quantum to Classical --Trotter- Suzuki formula

3 Stanislaw Ulam ( ) S. Ulam is credited as the inventor of Monte Carlo method in 1940s, which solves mathematical problems using statistical sampling.

4 Nicholas Metropolis ( ) The algorithm by Metropolis (and A Rosenbluth, M Rosenbluth, A Teller and E Teller, 1953) has been cited as among the top 10 algorithms having the "greatest influence on the development and practice of science and engineering in the 20th century."

5 Markov Chain Monte Carlo Generate a sequence of states X 0, X 1, …, X n, such that the limiting distribution is given by P(X) Move X by the transition probability W(X -> X’) Starting from arbitrary P 0 (X), we have P n+1 (X) = ∑ X’ P n (X’) W(X’ -> X) P n (X) approaches P(X) as n go to ∞

6 Ergodicity [W n ](X - > X’) > 0 For all n > n max, all X and X’ Detailed Balance P(X) W(X -> X’) = P(X’) W(X’ -> X) Necessary and sufficient conditions for convergence

7 Taking Statistics After equilibration, we estimate: It is necessary that we take data for each sample or at uniform interval. It is an error to omit samples (condition on things).

8 Metropolis Algorithm (1953) Metropolis algorithm takes W(X->X’) = T(X->X’) min ( 1, P(X’)/P(X) ) where X ≠ X’, and T is a symmetric stochastic matrix T(X -> X’) = T(X’ -> X)

9 The Statistical Mechanics of Classical Gas/(complex) Fluids/Solids Compute multi-dimensional integral where potential energy

10 Advanced MC Techniques Cluster algorithms Histogram reweighting Transition matrix MC Extended ensemble methods (multi- canonical, replica MC, Wang-Landau method, etc)

11 2. Quantum Monte Carlo Method

12 Variational Principle For any trial wave-function Ψ, the expectation value of the Hamiltonian operator Ĥ provides an upper bound to the ground state energy E 0 :

13 Quantum Expectation by Monte Carlo where

14 Zero-Variance Principle The variance of E L (X) approaches zero as Ψ approaches the ground state wave- function Ψ 0. σ E 2 = - 2 ≈ - 2 = 0 Such property can be used to construct better algorithm (see Assaraf & Caffarel, PRL 83 (1999) 4682).

15 Schrödinger Equation in Imaginary Time Let  = it, the evolution becomes As  -> , only the ground state survive.

16 Diffusion Equation with Drift The Schrödinger equation in imaginary time  becomes a diffusion equation: We have let ħ=1, mass m =1 for N identical particles, X is set of all coordinates (may including spins). We also introduce a energy shift E T.

17 Fixed Node/Fixed Phase Approximation We introduce a non-negative function f, such that f = Ψ Φ T * ≥ 0 Ψ ΦTΦT f f is interpreted as walker density.

18 Equation for f

19 Monte Carlo Simulation of the Diffusion Equation If we have only the first term -½  2 f, it is a pure random walk. If we have first and second term, it describes a diffusion with drift velocity v. The last term represents birth- death of the walkers.

20 Walker Space X The population of the walkers is proportional to the solution f(X).

21 Diffusion Quantum Monte Carlo Algorithm 1.Initialize a population of walkers {X i } 2.X’ = X + η  ½ + v(X)  3.Duplicate X’ to M copies: M = int( ξ + exp[-  ((E L (X)+E L (X’))/2-E T ) ] ) 4.Compute statistics 5.Adjust E T to make average population constant.

22 Statistics The diffusion Quantum Monte Carlo provides estimator for where

23 Trial Wave-Function The common choice for interacting fermions (electrons) is the Slater- Jastrow form:

24 Example: Quantum Dots 2D electron gas with Coulomb interaction in magnetic field We have used atomic units: ħ=c=m=e=1.

25 Trial Wave-Function A Slater determinant of Fock-Darwin solution (J(X)=0): where L is Laguerre polynomial Energy level E n,m,s =(n+2|m|+1)h  + g  B (m+s)B

26 Six-Electrons Ground- state Energy Using parameters for GaAs. The (L,S) values are the total orbital angular momentum L and total Pauli spin S. From J S Wang, A D Güçlü and H Guo, unpublished

27 Addition Spectrum E N+1 -E N

28 Comparison of Electron Density Electron charge density from trial wavefunction (Slater determinant of Fock-Darwin solution), exact diagonalisation calculation, and QMC. N=5 L=6 S=3

29 QD - Disordered Potential Random gaussian peak perturbed quantum dot. From A D Güçlü, J-S Wang, H Guo, PRB 68 (2003)

30 Quantum System at Finite Temperature Partition function Expectation value

31 D Dimensional Quantum System to D+1 Dimensional Classical system Φ i is a complete set of wave-functions

32 Zassenhaus formula If the operators  and Bˆ are order 1/M, the error of the approximation is of order O(1/M 2 ).

33 Trotter-Suzuki Formula where  and Bˆ are non-commuting operators

34 Quantum Ising Chain in Transverse Field Hamiltonian where Pauli matrices at different sites commute.

35 Complete Set of States We choose the eigenstates of operator σ z : Insert the complete set in the products:

36 A Typical Term (i,k) Space direction Trotter or β direction

37 Classical Partition Function Note that K 1  1/M, K 2  log M for large M.

38 Summary Briefly introduced (classical) MC method Quantum MC (variational, diffusional, and Trotter-Suzuki) Application to quantum dot models