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 III. Finite size effects and Reweighting methods III.1. Finite size effects III.2. Single histogram method III.3. Multiple histogram method III.4. Wang-Landau method III.5. The applications

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 III.1. Finite size effects Using for determining the properties of the corresponding infinite system distinguish the order of the transition (first or second order transition) test the results of simulation of finite size systems Finite size scaling and critical exponents Consider a spin model on the lattice of finite size L Scaling forms of thermodynamic quantities (3.1) : are scaling functions Scaling relations (3.2)

5 The thermodynamic properties at the transition reduce to proportionality constants Scaling relations (3.3) If, then The cumulants fourth order cumulant of the order parameter (3.4) As the system size For For

6 fourth order cumulant of the energy (3.5) The logarithmic derivative of the n th power of the magnetization (3.6) For a continuous transition (second order transition) (3.7) where

7 Calculate the critical exponents exponent : (3.8) exponent : (3.9) exponent : exponent : (3.10) (3.11) For a discontinuous transition (first order transition) finite-size scaling laws (3.12) with

8 Ferromagnetic Ising spin model on simple cubic lattice

9 Ferromagnetic Ising spin model on simple cubic lattice

10 The behavior of V L for the q = 10 Potts model in two dimensions A Guide to Monte Carlo Simulations in Statistical Physics D. Landau and K. Binder

11 III.2. Single histogram method Introduced by Ferrenberg and Swendsen (1988), Ferrenberg (1991) using histograms to extract information from Monte Carlo simulations Applying to the calculation of critical exponents The theory Consider a Monte Carlo simulation performed at T = T 0 generates system configurations with a frequency proportional to the Boltzmann weight, exp(-e/k B T). Histogram of energy and magnetization H(E, M) The probability of simultaneously observing the system (3.13) : is the number of configurations (density of states) with energy E and magnetization M Partition function: (3.14)

12 : provides an estimate for over the range of E and M values generated during the simulation N is the number of measurements made We have (3.15) : is an estimate for the true density of states From the histogram H(E, M) we can invert Eq. (3.15) to determine (3.16) Replace in Eq. (3.13) with the expression for, and normalize the distribution. the relationship between the histogram measured at K = K 0 and the estimated probability distribution for arbitrary K (3.17)

13 The average value of any function of E and M : (3.18) Energy histogram vs energy for ferromagnetic Ising spin model on square lattice of size L = 64, at temperature K =

14 Case study - one dimension single histogram From the histogram of energy H(E) The estimated probability distribution for arbitrary K (3.19) The average value of any function of E (3.20) For example

15 The simulations Find the temperature T 0 which is close to transition temperature Simulate the model by using the standard Monte Carlo simulation (Metropolis algorithm). Plot specific heat or susceptibility versus temperature, peaking the value of temperature at maxima of or. Choose the range of energy T 0 = 2.26 E min = -1.8, E max = 1.0

16 Do the simulation by using the single histogram method at T = T 0 Program structure - Gererating an array of N_BIN for energy range of interest - initialize the lattice SUBROUTINE equilibrating! Equilibrating process DO ieq = 1 to N_eq CALL monte_carlo_step() ENDDO END SUBROUTINE SUBROUTINE averaging! Averaging process DO iav = 1 to N_av CALL monte_carlo_step() do-analysis ENDDO END SUBROUTINE SUBROUTINE monte_carlo_step generate-one-sweep END SUBROUTINE

17 Source : single_histogram_ising.f90 PROGRAM SINGLE_HISTOGRAM_ISING IMPLICIT NONE INTEGER, PARAMETER :: n = 40,nms = n*n REAL,DIMENSION(n,n) :: s REAL,ALLOCATABLE,DIMENSION(:) :: e1,e2,m1,m2,he INTEGER :: i,j,ip,im,jp,jm,ie,ia,ms,neq,nav,ib,nbin REAL :: r,emin,emax,t,dt,temp,et1,et2! CALL RANDOM_SEED() neq = nav = t = 2.3; dt = 4.0 emax = -1.0*float(n*n); emin = -2.0*float(n*n) nbin = INT((emax-emin)/dt) + 1 ALLOCATE(he(nbin),e1(nbin),e2(nbin),m1(nbin),m2(nbin))

18 CALL spin_conf()! initial configuration CALL equilibrating() he =0.0; e1 = 0.0; e2 = 0.0; m1 = 0.0; m2 = 0.0 CALL averaging() OPEN(UNIT=12,FILE='sh_ising.dat') i = 0 DO ib = 1,nbin IF (he(ib) > 0) THEN write(12,1) he(ib),e1(ib)/he(ib),e2(ib)/he(ib)&,m1(ib)/he(ib),m2(ib)/he(ib) i = i + 1 ENDIF ENDDO 1 format(5(f16.6,1x)) CLOSE(12) OPEN(UNIT=12,FILE='sh_ising.info') write(12,*) t,i,n CLOSE(12) DEALLOCATE(he,e1,e2,m1,m2)! CONTAINS! list of subroutine/function

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

20 SUBROUTINE averaging DO ia = 1, nav CALL monte_carlo_step() temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (i == n) ip = 1 IF (i == 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (j == n) jp = 1 IF (j == 1) jm = n temp = temp & - s(i,j)*(s(ip,j)+s(im,j)+s(i,jp)+s(i,jm)) ENDDO ENDDO temp = 0.5*temp ib = NINT((temp-emin)/dt) + 1

21 IF ((ib > 0).AND. (ib <= nbin)) THEN he(ib) = he(ib) temp = temp/float(n*n) e1(ib) = e1(ib) + temp e2(ib) = e2(ib) + temp*temp! temp = 0.0 DO j = 1,n DO i = 1,n temp = temp + S(i,j) ENDDO ENDDO temp = temp/float(n*n) m1(ib) = m1(ib)+ abs(temp) m2(ib) = m2(ib)+ temp*temp ENDIF ENDDO END SUBROUTINE averaging

22 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 IF (i == n) ip = 1 IF (i == 1) im = n jp = j + 1; jm = j - 1 IF (j == n) jp = 1 IF (j == 1) jm = n et1 = -s(i,j)*(s(ip,j)+s(im,j)+s(i,jp)+s(i,jm)) et2 = -et1 CALL RANDOM_NUMBER(r) IF (r < exp(-(et2-et1)/t)) s(i,j) = -s(i,j) ENDDO END SUBROUTINE monte_carlo_step! END PROGRAM SINGLE_HISTOGRAM_ISING

23 Do analysis Read the data from histogram MC simulation Calculate the partition function Calculate the average value of physical quantities

24 Source : single_histogram_analysis.f90 PROGRAM SINGLE_HISTOGRAM_ANALYSIS IMPLICIT NONE REAL,ALLOCATABLE,DIMENSION(:) :: e,e1,e2,m1,m2,he INTEGER :: n,ib,nbin,it,nt REAL :: r,tmin,tmax,t,t0,dt,z REAL :: et1,et2,mt1,mt2,cv,chi! nt = 80 tmin = 2.1 tmax = 2.4 dt = (tmax-tmin)/float(nt-1)!

25 OPEN(UNIT=12,FILE='sh_ising.info') read(12,*) t0,nbin,n CLOSE(12) ALLOCATE(he(nbin),e(nbin),e1(nbin)&,e2(nbin),m1(nbin),m2(nbin))! OPEN(UNIT=12,FILE='sh_ising.dat') DO ib = 1,nbin read(12,1) he(ib),e1(ib),e2(ib),m1(ib),m2(ib) ENDDO 1 format(5(f16.6,1x)) CLOSE(12) e = e1*float(n*n)! OPEN(UNIT=12,FILE='ising_analysis.dat') t = tmin

26 DO it = 1,nt z = 0.0 DO ib = 1,nbin z = z + he(ib)*exp(e(ib)*(1/t0-1/t)) ENDDO et1 = 0.0; et2 = 0.0; mt1 = 0.0; mt2 = 0.0 DO ib = 1, nbin et1 = et1 + he(ib)*e1(ib)*exp(e(ib)*(1/t0-1/t)) et2 = et2 + he(ib)*e2(ib)*exp(e(ib)*(1/t0-1/t)) mt1 = mt1 + he(ib)*m1(ib)*exp(e(ib)*(1/t0-1/t)) mt2 = mt2 + he(ib)*m2(ib)*exp(e(ib)*(1/t0-1/t)) ENDDO et1 = et1/z; et2 = et2/z; mt1 = mt1/z; mt2 = mt2/z cv = float(n*n)*(et2-et1*et1)/t/t chi = float(n*n)*(mt2-mt1*mt1)/t write(12,1) t,et1,mt1,cv,chi t = t + dt ENDDO CLOSE(12) DEALLOCATE(he,e,e1,e2,m1,m2) END PROGRAM SINGLE_HISTOGRAM_ANALYSIS

27 Ferromagnetic Ising spin model on the square lattice Specific heat and susceptibility vs temperature with N = 40 red points : Standard MC result green points : Single histogram result

28 Ferromagnetic Ising spin model on the square lattice Specific heat and susceptibility vs temperature with N = 40, 50, 60

29 III.3. Multiple histogram method Introduced by Ferrenberg and Swendsen (Phys. Rev. Lett. 63,1195, 1989) Developed from single histogram method The technique is known to reproduce with very high accuracy the critical exponents of second order phase transitions The theory Consider n independent MC simulation Each simulation at temperature T j, the system has N j configurations The overall probability distribution at temperature T (3.21) where (3.22) f i is chosen self-consistently using Eq. 3.21

30 The thermal average of a physical quantity A is then calculated by (3.23) Monte Carlo simulations Choose the range of temperature [T min, T max ] Divide the teperature into n points: T i (i = 1,, n) Choose the range of energy [E min, E max ] Divide the energy into nbin Perform n independent MC simulation Calculate the energy histogram, average energy, magnetization Perform the analysis Read the simulation data Calculate self-consistently f i by iterating Eqs. (3.21) and (3.22) Do the calculations for the physical quantities by using (3.23)

31 III.4. Wang-Landau method Introduced by Wang and Landau, Phys. Rev. Lett. 86, 2050 (2001) It permits one to detect with efficiency weak first-order transitions Use to study classical statistical models with difficultly accessed microscopic states. The theory Wang Landau sampling The algorithm uses a random walk in energy space to obtain an accurate estimate for the density of states g(e) g(e) is defined as the number of spin configurations for any given E The classical partition function can either be written as a sum over all states or over all energies (3.24) g(e) independent of temperature, it can be used to find all properties of the system at all temperatures.

32 We begin with some simple guess for the density of states: g(e) = 1 For improve g(e), spins are overturned according to the probability (3.25) Following each spin-flip trial the density of states is updateds f i is a modification factor that is initially greater than 1 (3.26) At the beginning of the random walk, the modification factor f can be as large as A histogram H(E) records the number of times a state of energy E is visited Each time the energy histogram satisfies a certain flatness criterion, f is reduced according to and reset histogram H(E) = 0 for all E

33 The reduction process of the modification factor f is repeated several times until the final value f final is close enough to 1.0 The histogram is considered as flat if x% is flatness criterion, it can be chosen between 70% and 95% is the average (mean value) histogram. The thermodynamic quantities can be evaluated by (3.27) (3.28) (3.29) where Z is the partition function defined by (3.29) The canonical distribution at a temperature T (3.30)

34 Wang-Landau Monte Carlo scheme (1) Set g(e) = 1; choose a modification factor (e.g. f 0 = e 1 ) (2) Choose an initial state (3) Choose a site i (4) Calculate the ratio of the density of states (5) Generate a random number r such that 0 < r < 1 (6) If r < : then flip the spin (7) Set (8) If the histogram is not flat, go to the next site and go to (4) (9) If the histogram is flat, decrease f, e.g. (10) Repeat steps (3) (9) until (11) Calculate properties using final density of states g(e)

35 Source : wanglandau_ising.f90 Ferromagnetic Ising spin model on square lattice PROGRAM WANG_LANDAU_ISING IMPLICIT NONE INTEGER, PARAMETER :: n = 10 REAL,DIMENSION(n,n) :: s REAL,ALLOCATABLE,DIMENSION(:) :: e1,e2,m1,m2,he,ge,pe INTEGER :: i,j,ip,im,jp,jm,ib,nbin,step,iold,inew REAL :: r,emin,emax,de,temp,eold,enew! CALL RANDOM_SEED() emax = -0.5*float(n*n); emin = -2.0*float(n*n) de = 4.0 nbin = INT((emax-emin)/de) + 1 ALLOCATE(ge(nbin),he(nbin),e1(nbin)) ALLOCATE(pe(nbin),e2(nbin),m1(nbin),m2(nbin)) s = 1.0; s(1,1) = -1.0; s(5,5) = -1.0 e1(1) = emin DO ib = 2,nbin e1(ib) = e1(ib-1) + de ENDDO

36 pe =0.0; e2 = 0.0; m1 = 0.0; m2 = 0.0 CALL wanglandau()! OPEN(UNIT=12,FILE='wl_ising.dat') temp = MINVAL(ge)-1.0 DO ib = 1,nbin IF (pe(ib) > 0.0) THEN e2(ib) = e2(ib)/pe(ib) m1(ib) = m1(ib)/pe(ib) m2(ib) = m2(ib)/pe(ib) ENDIF write(12,1) ge(ib)-temp,e1(ib),e2(ib),m1(ib),m2(ib) ENDDO 1 format(5(f16.6,1x)) CLOSE(12) OPEN(UNIT=12,FILE='wl_ising.info') write(12,*) nbin,n CLOSE(12) DEALLOCATE(ge,he,pe,e1,e2,m1,m2)

37 CONTAINS! list of functions/subroutines SUBROUTINE wanglandau REAL :: logf,logffinal,xpc LOGICAL :: notfinish,notflat,notfilled xpc = 0.9; logf = 1.0; logffinal = 10.0**(-8.0) ge = 0.0; he = 0.0 eold = etot() iold = INT((eold-emin)/de) + 1 ge(iold) = logf; he(iold) = 1.0 step = 0 notfinish =.true. DO WHILE (notfinish) step = step + 1 notflat =.true. notfilled =.true. DO WHILE (notflat) CALL RANDOM_NUMBER(r) i = INT(r*float(n))+1 CALL RANDOM_NUMBER(r) j = INT(r*float(n))+1

38 ! periodic boundary condition ip = i + 1; im = i - 1 IF (i == n) ip = 1 IF (i == 1) im = n jp = j + 1; jm = j - 1 IF (j == n) jp = 1 IF (j == 1) jm = n! calculate the energy temp = -s(i,j)*(s(ip,j)+s(im,j)+s(i,jp)+s(i,jm)) enew = eold - 2.0*temp inew = INT((enew - emin)/de) + 1 IF (inew > 0.AND. inew <=nbin) THEN CALL RANDOM_NUMBER(r) IF (ge(iold) - ge(inew) > log(r)) THEN s(i,j) = -s(i,j) iold = inew eold = enew ENDIF ENDIF

39 ge(iold) = ge(iold) + logf he(iold) = he(iold) IF (notfilled) THEN notfilled = ANY(he == 0.0) ELSE temp = xpc*sum(he)/float(nbin) IF (MINVAL(he).GE. temp) notflat=.false. CALL averaging() ENDIF ENDDO print*, 'Step ',step,' is well done' logf = 0.5*logf he = 0.0 IF (logf < logffinal) notfinish =.false. ENDDO END SUBROUTINE wanglandau

40 REAL FUNCTION etot temp = 0.0 DO i = 1,n ip = i + 1; im = i - 1 IF (i == n) ip = 1 IF (i == 1) im = n DO j = 1,n jp = j + 1; jm = j - 1 IF (j == n) jp = 1 IF (j == 1) jm = n temp = temp & - s(i,j)*(s(ip,j)+s(im,j)+s(i,jp)+s(i,jm)) ENDDO ENDDO etot = 0.5*temp END FUNCTION etot

41 SUBROUTINE averaging! pe(iold) = pe(iold) temp = eold/float(n*n) e2(iold) = e2(iold) + temp*temp temp = 0.0 DO j = 1,n DO i = 1,n temp = temp + S(i,j) ENDDO ENDDO temp = temp/float(n*n) m1(iold) = m1(iold)+ abs(temp) m2(iold) = m2(iold)+ temp*temp END SUBROUTINE averaging! END PROGRAM WANG_LANDAU_ISING

42 Density of state vs energy for N = 10

43 Wang Landau results for Ising case with N = 10 Energy and specific heat Magnetization and susceptibility

44 III.5. The applications Frustrated spin system A spin system is frustrated when one cannot find a configuration of spins to fully satisfy the interaction (bond) between every pair of spins In other words, the minimum of the total energy does not correspond to the minimum of each bond. This situation arises when: the lattice geometry does not allow to satisfy all interaction bonds simultaneously there is a competition between different kinds of interactions acting on a spin by its neighbors

45 Effects of frustrated surface in Heisenberg thin films Study the effects of frustrated surfaces on the properties of thin films Lattice: made of stacked triangular layers Spin: Heisenberg spins with an Ising-like interaction anisotropy Methods: Standard Monte Carlo simulations and Single histogram method Green s function technique Model We consider a thin film made up by stacking N z planes of triangular lattice of N N lattice sites V. T. Ngo and H. T. Diep, J. Appl. Phys. 91, 8399 (2002). V. T. Ngo and H. T. Diep, Phys. Rev. B 75, (2007).

46 Hamiltonian (3.25) Interaction between two NN surface spins is equal to J s interaction between NN in interior layers are supposed to be ferromagnetic and all equal to J = 1 The two surfaces of the film are frustrated if J s is antiferromagnetic J s < 0 MC simulation The equilibrating time is about 10 6 MC steps per spin and the averaging time is MC steps per spin. Films thickness N z = 4 and plane size N = 24, 36, 48 and 60 Periodic boundary conditions are used in the XY planes

47 Ground state Angles between spins on layer 1 are all equal Angles between vertical spins are For (diamonds) and (crosses)

48 Monte Carlo results Magnetization and susceptibility of first two layers for

49 Magnetization and susceptibility of first two layers for

50 Phase diagram in the space for Phase I denotes the ordered phase with surface noncollinear spin configuration, Phase II indicates the collinear ordered state Phase III is the paramagnetic phase

51 Layer susceptibilities versus T for L = 36, 48, 60 with J s = 0.5 and Left (right) figure corresponds to the first- second-layer susceptibility

52 Critical exponents Maximum of surface-layer susceptibility versus L for L = 24, 36, 48, 60 with J s = 0.5 (a,b), J s = 0.5 (c) and I = I s = 0.1, in the ln-ln scale. The slope gives / two-dimensional Ising model / = For 3D, / = 1.97

53 Critical behavior of magnetic thin films Study the critical behavior of magnetic thin films as a function of the film thickness Lattice: simple cubic Spin: Ising Methods: Standard Monte Carlo method Multiple histogram method Model We consider a thin film made made from a ferromagnetic simple cubic lattice The size of the film is L L N z Hamiltonian The periodic boundary conditions (PBC) is applied in the xy planes X.T. Pham Phu, V. T. Ngo and H. T. Diep, Surface Science 603, (2009).

54 Monte Carlo results Magnetization and susceptibility with

55 Susceptibility and V 1 with

56 Critical exponents Two-dimensional Ising model = 1

57 Critical exponents Two-dimensional Ising model = 1.75

58 Critical exponent 3D = Three-dimensional Ising model = 0.63

59 Critical exponent 3D = 1.25 Three-dimension Ising model = 1.24

60 Critical exponent vs filmthickness

61 Critical exponent vs filmthickness

62 From, we calculate the effective dimension of thin film

63 Stacked triangular antiferromagnets Study the phase transition in the frustrated XY and Heisenberg spin model Lattice: Stacked triangular lattice (3D) Spin: XY and Heisenberg Methods: Standard Monte Carlo method Wang-Landau method Model We consider the stacking of triangular lattices in the z direction The system size is N N N Lattice size : N = 12, 18, 24,, 120, 150 Hamiltonian V. T. Ngo and H. T. Diep, J. Appl. Phys. 103, 07C712 (2008). V. T. Ngo and H. T. Diep, Phys. Rev. E 78, (2008).

64 XY antiferromagnets Energy vs temperature for N = 84

65 XY antiferromagnets magnetization vs temperature for N = 84

66 XY antiferromagnets Energy histogram

67 Heisenberg antiferromagnets Energy and magnetization vs temperature for N = 120

68 Heisenberg antiferromagnets Energy histogram for N = 96 and 120

69 Heisenberg antiferromagnets Energy histogram for N = 150 Susceptibility vs temperature

70 Heisenberg antiferromagnets Susceptibility vs temperature Maximum of susceptibility versus N = 96, 108, 120, and 150 on a ln-ln scale

71 Crossover from first- to second-order transition in frustrated Ising antiferromagnetic films Study the nature of this phase transition in the case of a thin film as a function of the film thickness Lattice: Face center cubic thin films Spin: Ising antiferromagnetic Methods: Standard Monte Carlo method Wang-Landau method Green s function technique Model Consider a film of FCC lattice structure Hamiltonian X. T. Pham Phu, V. T. Ngo and H. T. Diep, Phys. Rev. E 79, (2009).

72 Ground state: The spin configuration depends on the interface interaction J s (a) ordering of type I for (b) ordering of type II for The energy of a surface spin for two configurations

73 Monte Carlo results for J s = J = -1 For the bulk case, L = N z = 12 Energy vs temperature Energy histogram with PBC (a) and without PBC (b) in z direction

74 For the N z = 4 Energy histogram for L = 20, 30 and 40

75 For the case N z = 2 and L = 120 Energy vs temperature Energy histogram

76 For the case N z = 2 and L =120 Specific heat vs temperature Susceptibilities of sublattices (a) 1 and (b) 3

77 The latent heat E as a function of film thickness

78 Critical exponents for N z = 2 Maximum sublattice susceptibility The maximum value of V 1

79 Fully frustrated simple cubic lattice Study the nature of the phase transition in the fully frustrated Lattice: simple cubic lattice Spin: Ising, XY and Heisenberg Methods: Standard Monte Carlo method Wang-Landau method Model Hamiltonian : for antiferromagnetic bond : for antiferromagnetic bond V. T. Ngo, D. Tien Hoang and H. T. Diep, Phys. Rev. E 82, (2010) V. T. Ngo, D. Tien Hoang and H. T. Diep, Mod. Phys. Lett. 25, 929 (2011) V. T. Ngo, D. Tien Hoang and H. T. Diep, J. Phys.: Condens. Matter 23, (2011)

80 Monte Carlo results for the case XY spin Energy and specific heat with N =24 Magnetization and susceptibility

81 Monte Carlo results for the case XY spin Energy histogram for N =24 Energy histogram The transition is clearly of first order at L = 36

82 Monte Carlo results for the case Heisenberg spin Energy and specific heat Magnetization and susceptibility

83 Monte Carlo results for the case Heisenberg spin Energy histogram The transition is clearly of first order at L = 70

84 Monte Carlo results for the case Ising spin Energy and specific heat

85 Monte Carlo results for the case Ising spin Energy histogram The transition is clearly of first order at L = 120 Maximum of the specific heat We conclude that a fully frustrated simple cubic lattice undergoes a first-order transition for Ising, XY and Heisenberg spin models

86

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 II. Monte Carlo Simulation Methods II.1. The spin models II.2. Boundary conditions II.3. Simple sampling Monte Carlo

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

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

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

Hexagonal-Close-Packed Lattice: Phase Transition and Spin Transport

Hexagonal-Close-Packed Lattice: Phase Transition and Spin Transport Hexagonal-Close-Packed Lattice: Phase ransition and Spin ransport Danh-ai Hoang, Hung he Diep o cite this version: Danh-ai Hoang, Hung he Diep. Hexagonal-Close-Packed Lattice: Phase ransition and Spin

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

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

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

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

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

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

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

Wang-Landau Sampling of an Asymmetric Ising Model: A Study of the Critical Endpoint Behavior

Wang-Landau Sampling of an Asymmetric Ising Model: A Study of the Critical Endpoint Behavior Brazilian Journal of Physics, vol. 36, no. 3A, September, 26 635 Wang-andau Sampling of an Asymmetric Ising Model: A Study of the Critical Endpoint Behavior Shan-o sai a,b, Fugao Wang a,, and D.P. andau

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

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

Statistical description of magnetic domains in the Ising model

Statistical description of magnetic domains in the Ising model arxiv:0804.3522v1 [cond-mat.stat-mech] 22 Apr 2008 Statistical description of magnetic domains in the Ising model K. Lukierska-Walasek Institute of Physics University of Zielona Góra ul. Z. Szafrana 4a,

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

A New Method to Determine First-Order Transition Points from Finite-Size Data

A New Method to Determine First-Order Transition Points from Finite-Size Data A New Method to Determine First-Order Transition Points from Finite-Size Data Christian Borgs and Wolfhard Janke Institut für Theoretische Physik Freie Universität Berlin Arnimallee 14, 1000 Berlin 33,

More information

arxiv: v1 [cond-mat.stat-mech] 22 Sep 2009

arxiv: v1 [cond-mat.stat-mech] 22 Sep 2009 Phase diagram and critical behavior of the square-lattice Ising model with competing nearest- and next-nearest-neighbor interactions Junqi Yin and D. P. Landau Center for Simulational Physics, University

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

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

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

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

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

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

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

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

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

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice

Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Population annealing study of the frustrated Ising antiferromagnet on the stacked triangular lattice Michal Borovský Department of Theoretical Physics and Astrophysics, University of P. J. Šafárik in Košice,

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

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

Interface tension of the 3d 4-state Potts model using the Wang-Landau algorithm

Interface tension of the 3d 4-state Potts model using the Wang-Landau algorithm Interface tension of the 3d 4-state Potts model using the Wang-Landau algorithm CP3-Origins and the Danish Institute for Advanced Study DIAS, University of Southern Denmark, Campusvej 55, DK-5230 Odense

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

arxiv:cond-mat/ v1 22 Sep 1998

arxiv:cond-mat/ v1 22 Sep 1998 Scaling properties of the cluster distribution of a critical nonequilibrium model Marta Chaves and Maria Augusta Santos Departamento de Física and Centro de Física do Porto, Faculdade de Ciências, Universidade

More information

Potts percolation Gauss model of a solid

Potts percolation Gauss model of a solid Cleveland State University From the SelectedWorks of Miron Kaufman January, 2008 Potts percolation Gauss model of a solid Miron Kaufman H T Diep Available at: https://works.bepress.com/miron_kaufman/21/

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 8: Computer Simulations of Generalized Ensembles

Lecture 8: Computer Simulations of Generalized Ensembles Lecture 8: Computer Simulations of Generalized Ensembles Bernd A. Berg Florida State University November 6, 2008 Bernd A. Berg (FSU) Generalized Ensembles November 6, 2008 1 / 33 Overview 1. Reweighting

More information

Invaded cluster dynamics for frustrated models

Invaded cluster dynamics for frustrated models PHYSICAL REVIEW E VOLUME 57, NUMBER 1 JANUARY 1998 Invaded cluster dynamics for frustrated models Giancarlo Franzese, 1, * Vittorio Cataudella, 1, * and Antonio Coniglio 1,2, * 1 INFM, Unità di Napoli,

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

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

CONTINUOUS- AND FIRST-ORDER PHASE TRANSITIONS IN ISING ANTIFERROMAGNETS WITH NEXT-NEAREST- NEIGHBOUR INTERACTIONS

CONTINUOUS- AND FIRST-ORDER PHASE TRANSITIONS IN ISING ANTIFERROMAGNETS WITH NEXT-NEAREST- NEIGHBOUR INTERACTIONS Continuous- Rev.Adv.Mater.Sci. and first-order 14(2007) phase 1-10 transitions in ising antiferromagnets with next-nearest-... 1 CONTINUOUS- AND FIRST-ORDER PHASE TRANSITIONS IN ISING ANTIFERROMAGNETS

More information

Brazilian Journal of Physics, vol. 26, no. 4, december, P. M.C.deOliveira,T.J.P.Penna. Instituto de Fsica, Universidade Federal Fluminense

Brazilian Journal of Physics, vol. 26, no. 4, december, P. M.C.deOliveira,T.J.P.Penna. Instituto de Fsica, Universidade Federal Fluminense Brazilian Journal of Physics, vol. 26, no. 4, december, 1996 677 Broad Histogram Method P. M.C.deOliveira,T.J.P.Penna Instituto de Fsica, Universidade Federal Fluminense Av. Litor^anea s/n, Boa Viagem,

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

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

Numerical Study of the Antiferromagnetic Ising Model in Hyperdimensions

Numerical Study of the Antiferromagnetic Ising Model in Hyperdimensions Adv. Studies Theor. Phys., Vol. 3, 2009, no. 12, 481-488 Numerical Study of the Antiferromagnetic Ising Model in Hyperdimensions N. Olivi-Tran GES, UMR-CNRS 5650, Universite Montpellier II cc 074, place

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

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

Uncovering the Secrets of Unusual Phase Diagrams: Applications of Two-Dimensional Wang-Landau Sampling

Uncovering the Secrets of Unusual Phase Diagrams: Applications of Two-Dimensional Wang-Landau Sampling 6 Brazilian Journal of Physics, vol. 38, no. 1, March, 28 Uncovering the Secrets of Unusual Phase Diagrams: Applications of wo-dimensional Wang-Landau Sampling Shan-Ho sai a,b, Fugao Wang a,, and D. P.

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

Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems

Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems Massively parallel Monte Carlo simulation of a possible topological phase transition in two-dimensional frustrated spin systems Tsuyoshi OKUBO Institute for Solid State Physics, University of Tokyo Kashiwa-no-ha,

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

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

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

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

Coupled Cluster Method for Quantum Spin Systems

Coupled Cluster Method for Quantum Spin Systems Coupled Cluster Method for Quantum Spin Systems Sven E. Krüger Department of Electrical Engineering, IESK, Cognitive Systems Universität Magdeburg, PF 4120, 39016 Magdeburg, Germany sven.krueger@e-technik.uni-magdeburg.de

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

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

Overcoming the slowing down of flat-histogram Monte Carlo simulations: Cluster updates and optimized broad-histogram ensembles

Overcoming the slowing down of flat-histogram Monte Carlo simulations: Cluster updates and optimized broad-histogram ensembles PHYSICAL REVIEW E 72, 046704 2005 Overcoming the slowing down of flat-histogram Monte Carlo simulations: Cluster updates and optimized broad-histogram ensembles Yong Wu, 1 Mathias Körner, 2 Louis Colonna-Romano,

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

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

Cover Page. The handle holds various files of this Leiden University dissertation.

Cover Page. The handle   holds various files of this Leiden University dissertation. Cover Page The handle http://hdl.handle.net/1887/49403 holds various files of this Leiden University dissertation. Author: Keesman, R. Title: Topological phases and phase transitions in magnets and ice

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

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

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

ARTICLES. Monte Carlo study of a compressible Ising antiferromagnet on a triangular lattice

ARTICLES. Monte Carlo study of a compressible Ising antiferromagnet on a triangular lattice PHYSICAL REVIEW B VOLUME 53, NUMBER 18 ARTICLES 1 MAY 1996-II Monte Carlo study of a compressible Ising antiferromagnet on a triangular lattice Lei Gu and Bulbul Chakraborty The Martin Fisher School of

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

Universality class of triad dynamics on a triangular lattice

Universality class of triad dynamics on a triangular lattice Universality class of triad dynamics on a triangular lattice Filippo Radicchi,* Daniele Vilone, and Hildegard Meyer-Ortmanns School of Engineering and Science, International University Bremen, P. O. Box

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

Computer simulations as concrete models for student reasoning

Computer simulations as concrete models for student reasoning Computer simulations as concrete models for student reasoning Jan Tobochnik Department of Physics Kalamazoo College Kalamazoo MI 49006 In many thermal physics courses, students become preoccupied with

More information

PHYSICAL REVIEW LETTERS

PHYSICAL REVIEW LETTERS PHYSICAL REVIEW LETTERS VOLUME 76 4 MARCH 1996 NUMBER 10 Finite-Size Scaling and Universality above the Upper Critical Dimensionality Erik Luijten* and Henk W. J. Blöte Faculty of Applied Physics, Delft

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

Partition function zeros and finite size scaling for polymer adsorption

Partition function zeros and finite size scaling for polymer adsorption CompPhys13: New Developments in Computational Physics, Leipzig, Nov. 28-30, 2013 Partition function zeros and finite size scaling for polymer adsorption Mark P. Taylor 1 and Jutta Luettmer-Strathmann 2

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 and spin dynamics simulation of the fully frustrated anisotropic two-dimensional Heisenberg model

Monte Carlo and spin dynamics simulation of the fully frustrated anisotropic two-dimensional Heisenberg model Journal of Magnetism and Magnetic Materials 6 () 4 Monte Carlo and spin dynamics simulation of the fully frustrated anisotropic two-dimensional Heisenberg model A.B. Lima*, B.V. Costa Departamento de F!ısica,

More information

Optimized multicanonical simulations: A proposal based on classical fluctuation theory

Optimized multicanonical simulations: A proposal based on classical fluctuation theory Optimized multicanonical simulations: A proposal based on classical fluctuation theory J. Viana Lopes Centro de Física do Porto and Departamento de Física, Faculdade de Ciências, Universidade do Porto,

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

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

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

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

Monte Carlo study of O 3 antiferromagnetic models in three dimensions

Monte Carlo study of O 3 antiferromagnetic models in three dimensions PHYSICAL REVIEW B VOLUME 53, NUMBER 5 1 FEBRUARY 1996-I Monte Carlo study of O 3 antiferromagnetic models in three dimensions J. L. Alonso and A. Tarancón Departamento de Física Teórica, Facultad de Ciencias,

More information

The critical behaviour of the long-range Potts chain from the largest cluster probability distribution

The critical behaviour of the long-range Potts chain from the largest cluster probability distribution Physica A 314 (2002) 448 453 www.elsevier.com/locate/physa The critical behaviour of the long-range Potts chain from the largest cluster probability distribution Katarina Uzelac a;, Zvonko Glumac b a Institute

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

Multicanonical parallel tempering

Multicanonical parallel tempering JOURNAL OF CHEMICAL PHYSICS VOLUME 116, NUMBER 13 1 APRIL 2002 Multicanonical parallel tempering Roland Faller, Qiliang Yan, and Juan J. de Pablo Department of Chemical Engineering, University of Wisconsin,

More information

Electron Correlation

Electron Correlation Series in Modern Condensed Matter Physics Vol. 5 Lecture Notes an Electron Correlation and Magnetism Patrik Fazekas Research Institute for Solid State Physics & Optics, Budapest lb World Scientific h Singapore

More information

(1) Consider the ferromagnetic XY model, with

(1) Consider the ferromagnetic XY model, with PHYSICS 10A : STATISTICAL PHYSICS HW ASSIGNMENT #7 (1 Consider the ferromagnetic XY model, with Ĥ = i

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

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

Zero-temperature phase transitions of an antiferromagnetic Ising model of general spin on a triangular lattice

Zero-temperature phase transitions of an antiferromagnetic Ising model of general spin on a triangular lattice PHYSICAL REVIEW B VOLUME 55, NUMBER 22 1 JUNE 1997-II Zero-temperature phase transitions of an antiferromagnetic Ising model of general spin on a triangular lattice Chen Zeng * Department of Physics, Syracuse

More information

arxiv: v1 [cond-mat.stat-mech] 9 Feb 2012

arxiv: v1 [cond-mat.stat-mech] 9 Feb 2012 Magnetic properties and critical behavior of disordered Fe 1 x Ru x alloys: a Monte Carlo approach I. J. L. Diaz 1, and N. S. Branco 2, arxiv:1202.2104v1 [cond-mat.stat-mech] 9 Feb 2012 1 Universidade

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

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

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

Physics 127b: Statistical Mechanics. Landau Theory of Second Order Phase Transitions. Order Parameter

Physics 127b: Statistical Mechanics. Landau Theory of Second Order Phase Transitions. Order Parameter Physics 127b: Statistical Mechanics Landau Theory of Second Order Phase Transitions Order Parameter Second order phase transitions occur when a new state of reduced symmetry develops continuously from

More information

Multicanonical methods

Multicanonical methods Multicanonical methods Normal Monte Carlo algorithms sample configurations with the Boltzmann weight p exp( βe). Sometimes this is not desirable. Example: if a system has a first order phase transitions

More information

Available online at ScienceDirect. Physics Procedia 53 (2014 ) Andressa A. Bertolazzo and Marcia C.

Available online at  ScienceDirect. Physics Procedia 53 (2014 ) Andressa A. Bertolazzo and Marcia C. Available online at www.sciencedirect.com ScienceDirect Physics Procedia 53 (2014 ) 7 15 Density and Diffusion Anomalies in a repulsive lattice gas Andressa A. Bertolazzo and Marcia C. Barbosa Instituto

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

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