Monte Caro simulations

Size: px
Start display at page:

Download "Monte Caro simulations"

Transcription

1 Monte Caro simulations Monte Carlo methods - based on random numbers Stanislav Ulam s terminology - his uncle frequented the Casino in Monte Carlo Random (pseudo random) number generator on the computer Less glamorous than roulette tables or cards, but faster... >10 9 random numbers per second Monte Carlo simulations in statistical physics normally refers to importance sampling of configurations (e.g., spins) generating configurations with probability equal to the Boltzmann probability MC simulations show clearly how phase transitions can happen when N 30

2 Monte Carlo simulation of the Ising model The Metropolis algorithm [Metropolis, Rusenbluth, Rosenbluth, Teller, and Teller, Phys. Rev. 1953] Generate a series of configurations (Markov chain); C1 C2 C3 C4... Cn+1 obtained by modifying (updating) Cn changes satisfy the detailed-balance principle P change (A B) P change (B A) = W (B) W (A) = e E(A)/T W (A) Starting from any configuration, such a stochastic process leads to configurations distributed according to W the process has to be ergodic - any configuration reachable in principle it takes some time to reach equilibrium Metropolis algorithm for the Ising model. For each update perform: select a spin i at random; consider flipping it σi -σi compute the ratio R=W(σ1,...-σi,...,σN)/W(σ1,...σi,...,σN) - for this we need only the spins neighboring i generate random number 0<r 1; accept flip if r<r (go back to old config else) P change (A B) =P select (B A)P accept (B A) P select =1/N, P accept = min[w (B)/W (A), 1] These probabilities satisfy detailed balance 31

3 Symmetry breaking (magnetic phase transition) for h=0 A magnetized state, <m> 0, breaks a symmetry (E invariant under all σi -σi) strictly, mathematically we must have <m>=0 symmetry breaking (phase transition) can take place when N how can we understand the symmetry breaking for N large but finite? Time series of simulation data; magnetization vs simulation time for T<Tc M N = m = 1 N N i=1 σ i There is a characteristic reversal time between m>0 and m<0 configurations reversal time diverges for N the symmetry can be broken on practical time scales for finite (large) N also mechanism of phase transitions in real magnets (and other systems) 32

4 Another way to look at it: magnetization distribution probability distrubution (histogram) of m during the simulation m = 1 N N i=1 σ i single-peak distribution for T>Tc double-peak distribution for T<Tc peaks become sharper for increasing N no probability to fluctuate between m<0 and m>0 peaks for N - have to go through low-probability m 0 configurations Why this peak structure? balance between large number of m 0 configurations with high energy small number of m 1 configuration with low energy entropy dominates at hight T, internal energy at low T F = E ST 33

5 Binder ratios and cumulants Consider the dimensionless ratio R 2 = m4 m 2 2 We can compute R2 exactly for N for T<Tc: P(m) δ(m-m*)+δ(m+m*) m*= peak m-value R2 1 for T>Tc: P(m) exp[-m 2 /a(n)] a(n) N -1 R2 3 (properties of Gaussian integrals) The Binder cumulant is defined as (n-component order parameter; n=1 for Ising) U 2 = 3 ( n +1 n ) { 1, T < R Tc 2 0, T > T c 2D Ising model; MC results Curves for different L normally cross each other close to Tc Extrapolate crossing for sizes L and 2L to infinite size converges faster than single-size Tc defs. 34

6 Computing expectation values and their statistical errors Definition: Monte Carlo sweep = N spin-flip attempts a natural unit of simulation time measure observables after every (or every n) sweep Boltzmann probability accounted for at sampling stage Q = 1 N s N s i=1 Q i, N s = number of samples is the estimate for the true expectation value; Q Q, (N s ) Statistical errors (error bars): Q = Q ± σ Q the measurements are not statistically independent independent only after a number of sweeps >> autocorrelation time Divide the simulation into B bins, M sweeps in each bin; Ns=BM bin averages: Qb,b=1,..., B Q = 1 B Q b, σ 2 1 B Q = ( B B(B 1) Q b Q) 2 b=1 If M is sufficiently large (>> autocorrelation time) the average and error are statistically sounds (corresonding to independent Gaussian-distributed data) probability of true value being inside the error bars 2/3 b=1 35

7 Autocorrelation functions characterization of how measurements become statistically independent A Q (t) = Q(i + t)q(i) Q 2 Q 2 Q 2, ( e t/θ,t ) the autocorrelation time Θ grows as T Tc (diverges for N, T Tc) T/J=3.0 > Tc! T/J = = Tc! This problem can be largely overcome by using cluster algorithms for standard Ising, XY, Heisenberg,... but not in all cases, e.g., in the presence of external fields, frustrated systems,... 36

3.320 Lecture 18 (4/12/05)

3.320 Lecture 18 (4/12/05) 3.320 Lecture 18 (4/12/05) Monte Carlo Simulation II and free energies Figure by MIT OCW. General Statistical Mechanics References D. Chandler, Introduction to Modern Statistical Mechanics D.A. McQuarrie,

More information

Numerical Analysis of 2-D Ising Model. Ishita Agarwal Masters in Physics (University of Bonn) 17 th March 2011

Numerical Analysis of 2-D Ising Model. Ishita Agarwal Masters in Physics (University of Bonn) 17 th March 2011 Numerical Analysis of 2-D Ising Model By Ishita Agarwal Masters in Physics (University of Bonn) 17 th March 2011 Contents Abstract Acknowledgment Introduction Computational techniques Numerical Analysis

More information

Guiding Monte Carlo Simulations with Machine Learning

Guiding Monte Carlo Simulations with Machine Learning Guiding Monte Carlo Simulations with Machine Learning Yang Qi Department of Physics, Massachusetts Institute of Technology Joining Fudan University in 2017 KITS, June 29 2017. 1/ 33 References Works led

More information

Copyright 2001 University of Cambridge. Not to be quoted or copied without permission.

Copyright 2001 University of Cambridge. Not to be quoted or copied without permission. Course MP3 Lecture 4 13/11/2006 Monte Carlo method I An introduction to the use of the Monte Carlo method in materials modelling Dr James Elliott 4.1 Why Monte Carlo? The name derives from the association

More information

Their Statistical Analvsis. With Web-Based Fortran Code. Berg

Their Statistical Analvsis. With Web-Based Fortran Code. Berg Markov Chain Monter rlo Simulations and Their Statistical Analvsis With Web-Based Fortran Code Bernd A. Berg Florida State Univeisitfi USA World Scientific NEW JERSEY + LONDON " SINGAPORE " BEIJING " SHANGHAI

More information

Self-learning Monte Carlo Method

Self-learning Monte Carlo Method Self-learning Monte Carlo Method Zi Yang Meng ( 孟子杨 ) http://ziyangmeng.iphy.ac.cn/ Know thyself "Know thyself" (Greek: γνῶθι σεαυτόν, gnothi seauton) one of the Delphic maxims and was inscribed in the

More information

Markov Chain Monte Carlo Simulations and Their Statistical Analysis An Overview

Markov Chain Monte Carlo Simulations and Their Statistical Analysis An Overview Markov Chain Monte Carlo Simulations and Their Statistical Analysis An Overview Bernd Berg FSU, August 30, 2005 Content 1. Statistics as needed 2. Markov Chain Monte Carlo (MC) 3. Statistical Analysis

More information

Fig. 1 Cluster flip: before. The region inside the dotted line is flipped in one Wolff move. Let this configuration be A.

Fig. 1 Cluster flip: before. The region inside the dotted line is flipped in one Wolff move. Let this configuration be A. Physics 6562: Statistical Mechanics http://www.physics.cornell.edu/sethna/teaching/562/ In Class Exercises Last correction at March 25, 2017, 1:37 pm c 2017, James Sethna, all rights reserved 1. Detailed

More information

Classical Monte Carlo Simulations

Classical Monte Carlo Simulations Classical Monte Carlo Simulations Hyejin Ju April 17, 2012 1 Introduction Why do we need numerics? One of the main goals of condensed matter is to compute expectation values O = 1 Z Tr{O e βĥ} (1) and

More information

Lecture V: Multicanonical Simulations.

Lecture V: Multicanonical Simulations. Lecture V: Multicanonical Simulations. 1. Multicanonical Ensemble 2. How to get the Weights? 3. Example Runs (2d Ising and Potts models) 4. Re-Weighting to the Canonical Ensemble 5. Energy and Specific

More information

Physics 115/242 Monte Carlo simulations in Statistical Physics

Physics 115/242 Monte Carlo simulations in Statistical Physics Physics 115/242 Monte Carlo simulations in Statistical Physics Peter Young (Dated: May 12, 2007) For additional information on the statistical Physics part of this handout, the first two sections, I strongly

More information

Phase transitions and finite-size scaling

Phase transitions and finite-size scaling Phase transitions and finite-size scaling Critical slowing down and cluster methods. Theory of phase transitions/ RNG Finite-size scaling Detailed treatment: Lectures on Phase Transitions and the Renormalization

More information

Monte Carlo Methods in High Energy Physics I

Monte Carlo Methods in High Energy Physics I Helmholtz International Workshop -- CALC 2009, July 10--20, Dubna Monte Carlo Methods in High Energy Physics CALC2009 - July 20 10, Dubna 2 Contents 3 Introduction Simple definition: A Monte Carlo technique

More information

Quantum Annealing in spin glasses and quantum computing Anders W Sandvik, Boston University

Quantum Annealing in spin glasses and quantum computing Anders W Sandvik, Boston University PY502, Computational Physics, December 12, 2017 Quantum Annealing in spin glasses and quantum computing Anders W Sandvik, Boston University Advancing Research in Basic Science and Mathematics Example:

More information

LECTURE 10: Monte Carlo Methods II

LECTURE 10: Monte Carlo Methods II 1 LECTURE 10: Monte Carlo Methods II In this chapter, we discuss more advanced Monte Carlo techniques, starting with the topics of percolation and random walks, and then continuing to equilibrium statistical

More information

Markov Processes. Stochastic process. Markov process

Markov Processes. Stochastic process. Markov process Markov Processes Stochastic process movement through a series of well-defined states in a way that involves some element of randomness for our purposes, states are microstates in the governing ensemble

More information

Advanced Monte Carlo Methods Problems

Advanced Monte Carlo Methods Problems Advanced Monte Carlo Methods Problems September-November, 2012 Contents 1 Integration with the Monte Carlo method 2 1.1 Non-uniform random numbers.......................... 2 1.2 Gaussian RNG..................................

More information

ICCP Project 2 - Advanced Monte Carlo Methods Choose one of the three options below

ICCP Project 2 - Advanced Monte Carlo Methods Choose one of the three options below ICCP Project 2 - Advanced Monte Carlo Methods Choose one of the three options below Introduction In statistical physics Monte Carlo methods are considered to have started in the Manhattan project (1940

More information

Monte Carlo Simulation of the Ising Model. Abstract

Monte Carlo Simulation of the Ising Model. Abstract Monte Carlo Simulation of the Ising Model Saryu Jindal 1 1 Department of Chemical Engineering and Material Sciences, University of California, Davis, CA 95616 (Dated: June 9, 2007) Abstract This paper

More information

Monte Carlo study of the Baxter-Wu model

Monte Carlo study of the Baxter-Wu model Monte Carlo study of the Baxter-Wu model Nir Schreiber and Dr. Joan Adler Monte Carlo study of the Baxter-Wu model p.1/40 Outline Theory of phase transitions, Monte Carlo simulations and finite size scaling

More information

Phase Transitions in Spin Glasses

Phase Transitions in Spin Glasses Phase Transitions in Spin Glasses Peter Young Talk available at http://physics.ucsc.edu/ peter/talks/sinica.pdf e-mail:peter@physics.ucsc.edu Supported by the Hierarchical Systems Research Foundation.

More information

Directional Ordering in the Classical Compass Model in Two and Three Dimensions

Directional Ordering in the Classical Compass Model in Two and Three Dimensions Institut für Theoretische Physik Fakultät für Physik und Geowissenschaften Universität Leipzig Diplomarbeit Directional Ordering in the Classical Compass Model in Two and Three Dimensions vorgelegt von

More information

Critical Dynamics of Two-Replica Cluster Algorithms

Critical Dynamics of Two-Replica Cluster Algorithms University of Massachusetts Amherst From the SelectedWorks of Jonathan Machta 2001 Critical Dynamics of Two-Replica Cluster Algorithms X. N. Li Jonathan Machta, University of Massachusetts Amherst Available

More information

Metropolis Monte Carlo simulation of the Ising Model

Metropolis Monte Carlo simulation of the Ising Model Metropolis Monte Carlo simulation of the Ising Model Krishna Shrinivas (CH10B026) Swaroop Ramaswamy (CH10B068) May 10, 2013 Modelling and Simulation of Particulate Processes (CH5012) Introduction The Ising

More information

Parallel Tempering Algorithm in Monte Carlo Simulation

Parallel Tempering Algorithm in Monte Carlo Simulation Parallel Tempering Algorithm in Monte Carlo Simulation Tony Cheung (CUHK) Kevin Zhao (CUHK) Mentors: Ying Wai Li (ORNL) Markus Eisenbach (ORNL) Kwai Wong (UTK/ORNL) Metropolis Algorithm on Ising Model

More information

Kinetic Monte Carlo (KMC) Kinetic Monte Carlo (KMC)

Kinetic Monte Carlo (KMC) Kinetic Monte Carlo (KMC) Kinetic Monte Carlo (KMC) Molecular Dynamics (MD): high-frequency motion dictate the time-step (e.g., vibrations). Time step is short: pico-seconds. Direct Monte Carlo (MC): stochastic (non-deterministic)

More information

Hanoi 7/11/2018. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam.

Hanoi 7/11/2018. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. Hanoi 7/11/2018 Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. Finite size effects and Reweighting methods 1. Finite size effects 2. Single histogram method 3. Multiple histogram method 4. Wang-Landau

More information

Quantum and classical annealing in spin glasses and quantum computing. Anders W Sandvik, Boston University

Quantum and classical annealing in spin glasses and quantum computing. Anders W Sandvik, Boston University NATIONAL TAIWAN UNIVERSITY, COLLOQUIUM, MARCH 10, 2015 Quantum and classical annealing in spin glasses and quantum computing Anders W Sandvik, Boston University Cheng-Wei Liu (BU) Anatoli Polkovnikov (BU)

More information

Monte Carlo and cold gases. Lode Pollet.

Monte Carlo and cold gases. Lode Pollet. Monte Carlo and cold gases Lode Pollet lpollet@physics.harvard.edu 1 Outline Classical Monte Carlo The Monte Carlo trick Markov chains Metropolis algorithm Ising model critical slowing down Quantum Monte

More information

8 Error analysis: jackknife & bootstrap

8 Error analysis: jackknife & bootstrap 8 Error analysis: jackknife & bootstrap As discussed before, it is no problem to calculate the expectation values and statistical error estimates of normal observables from Monte Carlo. However, often

More information

Quantum spin systems - models and computational methods

Quantum spin systems - models and computational methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Quantum spin systems - models and computational methods Anders W. Sandvik, Boston University Lecture outline Introduction

More information

Cluster Algorithms to Reduce Critical Slowing Down

Cluster Algorithms to Reduce Critical Slowing Down Cluster Algorithms to Reduce Critical Slowing Down Monte Carlo simulations close to a phase transition are affected by critical slowing down. In the 2-D Ising system, the correlation length ξ becomes very

More information

4. Cluster update algorithms

4. Cluster update algorithms 4. Cluster update algorithms Cluster update algorithms are the most succesful global update methods in use. These methods update the variables globally, in one step, whereas the standard local methods

More information

Topological defects and its role in the phase transition of a dense defect system

Topological defects and its role in the phase transition of a dense defect system Topological defects and its role in the phase transition of a dense defect system Suman Sinha * and Soumen Kumar Roy Depatrment of Physics, Jadavpur University Kolkata- 70003, India Abstract Monte Carlo

More information

Graphical Representations and Cluster Algorithms

Graphical Representations and Cluster Algorithms Graphical Representations and Cluster Algorithms Jon Machta University of Massachusetts Amherst Newton Institute, March 27, 2008 Outline Introduction to graphical representations and cluster algorithms

More information

Random Walks A&T and F&S 3.1.2

Random Walks A&T and F&S 3.1.2 Random Walks A&T 110-123 and F&S 3.1.2 As we explained last time, it is very difficult to sample directly a general probability distribution. - If we sample from another distribution, the overlap will

More information

Markov Chain Monte Carlo Method

Markov Chain Monte Carlo Method Markov Chain Monte Carlo Method Macoto Kikuchi Cybermedia Center, Osaka University 6th July 2017 Thermal Simulations 1 Why temperature 2 Statistical mechanics in a nutshell 3 Temperature in computers 4

More information

A New Algorithm for Monte Carlo Simulation of king Spin Systems* A. B. BORTZ M. H. KALOS J. L. LEBOWITZ

A New Algorithm for Monte Carlo Simulation of king Spin Systems* A. B. BORTZ M. H. KALOS J. L. LEBOWITZ JOURNAL OF COMPUTATIONAL PHYSICS 17, lo-18 (1975) A New Algorithm for Monte Carlo Simulation of king Spin Systems* A. B. BORTZ Berfer Graduate School of Science, Yeshiva University, New York, New York

More information

Is there a de Almeida-Thouless line in finite-dimensional spin glasses? (and why you should care)

Is there a de Almeida-Thouless line in finite-dimensional spin glasses? (and why you should care) Is there a de Almeida-Thouless line in finite-dimensional spin glasses? (and why you should care) Peter Young Talk at MPIPKS, September 12, 2013 Available on the web at http://physics.ucsc.edu/~peter/talks/mpipks.pdf

More information

The Monte Carlo Algorithm

The Monte Carlo Algorithm The Monte Carlo Algorithm This algorithm was invented by N. Metropolis, A.W. Rosenbluth, M.N. Rosenbluth, A.H. Teller, and E. Teller, J. Chem. Phys., 21, 1087 (1953). It was listed as one of the The Top

More information

A = {(x, u) : 0 u f(x)},

A = {(x, u) : 0 u f(x)}, Draw x uniformly from the region {x : f(x) u }. Markov Chain Monte Carlo Lecture 5 Slice sampler: Suppose that one is interested in sampling from a density f(x), x X. Recall that sampling x f(x) is equivalent

More information

GPU-based computation of the Monte Carlo simulation of classical spin systems

GPU-based computation of the Monte Carlo simulation of classical spin systems Perspectives of GPU Computing in Physics and Astrophysics, Sapienza University of Rome, Rome, Italy, September 15-17, 2014 GPU-based computation of the Monte Carlo simulation of classical spin systems

More information

Spin waves in the classical Heisenberg antiferromagnet on the kagome lattice

Spin waves in the classical Heisenberg antiferromagnet on the kagome lattice Journal of Physics: Conference Series Spin waves in the classical Heisenberg antiferromagnet on the kagome lattice To cite this article: Stefan Schnabel and David P Landau J. Phys.: Conf. Ser. 4 View the

More information

arxiv: v2 [cond-mat.stat-mech] 13 Oct 2010

arxiv: v2 [cond-mat.stat-mech] 13 Oct 2010 Markov Chain Monte Carlo Method without Detailed Balance Hidemaro Suwa 1 and Synge Todo 1,2 1 Department of Applied Physics, University of Tokyo, Tokyo 113-8656, Japan 2 CREST, Japan Science and Technology

More information

Computational Physics (6810): Session 13

Computational Physics (6810): Session 13 Computational Physics (6810): Session 13 Dick Furnstahl Nuclear Theory Group OSU Physics Department April 14, 2017 6810 Endgame Various recaps and followups Random stuff (like RNGs :) Session 13 stuff

More information

Irreversible Markov-Chain Monte Carlo methods

Irreversible Markov-Chain Monte Carlo methods Irreversible Markov-Chain Monte Carlo methods Koji HUKUSHIMA Department of Basic Science, University of Tokyo 3-8-1 Komaba, Meguro-ku, Tokyo 153-8902 Abstract We review irreversible Markov chain Monte

More information

Progress toward a Monte Carlo Simulation of the Ice VI-VII Phase Transition

Progress toward a Monte Carlo Simulation of the Ice VI-VII Phase Transition Progress toward a Monte Carlo Simulation of the Ice VI-VII Phase Transition Christina Gower 2010 NSF/REU PROJECT Physics Department University of Notre Dame Advisor: Dr. Kathie E. Newman August 6, 2010

More information

Monte Carlo importance sampling and Markov chain

Monte Carlo importance sampling and Markov chain Monte Carlo importance sampling and Markov chain If a configuration in phase space is denoted by X, the probability for configuration according to Boltzman is ρ(x) e βe(x) β = 1 T (1) How to sample over

More information

Stochastic series expansion (SSE) and ground-state projection

Stochastic series expansion (SSE) and ground-state projection Institute of Physics, Chinese Academy of Sciences, Beijing, October 31, 2014 Stochastic series expansion (SSE) and ground-state projection Anders W Sandvik, Boston University Review article on quantum

More information

Spontaneous Symmetry Breaking

Spontaneous Symmetry Breaking Spontaneous Symmetry Breaking Second order phase transitions are generally associated with spontaneous symmetry breaking associated with an appropriate order parameter. Identifying symmetry of the order

More information

Observation of topological phenomena in a programmable lattice of 1800 superconducting qubits

Observation of topological phenomena in a programmable lattice of 1800 superconducting qubits Observation of topological phenomena in a programmable lattice of 18 superconducting qubits Andrew D. King Qubits North America 218 Nature 56 456 46, 218 Interdisciplinary teamwork Theory Simulation QA

More information

J ij S i S j B i S i (1)

J ij S i S j B i S i (1) LECTURE 18 The Ising Model (References: Kerson Huang, Statistical Mechanics, Wiley and Sons (1963) and Colin Thompson, Mathematical Statistical Mechanics, Princeton Univ. Press (1972)). One of the simplest

More information

Generalized Ensembles: Multicanonical Simulations

Generalized Ensembles: Multicanonical Simulations Generalized Ensembles: Multicanonical Simulations 1. Multicanonical Ensemble 2. How to get the Weights? 3. Example Runs and Re-Weighting to the Canonical Ensemble 4. Energy and Specific Heat Calculation

More information

L échantillonnage parfait: un nouveau paradigme des calculs de Monte Carlo

L échantillonnage parfait: un nouveau paradigme des calculs de Monte Carlo L échantillonnage parfait: un nouveau paradigme des calculs de Monte Carlo Séminaire général Département de Physique Ecole normale supérieure Werner Krauth Laboratoire de physique statistique Ecole normale

More information

Wang-Landau sampling for Quantum Monte Carlo. Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart

Wang-Landau sampling for Quantum Monte Carlo. Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart Wang-Landau sampling for Quantum Monte Carlo Stefan Wessel Institut für Theoretische Physik III Universität Stuttgart Overview Classical Monte Carlo First order phase transitions Classical Wang-Landau

More information

Quantum Monte Carlo. Matthias Troyer, ETH Zürich

Quantum Monte Carlo. Matthias Troyer, ETH Zürich Quantum Monte Carlo Matthias Troyer, ETH Zürich 1 1. Monte Carlo Integration 2 Integrating a function Convert the integral to a discrete sum b! f (x)dx = b " a N a N ' i =1 # f a + i b " a % $ N & + O(1/N)

More information

PY 502, Computational Physics, Fall 2017 Monte Carlo simulations in classical statistical physics

PY 502, Computational Physics, Fall 2017 Monte Carlo simulations in classical statistical physics PY 502, Computational Physics, Fall 2017 Monte Carlo simulations in classical statistical physics Anders W. Sandvik, Department of Physics, Boston University 1 Introduction Monte Carlo simulation is a

More information

Janus: FPGA Based System for Scientific Computing Filippo Mantovani

Janus: FPGA Based System for Scientific Computing Filippo Mantovani Janus: FPGA Based System for Scientific Computing Filippo Mantovani Physics Department Università degli Studi di Ferrara Ferrara, 28/09/2009 Overview: 1. The physical problem: - Ising model and Spin Glass

More information

Monte-Carlo simulation of small 2D Ising lattice with Metropolis dynamics

Monte-Carlo simulation of small 2D Ising lattice with Metropolis dynamics Monte-Carlo simulation of small 2D Ising lattice with Metropolis dynamics Paul Secular Imperial College London (Dated: 6th February 2015) Results of a Monte-Carlo simulation of the nearest-neighbour Ising

More information

Effective theories for QCD at finite temperature and density from strong coupling

Effective theories for QCD at finite temperature and density from strong coupling XQCD 2011 San Carlos, July 2011 Effective theories for QCD at finite temperature and density from strong coupling Owe Philipsen Introduction to strong coupling expansions SCE for finite temperature: free

More information

Typical quantum states at finite temperature

Typical quantum states at finite temperature Typical quantum states at finite temperature How should one think about typical quantum states at finite temperature? Density Matrices versus pure states Why eigenstates are not typical Measuring the heat

More information

Monte Carlo Simulation of Spins

Monte Carlo Simulation of Spins Monte Carlo Simulation of Spins Aiichiro Nakano Collaboratory for Advanced Computing & Simulations Department of Computer Science Department of Physics & Astronomy Department of Chemical Engineering &

More information

Improvement of Monte Carlo estimates with covariance-optimized finite-size scaling at fixed phenomenological coupling

Improvement of Monte Carlo estimates with covariance-optimized finite-size scaling at fixed phenomenological coupling Improvement of Monte Carlo estimates with covariance-optimized finite-size scaling at fixed phenomenological coupling Francesco Parisen Toldin Max Planck Institute for Physics of Complex Systems Dresden

More information

Paul Karapanagiotidis ECO4060

Paul Karapanagiotidis ECO4060 Paul Karapanagiotidis ECO4060 The way forward 1) Motivate why Markov-Chain Monte Carlo (MCMC) is useful for econometric modeling 2) Introduce Markov-Chain Monte Carlo (MCMC) - Metropolis-Hastings (MH)

More information

Sampling Methods (11/30/04)

Sampling Methods (11/30/04) CS281A/Stat241A: Statistical Learning Theory Sampling Methods (11/30/04) Lecturer: Michael I. Jordan Scribe: Jaspal S. Sandhu 1 Gibbs Sampling Figure 1: Undirected and directed graphs, respectively, with

More information

Paramagnetic phases of Kagome lattice quantum Ising models p.1/16

Paramagnetic phases of Kagome lattice quantum Ising models p.1/16 Paramagnetic phases of Kagome lattice quantum Ising models Predrag Nikolić In collaboration with T. Senthil Massachusetts Institute of Technology Paramagnetic phases of Kagome lattice quantum Ising models

More information

Rensselaer Polytechnic Institute, 110 8th Street, Troy, NY , USA. Florida State University, Tallahassee, Florida , USA

Rensselaer Polytechnic Institute, 110 8th Street, Troy, NY , USA. Florida State University, Tallahassee, Florida , USA 5 Dynamic Phase Diagram for a Periodically Driven Kinetic Square-lattice Ising Ferromagnet: Finite-size Scaling Evidence for the Absence of a Tri-critical Point G. Korniss 1, P.A. Rikvold 2,3, and M.A.

More information

Advanced Sampling Algorithms

Advanced Sampling Algorithms + Advanced Sampling Algorithms + Mobashir Mohammad Hirak Sarkar Parvathy Sudhir Yamilet Serrano Llerena Advanced Sampling Algorithms Aditya Kulkarni Tobias Bertelsen Nirandika Wanigasekara Malay Singh

More information

VSOP19, Quy Nhon 3-18/08/2013. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam.

VSOP19, Quy Nhon 3-18/08/2013. Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. VSOP19, Quy Nhon 3-18/08/2013 Ngo Van Thanh, Institute of Physics, Hanoi, Vietnam. Part III. Finite size effects and Reweighting methods III.1. Finite size effects III.2. Single histogram method III.3.

More information

Phase Transitions in Spin Glasses

Phase Transitions in Spin Glasses p.1 Phase Transitions in Spin Glasses Peter Young http://physics.ucsc.edu/ peter/talks/bifi2008.pdf e-mail:peter@physics.ucsc.edu Work supported by the and the Hierarchical Systems Research Foundation.

More information

INTRODUCTION TO MARKOV CHAIN MONTE CARLO SIMULATIONS AND THEIR STATISTICAL ANALYSIS

INTRODUCTION TO MARKOV CHAIN MONTE CARLO SIMULATIONS AND THEIR STATISTICAL ANALYSIS INTRODUCTION TO MARKOV CHAIN MONTE CARLO SIMULATIONS AND THEIR STATISTICAL ANALYSIS Bernd A. Berg Department of Physics Florida State University Tallahassee, Florida 32306-4350, USA and School of Computational

More information

Wang-Landau Monte Carlo simulation. Aleš Vítek IT4I, VP3

Wang-Landau Monte Carlo simulation. Aleš Vítek IT4I, VP3 Wang-Landau Monte Carlo simulation Aleš Vítek IT4I, VP3 PART 1 Classical Monte Carlo Methods Outline 1. Statistical thermodynamics, ensembles 2. Numerical evaluation of integrals, crude Monte Carlo (MC)

More information

Local persistense and blocking in the two dimensional Blume-Capel Model arxiv:cond-mat/ v1 [cond-mat.stat-mech] 4 Apr 2004.

Local persistense and blocking in the two dimensional Blume-Capel Model arxiv:cond-mat/ v1 [cond-mat.stat-mech] 4 Apr 2004. Local persistense and blocking in the two dimensional Blume-Capel Model arxiv:cond-mat/0404082v1 [cond-mat.stat-mech] 4 Apr 2004 Roberto da Silva Departamento de Informática Teórica, Instituto de Informática,

More information

André Schleife Department of Materials Science and Engineering

André Schleife Department of Materials Science and Engineering André Schleife Department of Materials Science and Engineering Length Scales (c) ICAMS: http://www.icams.de/cms/upload/01_home/01_research_at_icams/length_scales_1024x780.png Goals for today: Background

More information

Matrix-Product states: Properties and Extensions

Matrix-Product states: Properties and Extensions New Development of Numerical Simulations in Low-Dimensional Quantum Systems: From Density Matrix Renormalization Group to Tensor Network Formulations October 27-29, 2010, Yukawa Institute for Theoretical

More information

CS 781 Lecture 9 March 10, 2011 Topics: Local Search and Optimization Metropolis Algorithm Greedy Optimization Hopfield Networks Max Cut Problem Nash

CS 781 Lecture 9 March 10, 2011 Topics: Local Search and Optimization Metropolis Algorithm Greedy Optimization Hopfield Networks Max Cut Problem Nash CS 781 Lecture 9 March 10, 2011 Topics: Local Search and Optimization Metropolis Algorithm Greedy Optimization Hopfield Networks Max Cut Problem Nash Equilibrium Price of Stability Coping With NP-Hardness

More information

A Monte Carlo Implementation of the Ising Model in Python

A Monte Carlo Implementation of the Ising Model in Python A Monte Carlo Implementation of the Ising Model in Python Alexey Khorev alexey.s.khorev@gmail.com 2017.08.29 Contents 1 Theory 1 1.1 Introduction...................................... 1 1.2 Model.........................................

More information

Metropolis/Variational Monte Carlo. Microscopic Theories of Nuclear Structure, Dynamics and Electroweak Currents June 12-30, 2017, ECT*, Trento, Italy

Metropolis/Variational Monte Carlo. Microscopic Theories of Nuclear Structure, Dynamics and Electroweak Currents June 12-30, 2017, ECT*, Trento, Italy Metropolis/Variational Monte Carlo Stefano Gandolfi Los Alamos National Laboratory (LANL) Microscopic Theories of Nuclear Structure, Dynamics and Electroweak Currents June 12-30, 2017, ECT*, Trento, Italy

More information

Simulation of the two-dimensional square-lattice Lenz-Ising model in Python

Simulation of the two-dimensional square-lattice Lenz-Ising model in Python Senior Thesis Simulation of the two-dimensional square-lattice Lenz-Ising model in Python Author: Richard Munroe Advisor: Dr. Edward Brash 2012-10-17 Abstract A program to simulate the the two-dimensional

More information

Markov Chain Monte Carlo The Metropolis-Hastings Algorithm

Markov Chain Monte Carlo The Metropolis-Hastings Algorithm Markov Chain Monte Carlo The Metropolis-Hastings Algorithm Anthony Trubiano April 11th, 2018 1 Introduction Markov Chain Monte Carlo (MCMC) methods are a class of algorithms for sampling from a probability

More information

Computational Statistical Physics

Computational Statistical Physics Computational Statistical Physics Lecture Notes After a lecture by H.J. Herrmann written by Nicola Offeddu Marcel Thielmann Madis Ollikainen Summer Semester 2014 Preface This is the first part of a provvisory

More information

3. General properties of phase transitions and the Landau theory

3. General properties of phase transitions and the Landau theory 3. General properties of phase transitions and the Landau theory In this Section we review the general properties and the terminology used to characterise phase transitions, which you will have already

More information

Efficiency of Parallel Tempering for Ising Systems

Efficiency of Parallel Tempering for Ising Systems University of Massachusetts Amherst ScholarWorks@UMass Amherst Masters Theses 1911 - February 2014 2010 Efficiency of Parallel Tempering for Ising Systems Stephan Burkhardt University of Massachusetts

More information

Introduction to the Renormalization Group

Introduction to the Renormalization Group Introduction to the Renormalization Group Gregory Petropoulos University of Colorado Boulder March 4, 2015 1 / 17 Summary Flavor of Statistical Physics Universality / Critical Exponents Ising Model Renormalization

More information

Lab 70 in TFFM08. Curie & Ising

Lab 70 in TFFM08. Curie & Ising IFM The Department of Physics, Chemistry and Biology Lab 70 in TFFM08 Curie & Ising NAME PERS. -NUMBER DATE APPROVED Rev Aug 09 Agne 1 Introduction Magnetic materials are all around us, and understanding

More information

Multiple time step Monte Carlo

Multiple time step Monte Carlo JOURNAL OF CHEMICAL PHYSICS VOLUME 117, NUMBER 18 8 NOVEMBER 2002 Multiple time step Monte Carlo Balázs Hetényi a) Department of Chemistry, Princeton University, Princeton, NJ 08544 and Department of Chemistry

More information

Classical Monte-Carlo simulations

Classical Monte-Carlo simulations Classical Monte-Carlo simulations Graduate Summer Institute Complex Plasmas at the Stevens Insitute of Technology Henning Baumgartner, A. Filinov, H. Kählert, P. Ludwig and M. Bonitz Christian-Albrechts-University

More information

Monte Carlo Simulation of the 2D Ising model

Monte Carlo Simulation of the 2D Ising model Monte Carlo Simulation of the 2D Ising model Emanuel Schmidt, F44 April 6, 2 Introduction Monte Carlo methods are a powerful tool to solve problems numerically which are dicult to be handled analytically.

More information

Markov Chains and MCMC

Markov Chains and MCMC Markov Chains and MCMC Markov chains Let S = {1, 2,..., N} be a finite set consisting of N states. A Markov chain Y 0, Y 1, Y 2,... is a sequence of random variables, with Y t S for all points in time

More information

E = <ij> N 2. (0.3) (so that k BT

E = <ij> N 2. (0.3) (so that k BT Phys 4 Project solutions. November 4, 7 Note the model and units Quantities The D Ising model has the total energy E written in terms of the spins σ i = ± site i, E = σ i σ j (.) where < ij > indicates

More information

Variational Autoencoders for Classical Spin Models

Variational Autoencoders for Classical Spin Models Variational Autoencoders for Classical Spin Models Benjamin Nosarzewski Stanford University bln@stanford.edu Abstract Lattice spin models are used to study the magnetic behavior of interacting electrons

More information

Monte Carlo simulation calculation of the critical coupling constant for two-dimensional continuum 4 theory

Monte Carlo simulation calculation of the critical coupling constant for two-dimensional continuum 4 theory Monte Carlo simulation calculation of the critical coupling constant for two-dimensional continuum 4 theory Will Loinaz * Institute for Particle Physics and Astrophysics, Physics Department, Virginia Tech,

More information

Phase Transitions of Random Binary Magnetic Square Lattice Ising Systems

Phase Transitions of Random Binary Magnetic Square Lattice Ising Systems I. Q. Sikakana Department of Physics and Non-Destructive Testing, Vaal University of Technology, Vanderbijlpark, 1900, South Africa e-mail: ike@vut.ac.za Abstract Binary magnetic square lattice Ising system

More information

Answers and expectations

Answers and expectations Answers and expectations For a function f(x) and distribution P(x), the expectation of f with respect to P is The expectation is the average of f, when x is drawn from the probability distribution P E

More information

Binder Cumulants for the Ising Model using Worm algorithms

Binder Cumulants for the Ising Model using Worm algorithms Trinity College The University of Dublin Theoretical Physics Final Year Project Binder Cumulants for the Ising Model using Worm algorithms Author: Ruairí Brett Supervisor: Prof. John Bulava March 2015

More information

Evaporation/Condensation of Ising Droplets

Evaporation/Condensation of Ising Droplets , Elmar Bittner and Wolfhard Janke Institut für Theoretische Physik, Universität Leipzig, Augustusplatz 10/11, D-04109 Leipzig, Germany E-mail: andreas.nussbaumer@itp.uni-leipzig.de Recently Biskup et

More information

Wang-Landau algorithm: A theoretical analysis of the saturation of the error

Wang-Landau algorithm: A theoretical analysis of the saturation of the error THE JOURNAL OF CHEMICAL PHYSICS 127, 184105 2007 Wang-Landau algorithm: A theoretical analysis of the saturation of the error R. E. Belardinelli a and V. D. Pereyra b Departamento de Física, Laboratorio

More information

SIMULATED TEMPERING: A NEW MONTECARLO SCHEME

SIMULATED TEMPERING: A NEW MONTECARLO SCHEME arxiv:hep-lat/9205018v1 22 May 1992 SIMULATED TEMPERING: A NEW MONTECARLO SCHEME Enzo MARINARI (a),(b) and Giorgio PARISI (c) Dipartimento di Fisica, Università di Roma Tor Vergata, Via della Ricerca Scientifica,

More information

8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization

8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization 8.334: Statistical Mechanics II Problem Set # 4 Due: 4/9/14 Transfer Matrices & Position space renormalization This problem set is partly intended to introduce the transfer matrix method, which is used

More information

Today: Fundamentals of Monte Carlo

Today: Fundamentals of Monte Carlo Today: Fundamentals of Monte Carlo What is Monte Carlo? Named at Los Alamos in 940 s after the casino. Any method which uses (pseudo)random numbers as an essential part of the algorithm. Stochastic - not

More information