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

Size: px
Start display at page:

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

Transcription

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

2 Part II. Monte Carlo Simulation Methods II.1. The spin models II.2. Boundary conditions II.3. Simple sampling Monte Carlo methods II.4. Importance sampling Monte Carlo methods

3 A Guide to Monte Carlo Simulations in Statistical Physics D. Landau and K. Binder, (Cambridge University Press, 2009). Monte Carlo Simulation in Statistical Physics: An Introduction K. Binder and D. W. Heermann (Springer-Verlag Berlin Heidelberg, 2010). Understanding Molecular Simulation : From Algorithms to Applications D. Frenkel, (Academic Press, 2002). Frustrated Spin Systems H. T. Diep, 2 nd Ed. (World Scientific, 2013). Lecture notes PDF files : Example code :

4 II.1. The spin models Introduction Spin model = spin kind + lattice structure (with including the dimension) Spin kinds : Ising XY Heisenberg Lattice structure : Simple cubic (SC) Body center cubic (BCC) Face center cubic (FCC) Stacked triangular (hexagonal) Dimensions : 2D, 3D or films

5 n-vector model The hamiltonian (2.1) n : number of conponent n = 0 : The Self-Avoiding Walks n = 1 : Ising model n = 2 : XY model n = 3 : Heisenberg model exchange interaction J The sum is taken over nearest neighbours spin pair : Ferromagnetic interaction : Antiferromagnetic interaction : Spin glass next nearest neighbours spin pair

6 Ising spin model The hamiltonian (2.2) the probability that the system is in state s (2.3) For the ferromagnetic Ising model on 2D simple cubic lattice The energy (2.4)

7 XY spin model This is the special case of the n-vector model, for n = 2 The hamiltonian (2.5) Using polar coordinate, with and (2.6) the system in a external magnetic field (2.7)

8 Heisenberg spin model This is the special case of the n-vector model, for n = 3 The hamiltonian with (2.8) The equation of motion in the continuum limit The Potts model The standard Potts model, spin (2.9) (2.10) : is the Kronecker delta (2.11)

9 II.2. Boundary conditions Periodic boundary condition (PBC)

10 film thickness Free boundary condition Using for a thin-film geometry Applying the free boundary condition on z-direction only Use PBC on (x, y) plane

11 II.3. Simple sampling Monte Carlo methods Comparisons of methods for numerical integration of given functions: Simple methods Consider a definite integral (2.12) draw a box extending from a to b and from 0 to y 0 Using random numbers drawn from a uniform distribution drop N points randomly into the box count the number N 0 which fall below f(x) An estimate for the integral y y 0 f(x) (2.13) 0 a b x

12 Crude method choose N values of x randomly, then calculate f(x) (2.14) Intelligent methods : control variate method (2.15) where selects a integrable function

13 Simulation of radioactive decay : Consider sample of N nuclei which decay at rate the rate of decay (2.16) the nuclei is chosen randomly The number of undecayed nuclei (2.17) N 0 : the initial number of nuclei, related to the half-life of the system Simulation Dividing the time into discrete intervals during the time interval, test for decay of each undecayed nucleus Determine the number of undecayed nuclei Increasing the time step, then repeat the process

14 Program structure N = N 0 ; NP = N 0 LOOP from (t = dt) to T max, step dt LOOP from 1 to NP! Loop over each remaining parent nucleus R = uniform_randomnumber()! 0 R 1 IF ( R < λ dt ) THEN N = N-1 END IF END LOOP over nuclei NP = N Record t, N END LOOP over time

15 Source : radioactive_decay.f90 PROGRAM RADIOACTIVE_DECAY IMPLICIT NONE REAL :: t,tmax,dt,r,lambda INTEGER :: n,n0,np,nt,i! CALL RANDOM_SEED() n0 = 1000; tmax = 50.0 dt = 0.1; lambda = 0.1 n = n0; t = 0.0 DO WHILE (t <= tmax.and. n > 0) t = t + dt np = n DO i = 1,np CALL RANDOM_NUMBER(r) IF (r < lambda*dt) n = n - 1 END DO nt = NINT(n0*exp(-t*lambda)) print*,t,n,nt END DO END PROGRAM RADIOACTIVE_DECAY

16

17 Finding the groundstate of a hamiltonian Consider a system of Ising spins Algorithm Randomly chosen an initial state of the system Choose a random site on the lattice Try to overturn the spin, determining the change in energy if the energy is lowered, then accept the overturn of the spin otherwise it is left unchanged, go to the next site. the system is then either in the groundstate or in some metastable state. We can use different initial configurations, one tests to see if the same state is reached as before if a lower energy state is found.

18 Source : groundstate.f90 PROGRAM GROUNDSTATE IMPLICIT NONE INTEGER, PARAMETER :: N = 10 REAL,DIMENSION(n,n) :: S INTEGER :: i,j,k,l,ip,im,jp,jm REAL :: r,e1,e2,temp! initial configuration CALL RANDOM_SEED() CALL RANDOM_NUMBER(S) DO i = 1,n DO j = 1,n IF (S(i,j) > 0.5) THEN S(i,j) = 1.0 ELSE S(i,j) = -1.0 ENDIF print*,0,etot()

19 DO l = 1,60! Simulation DO k = 1,40 CALL RANDOM_NUMBER(r) i = INT(r*float(n))+1 CALL RANDOM_NUMBER(r) j = INT(r*float(n))+1! periodic boundary condition ip = i + 1; im = i - 1 jp = j + 1; jm = j - 1 IF (ip > n) ip = 1; IF (im < 1) im = n IF (jp > n) jp = 1; IF (jm < 1) jm = n! calculate the energy e1 = -S(i,j)*(S(ip,j)+S(im,j)+S(i,jp)+S(i,jm)) e2 = -e1 IF (e2 <= e1) S(i,j) = -S(i,j) print*,l,etot()

20 CONTAINS! list of subroutine/function REAL FUNCTION etot temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (ip > n) ip = 1 IF (im < 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (jp > n) jp = 1 IF (jm < 1) jm = n temp = temp & - S(i,j)*(S(ip,j)+S(im,j)+S(i,jp)+S(i,jm)) etot = 0.5*temp/float(n*n) END FUNCTION etot! END PROGRAM GROUNDSTATE

21

22 Generation of random walks Introduction A random walk consists of a connected path formed by randomly adding new bonds to the end of the existing walk The mean-square end-to-end distance (2.18) : critical exponent : non-universal constants : correction to scaling exponent The partition function (2.19) : an effective coordination number

23 Random walks (RW) used for the description of diffusion phenomena the end-to-end distance (2.20) Simulation of the simple random walk Picking a starting point Generating a random number to determine the direction of each subsequent Calculating the end-to-end distance Performing a statistical analysis of the resultant distribution non-reversal random walk (RNNW) The choice of the (n + 1) step from the n th step of a return to the point reached at the (n - 1) step is forbidden

24 Algorithm of random walks DO i = 1 to ns x = 0; y = 0 DO j = 1 to N id = INT(r*4.0) SELECT CASE(id) CASE (0) x = x + 1 CASE (1) x = x - 1 CASE (2) y = y + 1 CASE (3) y = y - 1 END SELECT accumulate-results the end-to-end distance! number-of-samples! initial position! number of step

25 Source : randomwalk.f90 INTEGER, PARAMETER :: ns = 1000,n = 100 INTEGER :: i,j,x,y,id REAL :: r,d,d2,temp CALL RANDOM_SEED() d = 0.0; d2 = 0.0 DO i=1,ns x = 0; y = 0 DO j = 1,n CALL RANDOM_NUMBER(r) id = INT(r*4.0) SELECT CASE (id) CASE (0) x = x + 1 CASE (1) x = x - 1 CASE (2) y = y + 1 CASE (3) y = y - 1 END SELECT temp = float(x**2+y**2) d = d + sqrt(temp); d2 = d2 + temp d = d/float(ns); d2 = d2/float(ns) print*,ns,n,d,d2

26 Algorithm of non-reversal random walks DO i = 1 to ns! number-of-samples x = 0; y = 0! initial position xp = 0; yp = 0! previous position DO j = 1 to N! number of step repeat xt = x; yt = y! template position generate-one-step (x; y) until ((x xp) or (y yp)) xp = xt yp = yt accumulate-results

27 Source : nr_randomwalk.f90 PROGRAM NR_RANDOM_WALKS IMPLICIT NONE INTEGER, PARAMETER :: ns = 1000,n = 100 INTEGER :: i,j,x,y,id,xp,yp,xt,yt REAL :: r,d,d2,temp LOGICAL :: test! CALL RANDOM_SEED() d = 0.0; d2 = 0.0 CALL NRRW()! non-reversal random walks d = d/float(ns); d2 = d2/float(ns) print*,ns,n,d,d2 CONTAINS SUBROUTINE NRRW END SUBROUTINE NRRW END PROGRAM NR_RANDOM_WALKS

28 SUBROUTINE NRRW DO i=1,ns x = 0; y = 0; xp = x; yp = y DO j = 1,N xt = x; yt = y; test =.FALSE. DO WHILE(.NOT.test) CALL RANDOM_NUMBER(r) id = INT(r*4.0) IF (id == 0) THEN x = xt + 1; y = yt ELSEIF (id == 1) THEN x = xt - 1; y = yt ELSEIF (id == 2) THEN y = yt + 1; x = xt ELSEIF (id == 3) THEN y = yt - 1; x = xt ENDIF IF ((x.ne. xp).or.(y.ne.yp)) test =.TRUE. xp = xt; yp = yt temp = float(x**2+y**2) d = d + sqrt(temp); d2 = d2 + temp END SUBROUTINE NRRW

29 Self-avoiding walks (SAW) Used to probe the configurations of flexible macromolecules in the solvents The walker dies when attempting to intersect a portion of the already completed walk Simulations Picking a starting point Generating a random number to the different possible choices for the next step If the new site is one which already contains a portion of the walk, then the process is terminated at the N th step. effective exponent (2.21)

30 For, the effective exponent is then related to the true value (2.22) the current estimates for (2.23) K. Kremer and K. Binder, Comput. Phys. Rep. 7, 261 (1988) The exponent Using the equation (2.19), we have (2.24) using symmetric values in step number (2.25)

31 Algorithm of Self-avoiding walks integer lattice(-n:n;-n:n); do sample = 1 to n-of-samples step = 0; x = 0; y = 0; xc = 0; yc = 0; repeat repeat generate-one-step(xnew, ynew); until lattice(xnew, ynew) sample + 1; if lattice(xnew, ynew) = sample then terminate = true else lattice(x, y) = sample; x = xc; y = yc; lattice(x, y) = sample + 1; xc = xnew; yc = ynew; step = step + 1; endif until (terminate or step = N); accumulate-results enddo

32 Source: sa_walk.f90 PROGRAM SELF_AVOIDING_WALKS IMPLICIT NONE INTEGER, PARAMETER :: ns = 100,n = 100 INTEGER, DIMENSION(-n:n,-n:n) :: lattice INTEGER :: i,x,y,xt,yt,id,step,nn REAL :: r,d,d2,temp LOGICAL :: terminate,newsite! CALL RANDOM_SEED() d = 0.0; d2 = 0.0 CALL SAW()! self avoiding walks d = d/float(ns); d2 = d2/float(ns) print*,ns,n,d,d2! CONTAINS SUBROUTINE SAW END SUBROUTINE SAW! END PROGRAM SELF_AVOIDING_WALKS

33 SUBROUTINE SAW DO i = 1,ns lattice = 0 x = 0; y = 0 step = 0; terminate =.FALSE. DO WHILE ((.NOT. terminate).and. (step <= n)) xt = x; yt = y nn = lattice(x+1,y) + lattice(x-1,y) & + lattice(x,y+1) + lattice(x,y-1) IF (nn == 4) THEN terminate =.TRUE. ELSE newsite =.FALSE. DO WHILE (.NOT. newsite) CALL RANDOM_NUMBER(r) id = INT(r*4.0)

34 IF (id == 0) THEN x = xt + 1; y = yt ELSEIF (id == 1) THEN x = xt - 1; y = yt ELSEIF (id == 2) THEN y = yt + 1; x = xt ELSEIF (id == 3) THEN y = yt - 1; x = xt ENDIF IF (lattice(x,y) == 0) newsite =.TRUE. step = step + 1 lattice(x,y) = 1 ENDIF temp = float(x**2+y**2) d = d + sqrt(temp) d2 = d2 + temp END SUBROUTINE SAW

35 Thermal Averages by the Simple Sampling Method The model Consider a polymer chain, : attractive energy between two nearest neighbor monomers Defination The distribution (2.26) number of SAW configurations of N steps with n nearest-neighbor contacts (2.27) number of SAW configurations of N steps with n nearest-neighbor contacts and an end-to-end vector.

36 The averages of interest (2.28) (2.29) The specific heat C per bond of the chain (2.30) Using Eq. (2.28), we have (2.31)

37 II.4. Importance sampling Monte Carlo methods Introduction used for the study of phase transitions at finite temperature Consider a spin model, the Hamiltonian is given by (2.32) the averages (2.33) the thermal average of any observable (2.34)

38 probability density (2.35) integrates Eq. (2.34) over all states with their proper weights (2.36) We consider a process where the phase space points are selected according to some probability (2.37) A natural choice for simple average (2.38)

39 Algorithm (Metropolis method) The configurations are generated from a previous state using a transition probability which depends on the energy difference between the initial and final states The master equation of probability of the system that is in the state n at time t (2.39) : is the transition rate for In the equilibrium process, the condition of detailed balance: We have (2.40)

40 The probability of the n th state occurring in a classical system (2.41) If we produce the n th state from the m th state From Eqs. (2.40) and (2.41), we have (2.42) The choice of rate (Metropolis form) (2.43) : is the time required to attempt a spin-flip

41 Metropolis importance sampling Monte Carlo scheme Ising model (1) Choose an initial state (2) Choose a site i (3) Calculate the energy change E which results if the spin at site i is overturned (4) Generate a random number r such that 0 < r < 1 (5) If exp(- E/k B T) > r, flip the spin (6) Go to the next site and go to (3)

42 Program structure initialize the lattice SUBROUTINE equilibrating! Equilibrating process DO ieq = 1 to N_eq CALL monte_carlo_step() END SUBROUTINE SUBROUTINE averaging! Averaging process DO iav = 1 to N_av CALL monte_carlo_step() do-analysis END SUBROUTINE SUBROUTINE monte_carlo_step generate-one-sweep END SUBROUTINE

43 Source : ising_2dsl.f90 Fortran code (ferromagnetic Ising spin model on 2D square lattice) PROGRAM ISING_2D_SL IMPLICIT NONE INTEGER, PARAMETER :: n = 10,nms = n*n,nt = 20 REAL,DIMENSION(n,n) :: S INTEGER :: i,j,ip,im,jp,jm,ie,ia,ms,it,neq,nav REAL :: r,tmin,tmax,t,dt,e1,e2,temp REAL :: ener,magn! CALL RANDOM_SEED() neq = 2000 nav = 4000 tmin = 0.5; tmax = 4.0

44 dt = (tmax-tmin)/float(nt-1) t = tmin! DO it = 1,nt CALL spin_conf() CALL equilibrating() ener = 0.0 magn = 0.0 CALL averaging() ener = ener/float(nav) magn = magn/float(nav) print*, t,ener,magn t = t + dt CONTAINS END PROGRAM ISING_2D_SL! initial configuration! equilibrating process! averaging process! list of subroutines/functions

45 CONTAINS! list of subroutines/functions! SUBROUTINE spin_conf CALL RANDOM_NUMBER(S) DO i = 1,n DO j = 1,n IF (S(i,j) > 0.5) THEN S(i,j) = 1.0 ELSE S(i,j) = -1.0 ENDIF END SUBROUTINE spin_conf! SUBROUTINE equilibrating DO ie = 1, neq CALL monte_carlo_step() END SUBROUTINE equilibrating

46 SUBROUTINE averaging DO ia = 1, nav CALL monte_carlo_step()! Calculate the average energy per spin temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (ip > n) ip = 1 IF (im < 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (jp > n) jp = 1 IF (jm < 1) jm = n temp = temp -S(i,j)*& (S(ip,j)+S(im,j)+S(i,jp)+S(i,jm)) ener = ener + 0.5*temp/float(n*n)

47 ! Calculate the average magnetization per spin temp = 0.0 DO i = 1,n DO j = 1,n temp = temp + S(i,j) magn = magn + abs(temp)/float(n*n) END SUBROUTINE averaging

48 SUBROUTINE monte_carlo_step DO ms = 1,nms! number of Monte Carlo step CALL RANDOM_NUMBER(r) i = INT(r*float(n))+1 CALL RANDOM_NUMBER(r) j = INT(r*float(n))+1! periodic boundary condition ip = i + 1; im = i - 1 jp = j + 1; jm = j - 1 IF (ip > n) ip = 1 IF (im < 1) im = n IF (jp > n) jp = 1 IF (jm < 1) jm = n! calculate the different energy e1 = -S(i,j)*(S(ip,j)+S(im,j)+S(i,jp)+S(i,jm)) e2 = -e1 CALL RANDOM_NUMBER(r) IF (r < exp(-(e2-e1)/t)) S(i,j) = -S(i,j) END SUBROUTINE monte_carlo_step

49 Ferromagnetic Ising spin model on square lattice Energy vs temperature for N = 10

50 Ferromagnetic Ising spin model on square lattice Magnetization vs temperature for N = 10

51 Exercises modify the program «ising_2dsl.f90» : Adding the calculations for specific heat and susceptibility ener2 = ener2 + (0.5*temp/float(n*n))**2 magn2 = magn2 + (temp/float(n*n))**2 cv = float(n*n)*(ener2 ener*ener)/t/t chi = float(n*n)*(magn2 magn*magn)/t For the case of three dimensions simple cubic lattice Local energy : e1 = -S(i,j,k)*(S(ip,j,k)+S(im,j,k)+S(i,jp,k)+S(i,jm,k) +S(i,j,kp)+S(i,j,km))

52 Ferromagnetic Ising spin model on square lattice Specific heat vs temperature for N = 10

53 Ferromagnetic Ising spin model on square lattice Magnetic susceptibility vs temperature for N = 10

54 Ferromagnetic Ising spin model on simple cubic lattice Energy, magnetization, specific heat and susceptibility vs temperature for N = 12

55 Write a new program for ferromagnetic XY spin model on square lattice Including the calculations for specific heat and susceptibility The local energy e1 = -SX(i,j)*(SX(ip,j)+SX(im,j)+SX(i,jp)+SX(i,jm)) -SY(i,j)*(SY(ip,j)+SY(im,j)+SY(i,jp)+SY(i,jm))

56 Generate a new XY spin with random orientation CALL RANDOM_NUMBER(r) PHI = 2.0* *r SXN = COS(PHI) SYN = SIN(PHI)! orientation

57 Source : xy_2dsl.f90 Fortran code (ferromagnetic XY spin model on square lattice) PROGRAM XY_2D_SL IMPLICIT NONE REAL,PARAMETER:: pi2 = 2.0* INTEGER, PARAMETER :: n = 10,nms = n*n,nt = 20 REAL,DIMENSION(n,n) :: sx,sy INTEGER :: i,j,ip,im,jp,jm,ie,ia,ms,it,neq,nav REAL :: r,tmin,tmax,t,dt,e1,e2,si,phi,sxn,syn,temp REAL :: sxt,syt,ener,magn! CALL RANDOM_SEED() neq = nav = tmin = 0.1; tmax = 2.0

58 dt = (tmax-tmin)/float(nt-1) t = tmin! DO it = 1,nt CALL spin_conf() CALL equilibrating() ener = 0.0; magn = 0.0 CALL averaging() ener = ener/float(nav) magn = magn/float(nav) print*, t,ener,magn t = t + dt! initial configuration CONTAINS! list of subroutines/functions

59 SUBROUTINE spin_conf! DO i = 1,n DO j = 1,n CALL RANDOM_NUMBER(r) phi = pi2*r sx(i,j)=cos(phi) sy(i,j)=sin(phi) END SUBROUTINE spin_conf! SUBROUTINE equilibrating DO ie = 1, neq CALL monte_carlo_step() END SUBROUTINE equilibrating

60 SUBROUTINE averaging DO ia = 1, nav CALL monte_carlo_step() temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (ip > n) ip = 1 IF (im < 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (jp > n) jp = 1 IF (jm < 1) jm = n temp = temp - sx(i,j)*(sx(ip,j) + sx(im,j) & + sx(i,jp) + sx(i,jm)) & - sy(i,j)*(sy(ip,j) + sy(im,j) & + sy(i,jp) + sy(i,jm))

61 ener = ener + 0.5*temp/float(n*n) sxt = 0.0; syt = 0.0 DO i = 1,n DO j = 1,n sxt = sxt + sx(i,j) syt = syt + sy(i,j) magn = magn + sqrt(sxt**2 + syt**2)/float(n*n) END SUBROUTINE averaging

62 SUBROUTINE monte_carlo_step DO ms = 1,NMS CALL RANDOM_NUMBER(r) i = INT(r*float(n))+1 CALL RANDOM_NUMBER(r) j = INT(r*float(n))+1 ip = i + 1; im = i - 1 jp = j + 1; jm = j - 1 IF (ip > n) ip = 1 IF (im < 1) im = n IF (jp > n) jp = 1 IF (jm < 1) jm = n! periodic boundary condition

63 ! calculate the local energy sxt = sx(ip,j)+sx(im,j)+sx(i,jp)+sx(i,jm) syt = sy(ip,j)+sy(im,j)+sy(i,jp)+sy(i,jm) e1 = -sx(i,j)*sxt - sy(i,j)*syt CALL RANDOM_NUMBER(r) phi = pi2*r sxn=cos(phi) syn=sin(phi) e2 = -sxn*sxt -syn*syt CALL RANDOM_NUMBER(r) IF (r < exp(-(e2-e1)/t)) THEN sx(i,j) = sxn sy(i,j) = syn ENDIF END SUBROUTINE monte_carlo_step! END PROGRAM XY_2D_SL

64 Ferromagnetic XY spin model on square lattice Energy and magnetization vs temperature for N = 10 There exist two phases A low-temperature-phase with a quasi-long range order, where most spins are aligned and the correlation-function decays with a power law An unordered high-temperature-phase where the correlation-function decays exponentially The phase transition is called «Kosterlitz-Thouless transition»

65 Counterclockwise vortices

66 Write a new program for ferromagnetic Heisenberg spin model on two dimensions square lattice The local energy e1 = -SX(i,j)*(SX(ip,j)+SX(im,j)+SX(i,jp)+SX(i,jm)) -SY(i,j)*(SY(ip,j)+SY(im,j)+SY(i,jp)+SY(i,jm)) -SZ(i,j)*(SZ(ip,j)+SZ(im,j)+SZ(i,jp)+SZ(i,jm))

67 Generate a new Heisenberg spin with random module and orientation CALL RANDOM_NUMBER(r) PHI = 2.0* *r CALL RANDOM_NUMBER(r) SZN = 2.0*r-1.0 SI = SQRT(1-SZN*SZN) SXN = SI*COS(PHI) SYN = SI*SIN(PHI)! orientation! projection of SZ

68 For two dimensions triangular lattice The local energy e1 = -S(i,j)*(S(ip,j)+S(im,j)+S(i,jp)+S(i,jm) + S(ip,jm)+S(im,jp)) For 3D stracked triangular lattice e1 = -S(i,j,k)*(S(ip,j,k)+S(im,j,k)+S(i,jp,k)+S(i,jm,k) +S(ip,jm,k)+S(im,jp,k) +S(i,j,kp) +S(i,j,km))

69 Source : ising_2dtl.f90 Fortran code (ferromagnetic Ising spin model on triangular lattice) PROGRAM ISING_2D_TL IMPLICIT NONE INTEGER, PARAMETER :: n = 10,nms = n*n,nt = 40 REAL,DIMENSION(n,n) :: S INTEGER :: i,j,ip,im,jp,jm,ie,ia,ms,it,neq,nav REAL :: r,tmin,tmax,t,dt,e1,e2,temp REAL :: ener,magn! CALL RANDOM_SEED() neq = nav = tmin = 1.0; tmax = 6.0

70 dt = (tmax-tmin)/float(nt-1) t = tmin! DO it = 1,nt CALL spin_conf()! initial configuration CALL equilibrating() ener = 0.0; magn = 0.0 CALL averaging() ener = ener/float(nav) magn = magn/float(nav) print*, t,ener,magn t = t + dt CONTAINS! list of subroutine/function

71 SUBROUTINE spin_conf! CALL RANDOM_NUMBER(S) DO i = 1,n DO j = 1,n IF (S(i,j) > 0.5) THEN S(i,j) = 1.0 ELSE S(i,j) = -1.0 ENDIF END SUBROUTINE spin_conf! SUBROUTINE equilibrating DO ie = 1, neq CALL monte_carlo_step() END SUBROUTINE equilibrating

72 SUBROUTINE averaging DO ia = 1, nav CALL monte_carlo_step() temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (ip > n) ip = 1 IF (im < 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (jp > n) jp = 1 IF (jm < 1) jm = n temp = temp - S(i,j)*(S(ip,j)+S(im,j) & +S(i,jp)+S(i,jm) + S(ip,jm)+S(im,jp) ) ener = ener + 0.5*temp/float(n*n)

73 temp = 0.0 DO i = 1,n DO j = 1,n temp = temp + S(i,j) magn = magn + abs(temp)/float(n*n) END SUBROUTINE averaging

74 SUBROUTINE monte_carlo_step DO ms = 1,NMS CALL RANDOM_NUMBER(r); i = INT(r*float(n))+1 CALL RANDOM_NUMBER(r); j = INT(r*float(n))+1! periodic boundary condition ip = i + 1; im = i - 1 jp = j + 1; jm = j - 1 IF (ip > n) ip = 1 IF (im < 1) im = n IF (jp > n) jp = 1 IF (jm < 1) jm = n! calculate the energy e1 = -S(i,j)*(S(ip,j)+S(im,j)+S(i,jp)+S(i,jm) & + S(ip,jm)+S(im,jp) ) e2 = -e1 CALL RANDOM_NUMBER(r) IF (r < exp(-(e2-e1)/t)) S(i,j) = -S(i,j) END SUBROUTINE monte_carlo_step END PROGRAM ISING_2D_TL

75 Ferromagnetic Ising spin model on 2D triangular lattice Energy vs temperature for N = 10

76 Ferromagnetic Ising spin model on 2D triangular lattice Magnetization vs temperature for N = 10

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

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

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

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

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

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 METHODS IN SEQUENTIAL AND PARALLEL COMPUTING OF 2D AND 3D ISING MODEL

MONTE CARLO METHODS IN SEQUENTIAL AND PARALLEL COMPUTING OF 2D AND 3D ISING MODEL Journal of Optoelectronics and Advanced Materials Vol. 5, No. 4, December 003, p. 971-976 MONTE CARLO METHODS IN SEQUENTIAL AND PARALLEL COMPUTING OF D AND 3D ISING MODEL M. Diaconu *, R. Puscasu, A. Stancu

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

Potts And XY, Together At Last

Potts And XY, Together At Last Potts And XY, Together At Last Daniel Kolodrubetz Massachusetts Institute of Technology, Center for Theoretical Physics (Dated: May 16, 212) We investigate the behavior of an XY model coupled multiplicatively

More information

Numerical diagonalization studies of quantum spin chains

Numerical diagonalization studies of quantum spin chains PY 502, Computational Physics, Fall 2016 Anders W. Sandvik, Boston University Numerical diagonalization studies of quantum spin chains Introduction to computational studies of spin chains Using basis states

More information

Monte Carlo Simulations of the Hyaluronan-Aggrecan Complex in the Pericellular Matrix

Monte Carlo Simulations of the Hyaluronan-Aggrecan Complex in the Pericellular Matrix Monte Carlo Simulations of the Hyaluronan-Aggrecan Complex in the Pericellular Matrix Marcel Hellmann BIOMS Group Cellular Biophysics, Deutsches Krebsforschungszentrum (DKFZ) Theoretical Biophysics Group,

More information

LECTURE 11: Monte Carlo Methods III

LECTURE 11: Monte Carlo Methods III 1 LECTURE 11: Monte Carlo Methods III December 3, 2012 In this last chapter, we discuss non-equilibrium Monte Carlo methods. We concentrate on lattice systems and discuss ways of simulating phenomena such

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

The Phase Transition of the 2D-Ising Model

The Phase Transition of the 2D-Ising Model The Phase Transition of the 2D-Ising Model Lilian Witthauer and Manuel Dieterle Summer Term 2007 Contents 1 2D-Ising Model 2 1.1 Calculation of the Physical Quantities............... 2 2 Location of the

More information

arxiv: v1 [cond-mat.dis-nn] 25 Apr 2018

arxiv: v1 [cond-mat.dis-nn] 25 Apr 2018 arxiv:1804.09453v1 [cond-mat.dis-nn] 25 Apr 2018 Critical properties of the antiferromagnetic Ising model on rewired square lattices Tasrief Surungan 1, Bansawang BJ 1 and Muhammad Yusuf 2 1 Department

More information

REVIEW: Derivation of the Mean Field Result

REVIEW: Derivation of the Mean Field Result Lecture 18: Mean Field and Metropolis Ising Model Solutions 1 REVIEW: Derivation of the Mean Field Result The Critical Temperature Dependence The Mean Field Approximation assumes that there will be an

More information

Surface effects in frustrated magnetic materials: phase transition and spin resistivity

Surface effects in frustrated magnetic materials: phase transition and spin resistivity Surface effects in frustrated magnetic materials: phase transition and spin resistivity H T Diep (lptm, ucp) in collaboration with Yann Magnin, V. T. Ngo, K. Akabli Plan: I. Introduction II. Surface spin-waves,

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

Introduction. Model DENSITY PROFILES OF SEMI-DILUTE POLYMER SOLUTIONS NEAR A HARD WALL: MONTE CARLO SIMULATION

Introduction. Model DENSITY PROFILES OF SEMI-DILUTE POLYMER SOLUTIONS NEAR A HARD WALL: MONTE CARLO SIMULATION 169 DENSITY PROFILES OF SEMI-DILUTE POLYMER SOLUTIONS NEAR A HARD WALL: MONTE CARLO SIMULATION WAN Y. SHIH, WEI-HENG SHIH and ILHAN A. AKSAY Dept. of Materials Science and Engineering University of Washington,

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

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

Scaling Theory. Roger Herrigel Advisor: Helmut Katzgraber

Scaling Theory. Roger Herrigel Advisor: Helmut Katzgraber Scaling Theory Roger Herrigel Advisor: Helmut Katzgraber 7.4.2007 Outline The scaling hypothesis Critical exponents The scaling hypothesis Derivation of the scaling relations Heuristic explanation Kadanoff

More information

Evaluation of Wang-Landau Monte Carlo Simulations

Evaluation of Wang-Landau Monte Carlo Simulations 2012 4th International Conference on Computer Modeling and Simulation (ICCMS 2012) IPCSIT vol.22 (2012) (2012) IACSIT Press, Singapore Evaluation of Wang-Landau Monte Carlo Simulations Seung-Yeon Kim School

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

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

Stacked Triangular XY Antiferromagnets: End of a Controversial Issue on the Phase Transition

Stacked Triangular XY Antiferromagnets: End of a Controversial Issue on the Phase Transition Stacked Triangular XY Antiferromagnets: End of a Controversial Issue on the Phase Transition V. Thanh Ngo, H. T. Diep To cite this version: V. Thanh Ngo, H. T. Diep. Stacked Triangular XY Antiferromagnets:

More information

WORLD SCIENTIFIC (2014)

WORLD SCIENTIFIC (2014) WORLD SCIENTIFIC (2014) LIST OF PROBLEMS Chapter 1: Magnetism of Free Electrons and Atoms 1. Orbital and spin moments of an electron: Using the theory of angular momentum, calculate the orbital

More information

Triangular Ising model with nearestand

Triangular Ising model with nearestand Chapter 3 Triangular Ising model with nearestand next-nearest-neighbor couplings in a field We study the Ising model on the triangular lattice with nearest-neighbor couplings K nn, next-nearest-neighbor

More information

Intro. Each particle has energy that we assume to be an integer E i. Any single-particle energy is equally probable for exchange, except zero, assume

Intro. Each particle has energy that we assume to be an integer E i. Any single-particle energy is equally probable for exchange, except zero, assume Intro Take N particles 5 5 5 5 5 5 Each particle has energy that we assume to be an integer E i (above, all have 5) Particle pairs can exchange energy E i! E i +1andE j! E j 1 5 4 5 6 5 5 Total number

More information

The XY-Model. David-Alexander Robinson Sch th January 2012

The XY-Model. David-Alexander Robinson Sch th January 2012 The XY-Model David-Alexander Robinson Sch. 08332461 17th January 2012 Contents 1 Introduction & Theory 2 1.1 The XY-Model............................... 2 1.2 Markov Chains...............................

More information

2D and 3D Ising model using Monte Carlo and Metropolis method

2D and 3D Ising model using Monte Carlo and Metropolis method 2D and 3D Ising model using Monte Carlo and Metropolis method Syed Ali Raza May 2012 1 Introduction We will try to simulate a 2D Ising model with variable lattice side and then extend it to a 3 dimensional

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

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

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

Decimation Technique on Sierpinski Gasket in External Magnetic Field

Decimation Technique on Sierpinski Gasket in External Magnetic Field Egypt.. Solids, Vol. (), No. (), (009 ) 5 Decimation Technique on Sierpinski Gasket in External Magnetic Field Khalid Bannora, G. Ismail and M. Abu Zeid ) Mathematics Department, Faculty of Science, Zagazig

More information

Monte Carlo Study of Planar Rotator Model with Weak Dzyaloshinsky Moriya Interaction

Monte Carlo Study of Planar Rotator Model with Weak Dzyaloshinsky Moriya Interaction Commun. Theor. Phys. (Beijing, China) 46 (2006) pp. 663 667 c International Academic Publishers Vol. 46, No. 4, October 15, 2006 Monte Carlo Study of Planar Rotator Model with Weak Dzyaloshinsky Moriya

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.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

arxiv: v1 [cond-mat.dis-nn] 12 Nov 2014

arxiv: v1 [cond-mat.dis-nn] 12 Nov 2014 Representation for the Pyrochlore Lattice arxiv:1411.3050v1 [cond-mat.dis-nn] 12 Nov 2014 André Luis Passos a, Douglas F. de Albuquerque b, João Batista Santos Filho c Abstract a DFI, CCET, Universidade

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

A Monte Carlo Study of the Specific Heat of Diluted Antiferromagnets

A Monte Carlo Study of the Specific Heat of Diluted Antiferromagnets A Monte Carlo Study of the Specific Heat of Diluted Antiferromagnets M. Staats and K. D. Usadel email: michael@thp.uni-duisburg.de Theoretische Physik and SFB 166 Gerhard-Mercator-Universität Gesamthochschule

More information

Solitonic elliptical solutions in the classical XY model

Solitonic elliptical solutions in the classical XY model Solitonic elliptical solutions in the classical XY model Rodrigo Ferrer, José Rogan, Sergio Davis, Gonzalo Gutiérrez Departamento de Física, Facultad de Ciencias, Universidad de Chile, Casilla 653, Santiago,

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

Blume-Emery-Griffiths Model In Thin Films of Stacked Triangular Lattices

Blume-Emery-Griffiths Model In Thin Films of Stacked Triangular Lattices Blume-Emery-Griffiths Model In Thin Films of Stacked Triangular Lattices Sahbi El Hog, H. T. Diep To cite this version: Sahbi El Hog, H. T. Diep. Blume-Emery-Griffiths Model In Thin Films of Stacked Triangular

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

2. Verification of the Boltzmann distribution

2. Verification of the Boltzmann distribution Exercises Lecture VIII Macrostates and microstates: equilibrium and entropy. Metropolis algorithm in the canonical ensemble: verifying Boltzmann s distribution 1. MC simulation of a simple N-particles

More information

Exercises Lecture IV : Random Walks

Exercises Lecture IV : Random Walks Exercises Lecture IV : Random Walks. D Random walks: properties; comparison numerical/analytical results; convergence Write a code (e.g. see rwd.f90) that simulates numerically a D random walk with a Monte

More information

Phase Transitions in Condensed Matter Spontaneous Symmetry Breaking and Universality. Hans-Henning Klauss. Institut für Festkörperphysik TU Dresden

Phase Transitions in Condensed Matter Spontaneous Symmetry Breaking and Universality. Hans-Henning Klauss. Institut für Festkörperphysik TU Dresden Phase Transitions in Condensed Matter Spontaneous Symmetry Breaking and Universality Hans-Henning Klauss Institut für Festkörperphysik TU Dresden 1 References [1] Stephen Blundell, Magnetism in Condensed

More information

AGuideto Monte Carlo Simulations in Statistical Physics

AGuideto Monte Carlo Simulations in Statistical Physics AGuideto Monte Carlo Simulations in Statistical Physics Second Edition David P. Landau Center for Simulational Physics, The University of Georgia Kurt Binder Institut für Physik, Johannes-Gutenberg-Universität

More information

arxiv: v1 [cond-mat.dis-nn] 13 Oct 2015

arxiv: v1 [cond-mat.dis-nn] 13 Oct 2015 Search for the Heisenberg spin glass on rewired square lattices with antiferromagnetic interaction arxiv:1510.03825v1 [cond-mat.dis-nn] 13 Oct 2015 asrief Surungan, Bansawang BJ, and Dahlang ahir Department

More information

Immigration, integration and ghetto formation

Immigration, integration and ghetto formation Immigration, integration and ghetto formation arxiv:cond-mat/0209242v1 10 Sep 2002 Hildegard Meyer-Ortmanns School of Engineering and Science International University Bremen P.O.Box 750561 D-28725 Bremen,

More information

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 24 Jul 2001

arxiv:cond-mat/ v1 [cond-mat.stat-mech] 24 Jul 2001 Autocorrelation functions in 3D Fully Frustrated Systems arxiv:cond-mat/0107509v1 [cond-mat.stat-mech] 24 Jul 2001 G. Franzese a, A. Fierro a, A. De Candia a and A. Coniglio a,b Dipartimento di Scienze

More information

Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations

Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations Meron-Cluster and Nested Cluster Algorithms: Addressing the Sign Problem in Quantum Monte Carlo Simulations Uwe-Jens Wiese Bern University IPAM Workshop QS2009, January 26, 2009 Collaborators: B. B. Beard

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

Lattice gas models. - Lattice gas - Diffusion Limited Aggregates

Lattice gas models. - Lattice gas - Diffusion Limited Aggregates Lattice gas models - Lattice gas - Diffusion Limited Aggregates M. Peressi - UniTS - Laurea Magistrale in Physics Laboratory of Computational Physics - Unit X Random Walks Dependence of R 2 (t) on t :

More information

Ageing properties of three-dimensional pure and site-diluted Ising ferromagnets

Ageing properties of three-dimensional pure and site-diluted Ising ferromagnets Journal of Physics: Conference Series OPEN ACCESS Ageing properties of three-dimensional pure and site-diluted Ising ferromagnets To cite this article: Vladimir V Prudnikov et al 2014 J. Phys.: Conf. Ser.

More information

Coarsening process in the 2d voter model

Coarsening process in the 2d voter model Alessandro Tartaglia (LPTHE) Coarsening in the 2d voter model May 8, 2015 1 / 34 Coarsening process in the 2d voter model Alessandro Tartaglia LPTHE, Université Pierre et Marie Curie alessandro.tartaglia91@gmail.com

More information

Phase Transition in Vector Spin Glasses. Abstract

Phase Transition in Vector Spin Glasses. Abstract Phase Transition in Vector Spin Glasses A. P. Young Department of Physics, University of California, Santa Cruz, California 95064 (Dated: June 3, 2004) Abstract We first give an experimental and theoretical

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

arxiv: v1 [cond-mat.stat-mech] 11 Oct 2014

arxiv: v1 [cond-mat.stat-mech] 11 Oct 2014 Heuristic Monte Carlo Method Applied to Cooperative Motion Algorithm for Binary Lattice Fluid P. Knycha la 1, and M. Banaszak 2 1 Chair of Computer Science, The President Stanislaw arxiv:1410.3015v1 [cond-mat.stat-mech]

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

Phase Transition in Vector Spin Glasses. Abstract

Phase Transition in Vector Spin Glasses. Abstract Phase Transition in Vector Spin Glasses A. P. Young Department of Physics, University of California, Santa Cruz, California 95064 (Dated: June 2, 2004) Abstract We first give an experimental and theoretical

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

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

Complex Systems Methods 9. Critical Phenomena: The Renormalization Group

Complex Systems Methods 9. Critical Phenomena: The Renormalization Group Complex Systems Methods 9. Critical Phenomena: The Renormalization Group Eckehard Olbrich e.olbrich@gmx.de http://personal-homepages.mis.mpg.de/olbrich/complex systems.html Potsdam WS 2007/08 Olbrich (Leipzig)

More information

Phase transitions in the Potts spin-glass model

Phase transitions in the Potts spin-glass model PHYSICAL REVIEW E VOLUME 58, NUMBER 3 SEPTEMBER 1998 Phase transitions in the Potts spin-glass model Giancarlo Franzese 1 and Antonio Coniglio 1,2 1 Dipartimento di Scienze Fisiche, Università di Napoli,

More information

Monte Caro simulations

Monte Caro simulations 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

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

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

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

Spin Hamiltonian and Order out of Coulomb Phase in Pyrochlore Structure of FeF3

Spin Hamiltonian and Order out of Coulomb Phase in Pyrochlore Structure of FeF3 Spin Hamiltonian and Order out of Coulomb Phase in Pyrochlore Structure of FeF3 Farhad Shahbazi in collaboration with Azam Sadeghi (IUT) Mojtaba Alaei (IUT) Michel J. P. Gingras (UWaterloo) arxiv: 1407.0849

More information

The Magnetic Properties of Superparamagnetic Particles by a Monte Carlo Method

The Magnetic Properties of Superparamagnetic Particles by a Monte Carlo Method The Magnetic Properties of Superparamagnetic Particles by a Monte Carlo Method D. A. Dimitrov and G. M. Wysin Department of Physics Kansas State University Manhattan, KS 6656-261 (June 19, 1996) We develop

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

Crystallization phenomena in germanium antimony phase-change films Eising, Gert

Crystallization phenomena in germanium antimony phase-change films Eising, Gert University of Groningen Crystallization phenomena in germanium antimony phase-change films Eising, Gert IMPORTANT NOTE: You are advised to consult the publisher's version (publisher's PDF) if you wish

More information

Finite-size analysis via the critical energy -subspace method in the Ising models

Finite-size analysis via the critical energy -subspace method in the Ising models Materials Science-Poland, Vol. 23, No. 4, 25 Finite-size analysis via the critical energy -subspace method in the Ising models A. C. MAAKIS *, I. A. HADJIAGAPIOU, S. S. MARTINOS, N. G. FYTAS Faculty of

More information

Exact diagonalization methods

Exact diagonalization methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Exact diagonalization methods Anders W. Sandvik, Boston University Representation of states in the computer bit

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

POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM

POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM Chapter 6 POTENTIAL THEORY AND HEAT CONDUCTION DIRICHLET S PROBLEM M. Ragheb 9/19/13 6.1 INTRODUCTION The solution of the Dirichlet problem is one of the easiest approaches to grasp using Monte Carlo methodologies.

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

8.334: Statistical Mechanics II Spring 2014 Test 3 Review Problems

8.334: Statistical Mechanics II Spring 2014 Test 3 Review Problems 8.334: Statistical Mechanics II Spring 014 Test 3 Review Problems The test is closed book, but if you wish you may bring a one-sided sheet of formulas. The intent of this sheet is as a reminder of important

More information

Physics 127b: Statistical Mechanics. Renormalization Group: 1d Ising Model. Perturbation expansion

Physics 127b: Statistical Mechanics. Renormalization Group: 1d Ising Model. Perturbation expansion Physics 17b: Statistical Mechanics Renormalization Group: 1d Ising Model The ReNormalization Group (RNG) gives an understanding of scaling and universality, and provides various approximation schemes to

More information

arxiv: v1 [cond-mat.dis-nn] 13 Jul 2015

arxiv: v1 [cond-mat.dis-nn] 13 Jul 2015 Spin glass behavior of the antiferromagnetic Heisenberg model on scale free network arxiv:1507.03305v1 [cond-mat.dis-nn] 13 Jul 2015 Tasrief Surungan 1,3, Freddy P. Zen 2,3, and Anthony G. Williams 4 1

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

Instability of In-Plane Vortices in Two-Dimensional Easy-Plane Ferromagnets

Instability of In-Plane Vortices in Two-Dimensional Easy-Plane Ferromagnets Instability of In-Plane Vortices in Two-Dimensional Easy-Plane Ferromagnets G. M. Wysin Department of Physics Kansas State University Manhattan, KS 66506-260 (November 9, 993) An analysis of the core region

More information

Magnetism at finite temperature: molecular field, phase transitions

Magnetism at finite temperature: molecular field, phase transitions Magnetism at finite temperature: molecular field, phase transitions -The Heisenberg model in molecular field approximation: ferro, antiferromagnetism. Ordering temperature; thermodynamics - Mean field

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

Phase transitions in the Ising model with random gap defects using the Monte Carlo method

Phase transitions in the Ising model with random gap defects using the Monte Carlo method Phase transitions in the Ising model with random gap defects using the Monte Carlo method Kimberly Schultz A senior thesis submitted to the Carthage College Physics & Astronomy Department in partial fulfillment

More information

Quantum Phase Transition

Quantum Phase Transition Quantum Phase Transition Guojun Zhu Department of Physics, University of Illinois at Urbana-Champaign, Urbana IL 61801, U.S.A. (Dated: May 5, 2002) A quantum system can undergo a continuous phase transition

More information

POWER-LAW CORRELATED PHASE IN RANDOM-FIELD XY MODELS AND RANDOMLY PINNED CHARGE-DENSITY WAVES Ronald Fisch Dept. of Physics Washington Univ. St. Louis, MO 63130 ABSTRACT: Monte Carlo simulations have been

More information

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky Monte Carlo Lecture 15 4/9/18 1 Sampling with dynamics In Molecular Dynamics we simulate evolution of a system over time according to Newton s equations, conserving energy Averages (thermodynamic properties)

More information

Chapter 6 Antiferromagnetism and Other Magnetic Ordeer

Chapter 6 Antiferromagnetism and Other Magnetic Ordeer Chapter 6 Antiferromagnetism and Other Magnetic Ordeer 6.1 Mean Field Theory of Antiferromagnetism 6.2 Ferrimagnets 6.3 Frustration 6.4 Amorphous Magnets 6.5 Spin Glasses 6.6 Magnetic Model Compounds TCD

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

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

Monte-Carlo simulations of spinodal ordering and decomposition in compositionally modulated alloys

Monte-Carlo simulations of spinodal ordering and decomposition in compositionally modulated alloys Monte-Carlo simulations of spinodal ordering and decomposition in compositionally modulated alloys Michael Atzmon Department of Nuclear Engineering, The University of Michigan, Ann Arbor, Michigan 48109

More information

arxiv: v3 [cond-mat.dis-nn] 20 May 2014

arxiv: v3 [cond-mat.dis-nn] 20 May 2014 1 Analytical estimates of the locations of phase transition points in the ground state for the bimodal Ising spin glass model in two dimensions Chiaki Yamaguchi arxiv:1309.6554v3 [cond-mat.dis-nn] 20 May

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

Critical Phenomena and Percolation Theory: II

Critical Phenomena and Percolation Theory: II Critical Phenomena and Percolation Theory: II Kim Christensen Complexity & Networks Group Imperial College London Joint CRM-Imperial College School and Workshop Complex Systems Barcelona 8-13 April 2013

More information

Magnetic properties of spherical fcc clusters with radial surface anisotropy

Magnetic properties of spherical fcc clusters with radial surface anisotropy Magnetic properties of spherical fcc clusters with radial surface anisotropy D. A. Dimitrov and G. M. Wysin Department of Physics Kansas State University Manhattan, KS 66506-2601 (December 6, 1994) We

More information

Optimized statistical ensembles for slowly equilibrating classical and quantum systems

Optimized statistical ensembles for slowly equilibrating classical and quantum systems Optimized statistical ensembles for slowly equilibrating classical and quantum systems IPAM, January 2009 Simon Trebst Microsoft Station Q University of California, Santa Barbara Collaborators: David Huse,

More information