This paper was converted on www.awesomepapers.org from LaTeX by an anonymous user.
Want to know more? Visit the Converter page.

Out-of-equilibrium Monte Carlo simulations of a classical gas with Bose-Einstein statistics

M. Di Pietro Martínez    M. Giuliano    M. Hoyuelos [email protected] Instituto de Investigaciones Físicas de Mar del Plata, CONICET, Facultad de Ciencias Exactas y Naturales, Universidad Nacional de Mar del Plata, Funes 3350, 7600 Mar del Plata, Argentina
Abstract

Algorithms to determine transition probabilities in Monte Carlo simulations are tested using a system of classical particles with effective interactions which reproduce Bose-Einstein statistics. The system is appropriate for testing different Monte Carlo simulation methods in out-of-equilibrium situations since non equivalent results are produced. We compare mobility numerical results obtained with transition probabilities derived from Glauber and Metropolis algorithms. Then, we compare these with a recent method, the interpolation algorithm, appropriate for non-equilibrium systems in homogeneous substrata and without phase transitions. The results of mobility obtained from the interpolation algorithm are qualitatively verified with molecular dynamics simulations for low concentrations.

I Introduction

If transition probabilities between different states of a system are known, then the kinetic Monte Carlo algorithm can be used to numerically reproduce a correct description of the transient or non-equilibrium behavior Bortz et al. (1975); Fichthorn and Weinberg (1991); Voter (2005); Jansen (2012). Nevertheless, it is not uncommon that the information available is restricted to the state’s energy, and transition probabilities have to be estimated using, for example, Glauber or Metropolis algorithms. Such algorithms guarantee a correct description of the equilibrium state, but not of the out-of-equilibrium transient. Convergence towards equilibrium is ensured by imposing the detailed balance condition on the transition probabilities, see for example Binder (1997); Binder and Heermann (2010).

Let us consider a system of particles, at temperature TT, divided into cells; transition probabilities describe jumps of one particle between neighboring cells. In Refs. Suárez et al. (2015); Martínez and Hoyuelos (2018, 2019a), it has been shown that the detailed balance condition can be used to derive a class of transition probabilities characterized by an interpolation parameter θ\theta. If θ=1\theta=-1, the transition probability depends on the one-particle potential in the origin cell; if θ=1\theta=1, it depends on the potential in the target cell; and if θ=0\theta=0, it depends on the potential energy change (a frequent choice in Monte Carlo simulations). The interpolation algorithm consists in the implementation of the kinetic Monte Carlo method using transition probabilities that are obtained from the potential and the interpolation parameter Suárez et al. (2015); Martínez and Hoyuelos (2018, 2019a). The purpose of this paper is to verify that this algorithm correctly describes an out-of-equilibrium system. To do this we select a specific example. The chosen system is a gas of classical particles with an effective attractive interaction which reproduces Bose-Einstein statistics. The main reason for this choice is that this system exhibits clear differences among the results generated by the mentioned numerical algorithms, in contrast, as shown below, with purely repulsive interaction of hard core.

So, we consider the following stationary non-equilibrium state. A constant force FF is applied along direction xx; the external potential is Ui=FxiU_{i}=-Fx_{i}, where xix_{i} is the position of cell ii. The system has periodic boundary conditions along the xx axis and, after some time, a stationary current is established. Particles have a mean velocity proportional to FF and the proportionality constant is the mobility BB. We consider BB (for small values of FF) as the parameter which characterizes the non-equilibrium state, and analyze its dependence on the density for the different algorithms.

This article is organized as follows. In Sec. II, the three algorithms used for transition probabilities: Glauber, Metropolis and interpolation, are described. In Sec. III, the hard-core interaction is briefly analyzed. In Sec. IV, the basic formulae for the Bose-Einstein gas are derived. In Sec. V, we present numerical and analytical results of the mobility using Glauber, Metropolis and interpolation algorithms for the Bose-Einstein gas. The Monte Carlo simulations are performed in a one-dimensional lattice gas with periodic boundary conditions. For completeness and as a verification, in Sec. VI, we compare the previous results with the ones obtained through Molecular Dynamics. This corresponds to a more detailed kinetic description, where the position and velocity of each particle inside the cells are considered sup Finally, conclusions are presented in Sec. VII.

II Algorithms for transition probabilities

According to the Glauber algorithm Glauber (1963), in a Monte Carlo step the transition from state ii to state jj, with energies EiE_{i} and EjE_{j} respectively, has a probability

pi,jG=11+eβ(EjEi),p_{i,j}^{G}=\frac{1}{1+e^{\beta(E_{j}-E_{i})}}, (1)

where β=(kBT)1\beta=(k_{B}T)^{-1}.

In the Metropolis or Metropolis-Hastings algorithm Hastings (1970), the probability is

pi,jM=min(1,eβ(EjEi)).p_{i,j}^{M}=\min(1,e^{-\beta(E_{j}-E_{i})}). (2)

Note that Metropolis algorithm is faster: if Ei=EjE_{i}=E_{j}, we have pi,jG=1/2p_{i,j}^{G}=1/2 and pi,jM=1p_{i,j}^{M}=1. We have to take this difference into account to have the same time scale in both cases. If PP is the number of jump attempts per unit time, then the transition probabilities are

Wi,jG\displaystyle W_{i,j}^{G} =2Ppi,jG\displaystyle=2\,P\,p_{i,j}^{G} (3)
Wi,jM\displaystyle W_{i,j}^{M} =Ppi,jM\displaystyle=P\,p_{i,j}^{M} (4)

where a factor 2 is included in Wi,jGW_{i,j}^{G} to compensate the speed difference between algorithms.

The energy of a given configuration {ni}\{n_{i}\} is

E=i(ϕni+niUi),E=\sum_{i}(\phi_{n_{i}}+n_{i}U_{i}), (5)

where ϕni\phi_{n_{i}} represents the interaction energy (or configuration energy) among the nin_{i} particles in the cell, in local equilibrium, and UiU_{i} is an external potential. Only processes where one particle jumps to a neighboring cell are allowed.

A different perspective is adopted for the interpolation algorithm. Instead of using the state energy, the mean field potential ViV_{i} for one particle, produced by all the other particles in the cell, is considered. We call θi\theta_{i} the interpolation parameter in cell ii. The transition probability from cell ii to cell i+1i+1 is given by

Wi,i+1=Peβ[θiVi+θi+1Vi+1+ΔV+ΔU]/2,W_{i,i+1}=Pe^{-\beta\left[\theta_{i}V_{i}+\theta_{i+1}V_{i+1}+\Delta V+\Delta U\right]/2}, (6)

where ΔU=Ui+1Ui\Delta U=U_{i+1}-U_{i} and ΔV=Vi+1Vi\Delta V=V_{i+1}-V_{i}. See Ref. Vattulainen et al. (1998) for a related approach in which the transition probability depends on the sum of energies in origin and target sites. Note that θi\theta_{i} and ViV_{i} can be functions of the number of particles, nin_{i}, in a cell ii.

A relationship between ViV_{i} and ϕni\phi_{n_{i}} has to be established. This can be done using the equilibrium distribution of particles n¯i\bar{n}_{i}. From the transition probabilities (6), a Fokker-Planck equation can be derived, whose equilibrium solution is

n¯i=eβ(Vi+Uiμ),\bar{n}_{i}=e^{-\beta(V_{i}+U_{i}-\mu)}, (7)

where μ\mu is the chemical potential, see Ref. Suárez et al. (2015). On the other hand, n¯i\bar{n}_{i} can also be obtained from the grand partition function for cell ii with energy ϕni+niUi\phi_{n_{i}}+n_{i}U_{i}. Combining both results, it can be shown Suárez et al. (2015) that

eβVi=eβ(ϕni+1ϕni),e^{-\beta V_{i}}=\langle e^{-\beta(\phi_{n_{i}+1}-\phi_{n_{i}})}\rangle, (8)

where ViV_{i} is evaluated at the average number n¯i\bar{n}_{i} (ViV_{i} is a continuous function of n¯i\bar{n}_{i} but, when implementing the algorithm for specific realizations, ViV_{i} has to be evaluated only at integer values of nin_{i}).

The interpolation parameter θi\theta_{i} can be simplified in the definition of transition probabilities (6) using the following relationship that holds in the absence of a phase transition:

eβθiVi=11+βniVi,e^{-\beta\theta_{i}V_{i}}=\frac{1}{1+\beta n_{i}V^{\prime}_{i}}, (9)

where ViV^{\prime}_{i} is the the derivative of ViV_{i} with respect to the number of particles. The demonstration of (9) can be found in Ref. Martínez and Hoyuelos (2019b); it is obtained from the fact that the energy difference between final and initial states is equal to the difference between the energy barriers (the exponents in Wi,i+1W_{i,i+1}) of the forward and backward processes. The transition probability form cell ii to i+1i+1 becomes

Wi,i+1=Peβ(ΔV+ΔU)/2(1+βniVi)1/2(1+βni+1Vi+1)1/2.W_{i,i+1}=P\frac{e^{-\beta(\Delta V+\Delta U)/2}}{(1+\beta n_{i}V^{\prime}_{i})^{1/2}(1+\beta n_{i+1}V^{\prime}_{i+1})^{1/2}}. (10)

In summary, transition probabilities in the interpolation algorithm are not obtained directly from the state energy, but are functions of the potential ViV_{i} that is obtained from (8). The method is more involved than Glauber or Metropolis, and it only applies to system of particles with local interactions, where the energy can be written as in (5). The advantage is that it holds out of equilibrium.

Here, models where ϕni\phi_{n_{i}} is a simple function of nin_{i} are considered. Long range interactions, such as the Coulomb potential, can not be represented by these methods, where the energy of one cell, given by ϕni+niUi\phi_{n_{i}}+n_{i}U_{i}, does not depend on the number of particles in nearby cells. Interaction between particles in different cells is neglected. For a specific (short range) interaction potential, the configuration energy ϕni\phi_{n_{i}} in general has to be obtained numerically. If the interaction potential is 𝒰i(𝐪1,,𝐪ni)\mathcal{U}_{i}(\mathbf{q}_{1},\dots,\mathbf{q}_{n_{i}}), with 𝐪j\mathbf{q}_{j} the position of particles in cell ii, the configuration energy ϕni\phi_{n_{i}} is given by

eβϕni=eβ𝒰i(𝐪1,,𝐪ni)0e^{-\beta\phi_{n_{i}}}=\langle e^{-\beta\mathcal{U}_{i}(\mathbf{q}_{1},\dots,\mathbf{q}_{n_{i}})}\rangle^{0} (11)

where average 0\langle\ \rangle^{0} is computed with the probability distribution of non-interacting particles (that is, particles randomly distributed).

III Hard-core interaction

The main purpose of this paper is to check the different algorithms with an effective Bose-Einstein interaction. But before that, we wish to briefly analyze other simple potential: hard core. These potentials represent two extreme situations: purely attractive or purely repulsive interactions. It is shown in this section that the mobility of hard spheres against concentration is the same independently of the simulation algorithm. Any of the three options, Glauber, Metropolis or interpolation, can be used for the description of the out-of-equilibrium behavior of hard spheres in a discrete lattice.

The hard-core interaction is given by

ϕni={0if ni=0,1if ni2.\phi_{n_{i}}=\left\{\begin{array}[]{cl}0&\text{if }n_{i}=0,1\\ \infty&\text{if }n_{i}\geq 2\end{array}\right.. (12)

Hard core imposes that, in any cell, nin_{i} takes values 0 or 1 only. Let us consider a jump from cell ii to cell i+1i+1. The energy of the initial configuration {,ni,ni+1,}\{\cdots,n_{i},n_{i+1},\cdots\} is EiniE_{\text{ini}}, and the energy of the final configuration {,ni1,ni+1+1,}\{\cdots,n_{i}-1,n_{i+1}+1,\cdots\} is EfinE_{\text{fin}}. The external energy change is ΔU=Fa\Delta U=-Fa, with aa the cell size. Then, the energy change is

ΔE\displaystyle\Delta E =EfinEini\displaystyle=E_{\text{fin}}-E_{\text{ini}}
=ΔU+ϕni1+ϕni+i+1ϕniϕni+1\displaystyle=\Delta U+\phi_{n_{i}-1}+\phi_{n_{i+i}+1}-\phi_{n_{i}}-\phi_{n_{i+1}}
={Faif ni+1=0if ni+1=1,\displaystyle=\left\{\begin{array}[]{cl}-Fa&\text{if }n_{i+1}=0\\ \infty&\text{if }n_{i+1}=1\end{array}\right., (15)

where it was assumed that ni=1n_{i}=1 so that the jump process from ii to i+1i+1 is possible (there must be a particle to make the jump).

Let us call vv the mean velocity of particles when a force FF is applied. Analytical expressions for the mobility, defined as B=v/FB=v/F, can be derived for the three algorithms to compare with numerical results. Mobility is obtained from the mean current:

J=niWi,i+1ni+1Wi+1,i,J=\langle n_{i}W_{i,i+1}-n_{i+1}W_{i+1,i}\rangle, (16)

since J=vn¯/a=BFn¯/aJ=v\,\bar{n}/a=BF\bar{n}/a, so that B=Ja/(Fn¯)B=J\,a/(F\bar{n}). We call the mobilities for Glauber and Metropolis algorithms BGB^{G} and BMB^{M} respectively. In the ideal system, where effects of interactions are neglected, the mobility is given by the Einstein relation: B0=βD0B_{0}=\beta D_{0}, where D0=Pa2D_{0}=Pa^{2} is the diffusivity.

First, for the Metropolis algorithm, the transition probability for a jump from ii to i+1i+1, assuming that F>0F>0, is

Wi,i+1M=Pmin(1,eβΔE)={Pif ni+1=00if ni+1=1,W^{M}_{i,i+1}=P\min(1,e^{-\beta\,\Delta E})=\left\{\begin{array}[]{cl}P&\text{if }n_{i+1}=0\\ 0&\text{if }n_{i+1}=1\end{array}\right., (17)

expression that can be written as

Wi,i+1M=P(1ni+1).W^{M}_{i,i+1}=P(1-n_{i+1}). (18)

And, for the jump from i+1i+1 to ii,

Wi+1,iM=P(1βFa)(1ni),W^{M}_{i+1,i}=P(1-\beta Fa)(1-n_{i}), (19)

where it is assumed that the force and the cell size satisfy FakBTFa\ll k_{B}T so that eβFa1βFae^{-\beta Fa}\simeq 1-\beta Fa; this approximation is necessary to get a linear relation between mean velocity vv and force FF, from which the mobility is obtained; the approximation corresponds to the linear regime of non equilibrium thermodynamics. Using (18) and (19) to evaluate the current (16), we get

JM=PβFan¯(1n¯),J^{M}=P\beta Fa\,\bar{n}(1-\bar{n}), (20)

and the mobility is

BMB0=1n¯(hard core).\frac{B^{M}}{B_{0}}=1-\bar{n}\qquad\text{(hard core)}. (21)

It is convenient to present the mobility relative to B0B_{0}, so that the result is independent of the jump rate PP or the cell size aa. In the last expressions, subindex ii is not used for the mean number of particles, n¯\bar{n}, since a homogeneous system is considered.

For the Glauber algorithm, using the definition (1), it can be shown that

Wi,i+1G\displaystyle W^{G}_{i,i+1} =P(1+βFa/2)(1ni+1)\displaystyle=P(1+\beta Fa/2)(1-n_{i+1}) (22)
Wi+1,iG\displaystyle W^{G}_{i+1,i} =P(1βFa/2)(1ni).\displaystyle=P(1-\beta Fa/2)(1-n_{i}). (23)

Using (16), the result for the current JGJ^{G} turns out to be equal to JMJ^{M}, and, of course, also the mobility:

BGB0=1n¯(hard core).\frac{B^{G}}{B_{0}}=1-\bar{n}\qquad\text{(hard core)}. (24)

For the interpolation algorithm, the first step is to calculate ViV_{i}. We have that

eβ(ϕni+1ϕni)\displaystyle e^{-\beta(\phi_{n_{i}+1}-\phi_{n_{i}})} ={1if ni=00if ni=1\displaystyle=\left\{\begin{array}[]{cl}1&\text{if }n_{i}=0\\ 0&\text{if }n_{i}=1\end{array}\right. (27)
=1ni,\displaystyle=1-n_{i}, (28)

then, from Eq. (8), we have

Vi=β1ln(1n¯i)V_{i}=-\beta^{-1}\ln(1-\bar{n}_{i}) (29)

and

Vi=β11n¯iV_{i}^{\prime}=\frac{\beta^{-1}}{1-\bar{n}_{i}} (30)

When replacing this expressions in Eq. (10) for the transition probability, as mentioned before, ViV_{i} and ViV_{i}^{\prime} have to be evaluated at integer values of nin_{i}. Then, using also that

ΔV=Vi+1Vi=β1ln(1ni+11ni)\Delta V=V_{i+1}-V_{i}=-\beta^{-1}\ln\left(\frac{1-n_{i+1}}{1-n_{i}}\right) (31)

it can be shown that the transition probabilities for the interpolation algorithm are equal to those of the Glauber algorithm:

Wi,i+1I\displaystyle W^{I}_{i,i+1} =P(1+βFa/2)(1ni+1)\displaystyle=P(1+\beta Fa/2)(1-n_{i+1}) (32)
Wi+1,iI\displaystyle W^{I}_{i+1,i} =P(1βFa/2)(1ni).\displaystyle=P(1-\beta Fa/2)(1-n_{i}). (33)

Therefore, the mobility is also the same,

BIB0=1n¯(hard core).\frac{B^{I}}{B_{0}}=1-\bar{n}\qquad\text{(hard core)}. (34)

Figure 1 shows numerical results of the mobility using Metropolis and Glauber (or interpolation) algorithms for the hard-core interaction. The results match the expression obtained for B/B0B/B_{0}.

Refer to caption
Figure 1: Mobility B/B0B/B_{0} against average number of particles per cell n¯\bar{n}, using hard-core interaction in a lattice with 100100 cells, with periodic boundary conditions. Numerical results for Metropolis (squares) and Glauber or interpolation (circles) algorithms are in agreement with the prediction B/B0=1n¯B/B_{0}=1-\bar{n} (solid line). Number of Monte Carlo steps: 10410^{4}, applied force: βFa=0.05\beta Fa=0.05.

In summary, hard spheres are not useful to discriminate among algorithms. Any of them seems to work. This is not the case for the attractive interaction of a classical Bose-Einstein gas, and this is the main reason why we focus our attention on it.

IV Basic formulae for the Bose-Einstein gas

In the lattice gas description, the system is divided into cells of size aa much smaller than the characteristic length of particle density variations. Temperature TT and chemical potential μ\mu are homogeneous. Interaction energy between particles in different cells is neglected. Since spatial variations are smooth, cells are point-like in the continuous limit, and local thermal equilibrium holds. This means that each cell can be considered as an equilibrium system, although the whole system is out of equilibrium. We can write the classical grand partition function of cell ii as

𝒵i=ni=0exp[β(ϕni+niUiniμ)]ni!,\mathcal{Z}_{i}=\sum_{n_{i}=0}^{\infty}\frac{\exp[-\beta(\phi_{n_{i}}+n_{i}U_{i}-n_{i}\mu)]}{n_{i}!}, (35)

where the energy in cell ii is ϕni+niUi\phi_{n_{i}}+n_{i}U_{i}.

We consider a configuration energy

ϕni=β1lnni!\phi_{n_{i}}=-\beta^{-1}\ln n_{i}! (36)

to reproduce Bose-Einstein statistics, since in this case we have

𝒵i=ni=0exp[βni(Uiμ)]=11eβ(Uiμ),\mathcal{Z}_{i}=\sum_{n_{i}=0}^{\infty}\exp[-\beta n_{i}(U_{i}-\mu)]=\frac{1}{1-e^{-\beta(U_{i}-\mu)}}, (37)

and the average number of particles is

n¯i=1eβ(Uiμ)1.\bar{n}_{i}=\frac{1}{e^{\beta(U_{i}-\mu)}-1}. (38)

If we know that the system has a total number of particles NN, the chemical potential is obtained from the relationship N=in¯iN=\sum_{i}\bar{n}_{i}, where the sum is performed in all cells. From Ec. (38), the chemical potential is

μ=Ui+β1lnn¯iβ1ln(1+n¯i).\mu=U_{i}+\beta^{-1}\ln\bar{n}_{i}-\beta^{-1}\ln(1+\bar{n}_{i}). (39)

Let us consider a cell in which the potential UiU_{i} takes a value μ\mu^{\circ}, i.e. a reference chemical potential. Then, in the previous expression, we can recognize the ideal and residual parts of the chemical potential:

μ=μ+β1lnn¯iidealβ1ln(1+n¯i)residual.\mu=\underbrace{\mu^{\circ}+\beta^{-1}\ln\bar{n}_{i}}_{\text{ideal}}-\underbrace{\beta^{-1}\ln(1+\bar{n}_{i})}_{\text{residual}}. (40)

This simplified description in terms of jumps between neighboring cells is intended to correctly reproduce the behavior of a system of particles which move with given velocities and interact with a space dependent potential. The effective potential, also known as statistical potential, between two bosons at distance rr is

vs(r)=β1ln(1+e2πr2/λ2),v_{s}(r)=-\beta^{-1}\ln\left(1+e^{-2\pi r^{2}/\lambda^{2}}\right), (41)

where λ\lambda determines the range of the interaction (it is equal to the de Broglie wavelength in the quantum case) (Pathria and Beale, 2011, p. 138). Notice that here we use the term “boson” to informally refer to classical particles with Bose-Einstein statistics. The statistical potential holds for small concentration, so we can expect descriptions to agree only in this limit. The concentration of a cell (in local equilibrium) is ρi=n¯i/a3\rho_{i}=\bar{n}_{i}/a^{3}. Also, in the limit of small concentration, we can use the cluster expansion to obtain the chemical potential:

eβμλ3=ρib2ρi2+𝒪(ρi3),\frac{e^{\beta\mu}}{\lambda^{3}}=\rho_{i}-b_{2}\rho_{i}^{2}+\mathcal{O}(\rho_{i}^{3}), (42)

where b2b_{2} is the coefficient of two-particle clusters given by

b2=d3𝐫(eβvs(r)1)=λ3/23/2;b_{2}=\int d^{3}\mathbf{r}\,(e^{-\beta v_{s}(r)}-1)=\lambda^{3}/2^{3/2}; (43)

see for example Eq. (5.32) in Ref. Kardar (2007). The cluster expansion is based on the quantity f(𝐫)=eβv(r)1f(\mathbf{r})=e^{-\beta v(r)}-1 as a convenient expansion parameter, with v(r)v(r) the interaction potential. For short-range hard-core interactions, it is equal to 1-1 for r0r\rightarrow 0 and decays to zero for increasing rr. In our case, it takes the value 11 for r0r\rightarrow 0 and vanishes exponentially as rr increases.

From Eqs. (42) and (43) we have that the chemical potential is

μβ1ln(ρiλ3)idealβ1ln(1+ρiλ3/23/2)residual,\mu\simeq\underbrace{\beta^{-1}\ln(\rho_{i}\lambda^{3})}_{\text{ideal}}-\underbrace{\beta^{-1}\ln(1+\rho_{i}\lambda^{3}/2^{3/2})}_{\text{residual}}, (44)

where, as in Eq. (40), we can identify the ideal and residual parts.

By imposing the condition in which the chemical potential in the lattice gas description, Eq. (40), is equal to the chemical potential in the kinetic description, Eq. (44), more specifically, by matching the residual parts of the chemical potential, we have that n¯i=ρiλ3/23/2\bar{n}_{i}=\rho_{i}\lambda^{3}/2^{3/2}, and therefore,

a=λ/21/2.a=\lambda/2^{1/2}. (45)

But setting this condition poses a problem in the calculation of the grand partition function, since in Eq. (35) interactions with particles in neighboring cells are neglected. This approximation is valid as long as aa is much larger than the interaction range, i.e. aλa\gg\lambda, a condition that is not fulfilled in (45). Still, the qualitative behavior of the chemical potential is the same in both descriptions. We expect equivalent qualitative behaviors also for the mobility although, due to the inconsistency of approximations, we can not expect quantitative agreement.

V Mobility from Glauber, Metropolis and interpolation algorithms

The energy change for a jump from cell ii to i+1i+1 with effective Bose-Einstein interaction is

ΔE\displaystyle\Delta E =ΔU+ϕni1+ϕni+i+1ϕniϕni+1\displaystyle=\Delta U+\phi_{n_{i}-1}+\phi_{n_{i+i}+1}-\phi_{n_{i}}-\phi_{n_{i+1}}
=Faβ1lnni+1+1ni,\displaystyle=-Fa-\beta^{-1}\ln\frac{n_{i+1}+1}{n_{i}}, (46)

where the condition ni1n_{i}\geq 1 has to be fulfilled in order to have the possibility of a jump from cell ii (for cells with ni=0n_{i}=0 there is no jump process and no need to calculate ΔE\Delta E).

With fixed boundary conditions and an external force, particles accumulate on one side of the system and, in equilibrium, they have the Bose-Einstein distribution given by Eq. (38). We have verified that Metropolis or Glauber algorithms converge to the Bose Einstein distribution in this case, as shown in Fig. 2.

Refer to caption
Figure 2: Equilibrium distribution of particles, n¯i\bar{n}_{i}, against position, ii, for Glauber (squares), Metropolis (circles) and Interpolation (diamonds) algorithms. The interpolation algorithm data is from Ref. Suárez et al. (2015). The curve corresponds to the Bose-Einstein distribution, Eq. (38) with βUi=βFai=0.03i\beta U_{i}=-\beta Fai=-0.03\,i and βμ\beta\mu calculated from the condition N=in¯iN=\sum_{i}\bar{n}_{i} with NN the total number of particles. Number of Monte Carlo steps: 2 1052\;10^{5}, lattice size: 100, number of particles N=50N=50.

Now we turn to the non-equilibrium situation. Instead of fixed boundary conditions, let us consider periodic boundary conditions. After some time, the system is in a stationary non-equilibrium state. The mean velocity of a particle in terms of the transition probabilities between cells of size aa is

v=aWi,i+1aWi,i1.v=aW_{i,i+1}-aW_{i,i-1}. (47)

For small concentration (ideal gas), interactions can be neglected and ΔEFa\Delta E\simeq-Fa. It can be shown that for both algorithms, Glauber and Metropolis, the mean velocity for small concentration is v=Pa2βFv=Pa^{2}\beta F. For Metropolis at small concentration and a positive force FF, transition probabilities are

Wi,i+1M=PWi,i1M=P(1βFa)(small concentration)\begin{aligned} W_{i,i+1}^{M}&=P\\ W_{i,i-1}^{M}&=P(1-\beta Fa)\end{aligned}\qquad\text{(small concentration)}

Replacing in (47), we obtain

vM=Pa2βF(small conc.).v^{M}=Pa^{2}\beta F\qquad\qquad\text{(small conc.)}.

For the Glauber algorithm we have

Wi,i+1G=2P1+eβFaP(1+βFa/2)Wi,i1G=2P1+eβFaP(1βFa/2).(small conc.)\begin{aligned} W_{i,i+1}^{G}&=\dfrac{2P}{1+e^{-\beta Fa}}\simeq P(1+\beta Fa/2)\\ W_{i,i-1}^{G}&=\dfrac{2P}{1+e^{\beta Fa}}\simeq P(1-\beta Fa/2).\end{aligned}\qquad\text{(small conc.)}

And, again, replacing in (47), we obtain

vG=Pa2βF(small conc.).v^{G}=Pa^{2}\beta F\qquad\qquad\text{(small conc.)}.

The mobility, BB, is defined as v/Fv/F. The previous results for the velocity, for both algorithms, are consistent with the Einstein relation; in both cases, B0=βPa2=βD0B_{0}=\beta Pa^{2}=\beta D_{0} is obtained. Subindex 0 identifies the small concentration regime.

As mentioned before, mobility is obtained from the mean current, Eq. (16). It can be shown that, for the Glauber algorithm,

BGB0\displaystyle\frac{B^{G}}{B_{0}} =2n¯ni=0ni+1=0ni2(ni+1+1)+ni+12(ni+1)(ni+ni+1+1)\displaystyle=\frac{2}{\bar{n}}\sum_{n_{i}=0}^{\infty}\sum_{n_{i+1}=0}^{\infty}\frac{n_{i}^{2}(n_{i+1}+1)+n_{i+1}^{2}(n_{i}+1)}{(n_{i}+n_{i+1}+1)}
×n¯ni+ni+1(1+n¯)ni+ni+1+2,\displaystyle\qquad\times\frac{\bar{n}^{n_{i}+n_{i+1}}}{(1+\bar{n})^{n_{i}+n_{i+1}+2}}, (48)

and that the corresponding expression for the Metropolis algorithm can be simplified to

BMB0=1+n¯1+2n¯;\frac{B^{M}}{B_{0}}=\frac{1+\bar{n}}{1+2\bar{n}}; (49)

see the Appendix for details.

In Fig. 3, we show the numerical results of the mobility obtained with both algorithms, compared with the analytical expressions (V) and (49). The agreement between numerical and analytical results supports their validity. Both algorithms coincide in the limit of small concentration, where B=B0B=B_{0} and interactions can be neglected. But as the mean number of particles is increased, discrepancies grow. There is a quantitative difference of about 30% between both predictions of BB for larger n¯\bar{n}. It is well known that we can not expect a correct description of a non-equilibrium state with these algorithms. Nevertheless, it is interesting to determine how far from the correct result they are. This is the purpose of the next paragraphs.

Refer to caption
Figure 3: Mobility B/B0B/B_{0} for a system of particles with bosonic interaction obtained with Glauber and Metropolis algorithms, as a function of the average number of particles per cell n¯\bar{n}. Points represent numerical results while curves correspond to the analytical expressions (V) and (49) for the Glauber and Metropolis algorithms respectively. Each sum in Eq. (V) was approximated using a maximum number of terms equal to 1010. Numerical results were obtained using a lattice of 100 cells, during 10710^{7} Monte Carlo steps, with an applied force βFa=0.03\beta Fa=0.03.

For the interpolation algorithm, using Eq. (36) for ϕni\phi_{n_{i}} in (8), we have

Vi=β1ln(n¯i+1).V_{i}=-\beta^{-1}\ln(\bar{n}_{i}+1). (50)

Notice that ViV_{i} is equal to the residual part of the chemical potential, see Eq. (40), and Eq. (8) corresponds to the Widom insertion method, where ϕni+1ϕni\phi_{n_{i}+1}-\phi_{n_{i}} is the insertion energy, i.e. the interaction energy needed to insert one particle. Using this result for ViV_{i}, and its derivative, in (10), the transition probability is

Wi,i+1=PeβΔU/2(1+ni+1).W_{i,i+1}=P\,e^{-\beta\,\Delta U/2}(1+n_{i+1}). (51)

With this information, we can calculate the mobility BIB^{I} for the interpolation algorithm (see the Appendix). The result is

BIB0=1+n¯.\frac{B^{I}}{B_{0}}=1+\bar{n}. (52)

As in the previous results, a homogeneous system, in which n¯i=n¯i+1=n¯\bar{n}_{i}=\bar{n}_{i+1}=\bar{n}, is considered for the calculation of mobility. Figure 4 shows a good agreement between this theoretical result and kinetic Monte Carlo simulations.

Refer to caption
Figure 4: Mobility B/B0B/B_{0} for a system of particles with bosonic interaction obtained with the interpolation algorithm, as a function of the average number of particles per cell n¯\bar{n}. Symbols \diamond represent numerical results taken from Ref. Suárez et al. (2015) (applied force βFa=0.05\beta Fa=0.05), while the line corresponds to Eq. (52).

The result for the mobility obtained with the interpolation algorithm is qualitatively different from the results of Glauber and Metropolis algorithms. While for the interpolation algorithm we have a mobility which increases with n¯\bar{n}, for the other algorithms it decreases (see Fig. 3). As mentioned before, we know that Glauber and Metropolis algorithms are designed to give the correct equilibrium state; they should not be applied to non-equilibrium situations, but it is interesting to evaluate the error. According to the interpolation algorithm, which is designed for non-equilibrium states (with limitations that are summarized in the conclusions), the error increases with concentration. Glauber and Metropolis algorithms give the correct result for the mobility only in the limit of small n¯\bar{n}, where interactions can be neglected.

VI Molecular dynamics

The objective of this section is to obtain the mobility of a boson gas in the context of a classical kinetic description which includes velocity of particles, and compare with the results of the previous sections.

The method is to numerically obtain the self-diffusivity DD and use the Einstein relation to calculate the mobility B=βDB=\beta D. The Green-Kubo formula (see for example (Kubo et al., 1998, Sec. 4.6.2) or (Reichl, 1998, Sec. S10.G)) is used to obtain the self-diffusivity from the velocity autocorrelation function:

D=130𝑑t𝐯(0)𝐯(t).D=\frac{1}{3}\int_{0}^{\infty}dt^{\prime}\,\langle\mathbf{v}(0)\cdot\mathbf{v}(t^{\prime})\rangle. (53)

We wish to emphasize that with this method the mobility is obtained from simulations of the system in equilibrium, without a force applied. The main purpose of this paper is to check algorithms for Monte Carlo simulations out of equilibrium. The motivation of this section is to obtain mobility using molecular dynamics, and in this context we can choose the method based on simplicity.

To compare with results of the previous sections, we have to calculate the mobility BB relative to its value for the ideal gas, B0B_{0}. From the kinetic theory of transport in dilute gases (see for example (McQuarrie, 2000, Sec. 16-1)), we know that the self-diffusivity in the ideal case, and therefore B0B_{0}, behaves as 1/ρ1/\rho, where ρ\rho is the particle density. The proportionality constant, between B0B_{0} and 1/ρ1/\rho, is numerically set in our results so as to have B/B01B/B_{0}\rightarrow 1 for ρ0\rho\rightarrow 0.

Then, we perform molecular dynamic simulations of a system of particles with a given density ρ\rho, in equilibrium, which interact among them with the statistical potential of Eq. (41). We do this for different densities and obtain the mobility through the velocity autocorrelation function. We focus our attention on the slope of the mobility for small concentrations, since this is the limit for which the statistical potential (41) holds.

Refer to caption
Figure 5: Mobility B/B0B/B_{0} against n¯=ρλ3/23/2\bar{n}=\rho\lambda^{3}/2^{3/2} obtained from molecular dynamics simulations. We use LAMMPS software Large-scale Atomic/Molecular Massively Parallel Simulator ; Plimpton (1993) with parameters: temperature T=1T=1, Boltzmann constant kB=1k_{B}=1, number of particles 20002000, cut-off distance rc=2.5r_{c}=2.5, λ=1\lambda=1, nve integration method and 10710^{7} run steps. The interactions among particles are given by the statistical potential for bosons, Eq. (41) (this defines a new pair style in LAMMPS software). For each simulation, we obtain a value of BB for a given ρ\rho. We perform around 9090 realizations for the same ρ\rho (with different initial conditions) to average. The dashed line corresponds to a linear fit (1.008+1.7n¯1.008+1.7\bar{n}), while the solid area represents its error, i.e. the area between 1.006+1.4n¯1.006+1.4\,\bar{n} and 1.010+2.0n¯1.010+2.0\,\bar{n}. We added the linear curve corresponding to the interpolation algorithm for comparison (solid line); see Eq. (52).

In Fig. 5, we show the data obtained for BB as a function of n¯=ρλ3/23/2\bar{n}=\rho\lambda^{3}/2^{3/2}. This result supports the validity of the interpolation algorithm since the same qualitative behavior is obtained: an approximate linear increase of mobility with concentration with slopes of the same order, see Fig. 5.

VII Conclusions

We study mobility in a system of classical particles with interactions. Two different approaches are possible: a lattice gas with transition probabilities among cells, or a kinetic description in a continuous space. A fundamental problem of the lattice gas description is to determine transition probabilities when only state energies are known. Monte Carlo simulations with Glauber or Metropolis algorithms correctly describe the equilibrium state but they are not supposed to hold out of equilibrium. Instead, the interpolation algorithm was recently introduced Suárez et al. (2015); Martínez and Hoyuelos (2018, 2019a, 2019b) in order to obtain transition probabilities that hold out of equilibrium; it is summarized in Eqs. (8) and (10). Limitations of the method are: the system should be in local thermal equilibrium (i.e. deviations from equilibrium have a characteristic length much larger than the cell size), no phase transition occur and the interaction is local [more precisely, the interaction energy can be written as in (5)]. Also, the information provided by the algorithm is incomplete if the jump rate PP has a non-trivial dependence on concentration, as it happens, for example, for diffusion in a solid Martínez and Hoyuelos (2019b).

We calculate the mobility in a non-equilibrium stationary state: a force is applied to a one-dimensional array of cells with periodic boundary conditions and homogeneous density. For hard core interaction, the same results are obtained for Glauber, Metropolis or interpolation algorithms. Instead, for an attractive potential such that the Bose-Einstein statistics is reproduced, important differences are obtained among algorithms. There is a difference of about 30% between the Glauber and Metropolis predictions for large concentration; in both cases, mobility decreases with concentration towards an asymptotic value. The mobility obtained from the interpolation algorithm qualitatively differs from the ones of the other methods. Instead of decreasing with concentration, it increases. This means an unbounded increasing error for the Glauber and Metropolis algorithms. They can be used to calculate mobility only in the limit of small concentration, where BB0B\rightarrow B_{0}.

The lattice gas description should be consistent with the kinetic description. So, we also consider particles moving in a continuous space and interacting with a statistical potential (41) which corresponds to the Bose-Einstein distribution. The mobility obtained from molecular dynamics simulations, Fig. 5, is in qualitative agreement with the prediction of the interpolation algorithm.

Acknowledgements.
The authors acknowledge discussions with H. Mártin which were useful for the development of these ideas. This work was partially supported by Consejo Nacional de Investigaciones Científicas y Técnicas (CONICET, Argentina, PIP 112 201501 00021 CO). This work used computational resources from CCAD – Universidad Nacional de Córdoba cca , in particular the Mendieta Cluster, which is part of SNCAD – MinCyT, República Argentina.

Appendix

In this appendix, the expressions (V) and (49) for the mobility for Glauber and Metropolis algorithms are derived.

Using (46) for the energy change, the transition probabilities for the Glauber algorithm are

Wi,i+1\displaystyle W_{i,i+1} =2Pni+1+1nieβFa+ni+1+1,\displaystyle=2P\frac{n_{i+1}+1}{n_{i}e^{-\beta Fa}+n_{i+1}+1}, (54)
Wi+1,i\displaystyle W_{i+1,i} =2Pni+1ni+1eβFa+ni+1.\displaystyle=2P\frac{n_{i}+1}{n_{i+1}e^{\beta Fa}+n_{i}+1}. (55)

Replacing these expressions in the current J=𝒥J=\langle\mathcal{J}\rangle, with

𝒥=niWi,i+1ni+1Wi+1,i,\mathcal{J}=n_{i}W_{i,i+1}-n_{i+1}W_{i+1,i}, (56)

and making approximations for βFa1\beta Fa\ll 1, we have

J2P\displaystyle\frac{J}{2P} =nini+1ni+ni+1+1\displaystyle=\left\langle\frac{n_{i}-n_{i+1}}{n_{i}+n_{i+1}+1}\right\rangle
+βFa(ni2(ni+1+1)+ni+12(ni+1))(ni+ni+1+1)2.\displaystyle\quad+\left\langle\frac{\beta Fa(n_{i}^{2}(n_{i+1}+1)+n_{i+1}^{2}(n_{i}+1))}{(n_{i}+n_{i+1}+1)^{2}}\right\rangle. (57)

The first term of the right side cancels due to the symmetry of the homogeneous stationary state. Knowing that B=Ja/(Fn¯)B=J\,a/(F\bar{n}) and that B0=βPa2B_{0}=\beta Pa^{2}, we have

BGB0=Jn¯PβFa=2n¯ni2(ni+1+1)+ni+12(ni+1)(ni+ni+1+1)2.\frac{B^{G}}{B_{0}}=\frac{J}{\bar{n}P\beta Fa}=\frac{2}{\bar{n}}\left\langle\frac{n_{i}^{2}(n_{i+1}+1)+n_{i+1}^{2}(n_{i}+1)}{(n_{i}+n_{i+1}+1)^{2}}\right\rangle. (58)

The probability of having nin_{i} particles knowing that the average value is n¯\bar{n}, for the Bose-Einstein distribution, is given by

pBE(ni)=n¯ni(n¯+1)ni+1;p_{\text{BE}}(n_{i})=\frac{\bar{n}^{n_{i}}}{(\bar{n}+1)^{n_{i}+1}}; (59)

see for example (Pathria and Beale, 2011, p. 152). Using this probability, we obtain Eq. (V) for the mobility in the Glauber algorithm. Actually, a correction of order βFa\beta Fa should be added to pBE(ni)p_{\text{BE}}(n_{i}) to use the probability which corresponds to the stationary non-equilibrium state, since Eq. (59) holds in equilibrium. But this correction cancels when only terms up to order βFa\beta Fa are kept in the equation for the current.

A similar process is applied to obtain the mobility for the Metropolis algorithm. Replacing the expression (46) for ΔE\Delta E in the Metropolis transition probabilities, we have

𝒥P\displaystyle\frac{\mathcal{J}}{P} =nimin(1,ni+1+1nieβFa)\displaystyle=n_{i}\min\left(1,\frac{n_{i+1}+1}{n_{i}}e^{\beta Fa}\right)
ni+1min(1,ni+1ni+1eβFa).\displaystyle\quad-n_{i+1}\min\left(1,\frac{n_{i}+1}{n_{i+1}}e^{-\beta Fa}\right). (60)

Assuming that βFa1\beta Fa\ll 1 and considering all possible combinations of nin_{i} and ni+1n_{i+1}, we get

𝒥P={(ni+1)βFa1 if ni+1ni+10 if ni+1=ni1 if ni+1=ni11+(ni+1+1)βFa if ni+1ni2.\frac{\mathcal{J}}{P}=\left\{\begin{array}[]{cl}(n_{i}+1)\beta Fa-1&\text{ if }n_{i+1}\geq n_{i}+1\\ 0&\text{ if }n_{i+1}=n_{i}\\ 1&\text{ if }n_{i+1}=n_{i}-1\\ 1+(n_{i+1}+1)\beta Fa&\text{ if }n_{i+1}\leq n_{i}-2\end{array}\right.. (61)

The average of this expression can be written as

JP\displaystyle\frac{J}{P} =ni=2ni+1=0ni2[1+(ni+1+1)βFa]pBE(ni+1)pBE(ni)\displaystyle=\sum_{n_{i}=2}^{\infty}\sum_{n_{i+1}=0}^{n_{i}-2}[1+(n_{i+1}+1)\beta Fa]p_{\text{BE}}(n_{i+1})p_{\text{BE}}(n_{i})
+ni=1pBE(ni1)pBE(ni)\displaystyle\ \ +\sum_{n_{i}=1}^{\infty}p_{\text{BE}}(n_{i}-1)p_{\text{BE}}(n_{i})
+ni=0ni+1=ni+1[(ni+1)βFa1]pBE(ni+1)pBE(ni).\displaystyle\ \ +\sum_{n_{i}=0}^{\infty}\sum_{n_{i+1}=n_{i}+1}^{\infty}[(n_{i}+1)\beta Fa-1]p_{\text{BE}}(n_{i+1})p_{\text{BE}}(n_{i}). (62)

These sums can be simplified. Replacing pBE(ni)=qni/(n¯+1)p_{\text{BE}}(n_{i})=q^{n_{i}}/(\bar{n}+1) with q=n¯/(n¯+1)q=\bar{n}/(\bar{n}+1), and using a symbolic manipulator such as Maxima Maxima, a Computer Algebra System , we obtain

JP\displaystyle\frac{J}{P} =qβFa(1q)2(1q)(1+q)(1+n¯)2\displaystyle=\frac{q\beta Fa}{(1-q)^{2}(1-q)(1+q)(1+\bar{n})^{2}}
=n¯(1+n¯)1+2n¯βFa.\displaystyle=\frac{\bar{n}(1+\bar{n})}{1+2\bar{n}}\beta Fa. (63)

Using the relationship between current and mobility, B=Ja/(Fn¯)B=J\,a/(F\bar{n}), Eq. (49) is immediately obtained.

Finally, the calculation of the mobility for the interpolation algorithm is simpler. We have the transition probabilities in (51), and the mean current is

J\displaystyle J =Pni(1+ni+1)eβFa/2ni+1(1+ni)eβFa/2\displaystyle=P\langle n_{i}(1+n_{i+1})e^{\beta Fa/2}-n_{i+1}(1+n_{i})e^{-\beta Fa/2}
Pnini+1βFa+ni(1+βFa/2)ni+1(1βFa/2)\displaystyle\simeq P\langle n_{i}n_{i+1}\beta Fa+n_{i}(1+\beta Fa/2)-n_{i+1}(1-\beta Fa/2)\rangle
=PβFan¯(1+n¯),\displaystyle=P\beta Fa\bar{n}(1+\bar{n}), (64)

where it was considered that ni=ni+1=n¯\langle n_{i}\rangle=\langle n_{i+1}\rangle=\bar{n} and that fluctuations in different cells are independent, so nini+1=n¯2\langle n_{i}n_{i+1}\rangle=\bar{n}^{2}. From this equation for JJ, the result for the mobility (52) is obtained.

References

  • Bortz et al. (1975) A. B. Bortz, M. H. Kalos,  and J. L. Lebowitz, “A new algorithm for Monte Carlo simulation of Ising spin systems,” J. Comp. Phys. 17, 10 (1975).
  • Fichthorn and Weinberg (1991) K. A. Fichthorn and W. H. Weinberg, “Theoretical foundations of dynamical Monte Carlo simulations,” J. Chem. Phys. 95, 1090 (1991).
  • Voter (2005) A. F. Voter, “Introduction to the kinetic monte carlo method,” in Radiation Effects in Solids, edited by K. E. Sickafus and E. A. Kotomin (Springer, 2005).
  • Jansen (2012) A. P. J. Jansen, An Introduction to Kinetic Monte Carlo Simulations of Surface Reactions (Springer, Berlin, Heidelberg, 2012).
  • Binder (1997) K. Binder, “Applications of Monte Carlo methods to statistical physics,” Rep. Prog. Phys. 60, 487 (1997).
  • Binder and Heermann (2010) K. Binder and D. W. Heermann, Monte Carlo Simulation in Statistical Physics (Springer, Berlin, Heidelberg, 2010).
  • Suárez et al. (2015) G. Suárez, M. Hoyuelos,  and H. Mártin, “Mean-field approach for diffusion of interacting particles,” Phys. Rev. E 92, 062118 (2015).
  • Martínez and Hoyuelos (2018) M. Di Pietro Martínez and M. Hoyuelos, “Mean-field approach to diffusion with interaction: Darken equation and numerical validation,” Phys. Rev. E 98, 022121 (2018).
  • Martínez and Hoyuelos (2019a) M. Di Pietro Martínez and M. Hoyuelos, “From diffusion experiments to mean-field theory simulations and back,” J. Stat. Mech.: Theory Exp. 2019, 113201 (2019a).
  • (10) See Supplemental Material at site, which includes Refs. difcode; Large-scale Atomic/Molecular Massively Parallel Simulator ; Plimpton (1993); lammpsdoc; Pathria and Beale (2011); mdcode, for the details about the numerical implementation and the codes used to obtain the mobility results shown in this article.
  • Glauber (1963) R. J. Glauber, “Time‐dependent statistics of the Ising model,” J. Math. Phys. 4, 294 (1963).
  • Hastings (1970) W. K. Hastings, “Monte Carlo sampling methods using Markov chains and their applications,” Biometrika 57, 97 (1970).
  • Vattulainen et al. (1998) I. Vattulainen, J. Merikoski, T. Ala-Nissila,  and S. C. Ying, “Adatom dynamics and diffusion in a model of O/W(110),” Phys. Rev. B 57, 1896 (1998).
  • Martínez and Hoyuelos (2019b) M. Di Pietro Martínez and M. Hoyuelos, “Diffusion in binary mixtures: an analysis of the dependence on the thermodynamic factor,” Phys. Rev. E 100, 022112 (2019b).
  • Pathria and Beale (2011) R. K. Pathria and P. D. Beale, Statistical Mechanics, 3rd ed. (Elsevier, 2011).
  • Kardar (2007) M. Kardar, Statistical Physics of Particles (Cambridge University Press, Cambridge, 2007).
  • Kubo et al. (1998) R. Kubo, M. Toda,  and N. Hashitsume, Statistical Physics II, 2nd ed. (Springer, 1998).
  • Reichl (1998) L. E. Reichl, A Modem Course in Statistical Physics, 2nd ed. (Wiley, 1998).
  • McQuarrie (2000) D. A. McQuarrie, Statistical Mechanics (University Science Books, Sausalito, 2000).
  • (20) Large-scale Atomic/Molecular Massively Parallel Simulator, http://lammps.sandia.gov.
  • Plimpton (1993) Steve Plimpton, Fast parallel algorithms for short-range molecular dynamics, Tech. Rep. (Sandia National Labs., Albuquerque, NM (United States), 1993).
  • (22) CCAD – UNC: http://ccad.unc.edu.ar/.
  • (23) Maxima, a Computer Algebra System, http://maxima.sourceforge.net/.