ViewVC Help
View File | Revision Log | Show Annotations | View Changeset | Root Listing
root/group/trunk/nivsRnemd/nivsRnemd.tex
(Generate patch)

Comparing trunk/nivsRnemd/nivsRnemd.tex (file contents):
Revision 3619 by skuang, Fri Jul 30 21:13:43 2010 UTC vs.
Revision 3630 by skuang, Thu Aug 12 14:48:03 2010 UTC

# Line 44 | Line 44 | Notre Dame, Indiana 46556}
44  
45   \begin{abstract}
46    We present a new method for introducing stable non-equilibrium
47 <  velocity and temperature distributions in molecular dynamics
48 <  simulations of heterogeneous systems.  This method extends earlier
49 <  Reverse Non-Equilibrium Molecular Dynamics (RNEMD) methods which use
50 <  momentum exchange swapping moves that can create non-thermal
51 <  velocity distributions and are difficult to use for interfacial
52 <  calculations.  By using non-isotropic velocity scaling (NIVS) on the
53 <  molecules in specific regions of a system, it is possible to impose
54 <  momentum or thermal flux between regions of a simulation and stable
55 <  thermal and momentum gradients can then be established.  The scaling
56 <  method we have developed conserves the total linear momentum and
57 <  total energy of the system.  To test the methods, we have computed
58 <  the thermal conductivity of model liquid and solid systems as well
59 <  as the interfacial thermal conductivity of a metal-water interface.
60 <  We find that the NIVS-RNEMD improves the problematic velocity
47 >  velocity and temperature gradients in molecular dynamics simulations
48 >  of heterogeneous systems.  This method extends earlier Reverse
49 >  Non-Equilibrium Molecular Dynamics (RNEMD) methods which use
50 >  momentum exchange swapping moves. The standard swapping moves can
51 >  create non-thermal velocity distributions and are difficult to use
52 >  for interfacial calculations.  By using non-isotropic velocity
53 >  scaling (NIVS) on the molecules in specific regions of a system, it
54 >  is possible to impose momentum or thermal flux between regions of a
55 >  simulation while conserving the linear momentum and total energy of
56 >  the system.  To test the methods, we have computed the thermal
57 >  conductivity of model liquid and solid systems as well as the
58 >  interfacial thermal conductivity of a metal-water interface.  We
59 >  find that the NIVS-RNEMD improves the problematic velocity
60    distributions that develop in other RNEMD methods.
61   \end{abstract}
62  
# Line 123 | Line 122 | Recently, Tenney and Maginn\cite{Maginn:2010} have dis
122   typically samples from the same manifold of states in the
123   microcanonical ensemble.
124  
125 < Recently, Tenney and Maginn\cite{Maginn:2010} have discovered
126 < some problems with the original RNEMD swap technique.  Notably, large
125 > Recently, Tenney and Maginn\cite{Maginn:2010} have discovered some
126 > problems with the original RNEMD swap technique.  Notably, large
127   momentum fluxes (equivalent to frequent momentum swaps between the
128   slabs) can result in ``notched'', ``peaked'' and generally non-thermal
129   momentum distributions in the two slabs, as well as non-linear thermal
130   and velocity distributions along the direction of the imposed flux
131   ($z$). Tenney and Maginn obtained reasonable limits on imposed flux
132 < and self-adjusting metrics for retaining the usability of the method.
132 > and proposed self-adjusting metrics for retaining the usability of the
133 > method.
134  
135   In this paper, we develop and test a method for non-isotropic velocity
136   scaling (NIVS) which retains the desirable features of RNEMD
# Line 181 | Line 181 | P_c^\alpha & = & \sum_{i = 1}^{N_c} m_i \left[\vec{v}_
181   \end{equation}
182   where
183   \begin{eqnarray}
184 < P_c^\alpha & = & \sum_{i = 1}^{N_c} m_i \left[\vec{v}_i\right]_\alpha \\
185 < P_h^\alpha & = & \sum_{j = 1}^{N_h} m_j \left[\vec{v}_j\right]_\alpha
184 > P_c^\alpha & = & \sum_{i = 1}^{N_c} m_i v_{i\alpha} \\
185 > P_h^\alpha & = & \sum_{j = 1}^{N_h} m_j v_{j\alpha}
186   \label{eq:momentumdef}
187   \end{eqnarray}
188   Therefore, for each of the three directions, the hot scaling
189   parameters are a simple function of the cold scaling parameters and
190 < the instantaneous linear momentum in each of the two slabs.
190 > the instantaneous linear momenta in each of the two slabs.
191   \begin{equation}
192   \alpha^\prime = 1 + (1 - \alpha) p_\alpha
193   \label{eq:hotcoldscaling}
# Line 200 | Line 200 | Conservation of total energy also places constraints o
200  
201   Conservation of total energy also places constraints on the scaling:
202   \begin{equation}
203 < \sum_{\alpha = x,y,z} K_h^\alpha + K_c^\alpha = \sum_{\alpha = x,y,z}
204 < \left(\alpha^\prime\right)^2 K_h^\alpha + \alpha^2 K_c^\alpha
203 > \sum_{\alpha = x,y,z} \left\{ K_h^\alpha + K_c^\alpha \right\} = \sum_{\alpha = x,y,z}
204 > \left\{ \left(\alpha^\prime\right)^2 K_h^\alpha + \alpha^2 K_c^\alpha \right\}
205   \end{equation}
206   where the translational kinetic energies, $K_h^\alpha$ and
207   $K_c^\alpha$, are computed for each of the three directions in a
# Line 269 | Line 269 | problem.\cite{Hoffman:2001sf} One simplification is to
269   degree 16.  There are a number of polynomial root-finding methods in
270   the literature,\cite{Hoffman:2001sf,384119} but numerically finding
271   the roots of high-degree polynomials is generally an ill-conditioned
272 < problem.\cite{Hoffman:2001sf} One simplification is to maintain velocity
273 < scalings that are {\it as isotropic as possible}.  To do this, we
274 < impose $x=y$, and to treat both the constraint and flux ellipsoids as
275 < 2-dimensional ellipses.  In reduced dimensionality, the
272 > problem.\cite{Hoffman:2001sf} One simplification is to maintain
273 > velocity scalings that are {\it as isotropic as possible}.  To do
274 > this, we impose $x=y$, and treat both the constraint and flux
275 > ellipsoids as 2-dimensional ellipses.  In reduced dimensionality, the
276   intersecting-ellipse problem reduces to finding the roots of
277   polynomials of degree 4.
278  
# Line 330 | Line 330 | after an MD step with a variable frequency.  We have t
330  
331   We have implemented this methodology in our molecular dynamics code,
332   OpenMD,\cite{Meineke:2005gd,openmd} performing the NIVS scaling moves
333 < after an MD step with a variable frequency.  We have tested the method
334 < in a variety of different systems, including homogeneous fluids
335 < (Lennard-Jones and SPC/E water), crystalline solids ({\sc
336 <  eam})~\cite{PhysRevB.33.7983} and quantum Sutton-Chen ({\sc
337 <  q-sc})~\cite{PhysRevB.59.3527} models for Gold), and heterogeneous
338 < interfaces ({\sc q-sc} gold - SPC/E water). The last of these systems would
339 < have been difficult to study using previous RNEMD methods, but using
340 < velocity scaling moves, we can even obtain estimates of the
341 < interfacial thermal conductivities ($G$).
333 > with a variable frequency after the molecular dynamics (MD) steps.  We
334 > have tested the method in a variety of different systems, including:
335 > homogeneous fluids (Lennard-Jones and SPC/E water), crystalline
336 > solids, using both the embedded atom method
337 > (EAM)~\cite{PhysRevB.33.7983} and quantum Sutton-Chen
338 > (QSC)~\cite{PhysRevB.59.3527} models for Gold, and heterogeneous
339 > interfaces (QSC gold - SPC/E water). The last of these systems would
340 > have been difficult to study using previous RNEMD methods, but the
341 > current method can easily provide estimates of the interfacial thermal
342 > conductivity ($G$).
343  
344   \subsection{Simulation Cells}
345  
# Line 357 | Line 358 | first performed simulations using the original techniq
358  
359   In order to compare our new methodology with the original
360   M\"{u}ller-Plathe swapping algorithm,\cite{ISI:000080382700030} we
361 < first performed simulations using the original technique.
361 > first performed simulations using the original technique. At fixed
362 > intervals, kinetic energy or momentum exchange moves were performed
363 > between the hot and the cold slabs.  The interval between exchange
364 > moves governs the effective momentum flux ($j_z(p_x)$) or energy flux
365 > ($J_z$) between the two slabs so to vary this quantity, we performed
366 > simulations with a variety of delay intervals between the swapping moves.
367  
368 + For thermal conductivity measurements, the particle with smallest
369 + speed in the hot slab and the one with largest speed in the cold slab
370 + had their entire momentum vectors swapped.  In the test cases run
371 + here, all particles had the same chemical identity and mass, so this
372 + move preserves both total linear momentum and total energy.  It is
373 + also possible to exchange energy by assuming an elastic collision
374 + between the two particles which are exchanging energy.
375 +
376 + For shear stress simulations, the particle with the most negative
377 + $p_x$ in the hot slab and the one with the most positive $p_x$ in the
378 + cold slab exchanged only this component of their momentum vectors.
379 +
380   \subsection{RNEMD with NIVS scaling}
381  
382   For each simulation utilizing the swapping method, a corresponding
383   NIVS-RNEMD simulation was carried out using a target momentum flux set
384 < to produce a the same momentum or energy flux exhibited in the
367 < swapping simulation.
384 > to produce the same flux experienced in the swapping simulation.
385  
386 < To test the temperature homogeneity (and to compute transport
387 < coefficients), directional momentum and temperature distributions were
388 < accumulated for molecules in each of the slabs.
386 > To test the temperature homogeneity, directional momentum and
387 > temperature distributions were accumulated for molecules in each of
388 > the slabs.  Transport coefficients were computed using the temperature
389 > (and momentum) gradients across the $z$-axis as well as the total
390 > momentum flux the system experienced during data collection portion of
391 > the simulation.
392  
393   \subsection{Shear viscosities}
394  
# Line 379 | Line 399 | momentum transfer occurs in two directions due to our
399   \end{equation}
400   where $L_x$ and $L_y$ denote the $x$ and $y$ lengths of the simulation
401   box.  The factor of two in the denominator is present because physical
402 < momentum transfer occurs in two directions due to our periodic
403 < boundary conditions.  The velocity gradient ${\langle \partial v_x
404 <  /\partial z \rangle}$ was obtained using linear regression of the
405 < velocity profiles in the bins.  For Lennard-Jones simulations, shear
406 < viscosities are reporte in reduced units (${\eta^* = \eta \sigma^2
407 <  (\varepsilon m)^{-1/2}}$).
402 > momentum transfer between the slabs occurs in two directions ($+z$ and
403 > $-z$).  The velocity gradient ${\langle \partial v_x /\partial z
404 >  \rangle}$ was obtained using linear regression of the mean $x$
405 > component of the velocity, $\langle v_x \rangle$, in each of the bins.
406 > For Lennard-Jones simulations, shear viscosities are reported in
407 > reduced units (${\eta^* = \eta \sigma^2 (\varepsilon m)^{-1/2}}$).
408  
409   \subsection{Thermal Conductivities}
410  
411 < The energy flux was calculated similarly to the momentum flux, using
412 < the total non-physical energy transferred (${E_{total}}$) and the data
413 < collection time $t$:
411 > The energy flux was calculated in a similar manner to the momentum
412 > flux, using the total non-physical energy transferred (${E_{total}}$)
413 > and the data collection time $t$:
414   \begin{equation}
415   J_z = \frac{E_{total}}{2 t L_x L_y}
416   \end{equation}
# Line 402 | Line 422 | For materials with a relatively low interfacial conduc
422  
423   \subsection{Interfacial Thermal Conductivities}
424  
425 < For materials with a relatively low interfacial conductance, and in
426 < cases where the flux between the materials is small, the bulk regions
427 < on either side of an interface rapidly come to a state in which the
428 < two phases have relatively homogeneous (but distinct) temperatures.
429 < In calculating the interfacial thermal conductivity $G$, this
410 < assumption was made, and the conductance can be approximated as:
425 > For interfaces with a relatively low interfacial conductance, the bulk
426 > regions on either side of an interface rapidly come to a state in
427 > which the two phases have relatively homogeneous (but distinct)
428 > temperatures.  The interfacial thermal conductivity $G$ can therefore
429 > be approximated as:
430  
431   \begin{equation}
432   G = \frac{E_{total}}{2 t L_x L_y \left( \langle T_{gold}\rangle -
# Line 417 | Line 436 | water phases respectively.
436   where ${E_{total}}$ is the imposed non-physical kinetic energy
437   transfer and ${\langle T_{gold}\rangle}$ and ${\langle
438    T_{water}\rangle}$ are the average observed temperature of gold and
439 < water phases respectively.
439 > water phases respectively.  If the interfacial conductance is {\it
440 >  not} small, it is also be possible to compute the interfacial
441 > thermal conductivity using this method utilizing the change in the
442 > slope of the thermal gradient ($\partial^2 \langle T \rangle / \partial
443 > z^2$) at the interface.
444  
445   \section{Results}
446  
# Line 440 | Line 463 | tested (Table \ref{LJ}). With a fixed scaling interval
463  
464   Our thermal conductivity calculations show that the NIVS method agrees
465   well with the swapping method. Five different swap intervals were
466 < tested (Table \ref{LJ}). With a fixed scaling interval of 10 time steps,
467 < the target exchange kinetic energy produced equivalent kinetic energy
468 < flux as in the swapping method. Similar thermal gradients were
469 < observed with similar thermal flux under the two different methods
470 < (Figure \ref{thermalGrad}). Furthermore, with appropriate choice of
471 < scaling variables, temperature along $x$, $y$ and $z$ axis has no
472 < observable difference(Figure TO BE ADDED). The system is able
450 < to maintain temperature homogeneity even under high flux.
466 > tested (Table \ref{LJ}). Similar thermal gradients were observed with
467 > similar thermal flux under the two different methods (Figure
468 > \ref{thermalGrad}). Furthermore, the 1-d temperature profiles showed
469 > no observable differences between the $x$, $y$ and $z$ axes (Figure
470 > \ref{thermalGrad} c), so even though we are using a non-isotropic
471 > scaling method, none of the three directions are experience
472 > disproportionate heating due to the velocity scaling.
473  
474   \begin{table*}
475    \begin{minipage}{\linewidth}
# Line 487 | Line 509 | to maintain temperature homogeneity even under high fl
509  
510   \begin{figure}
511    \includegraphics[width=\linewidth]{thermalGrad}
512 <  \caption{NIVS-RNEMD method (b) creates similar temperature gradients
513 <    compared with the swapping method (a) under a variety of imposed
512 >  \caption{The NIVS-RNEMD method creates similar temperature gradients
513 >    compared with the swapping method under a variety of imposed
514      kinetic energy flux values. Furthermore, the implementation of
515      Non-Isotropic Velocity Scaling does not cause temperature
516 <    difference among the three dimensions (c).}
516 >    anisotropy to develop in thermal conductivity calculations.}
517    \label{thermalGrad}
518   \end{figure}
519  
520   \subsubsection*{Velocity Distributions}
521  
522   During these simulations, velocities were recorded every 1000 steps
523 < and was used to produce distributions of both velocity and speed in
523 > and were used to produce distributions of both velocity and speed in
524   each of the slabs. From these distributions, we observed that under
525   relatively high non-physical kinetic energy flux, the speed of
526   molecules in slabs where swapping occured could deviate from the
527   Maxwell-Boltzmann distribution. This behavior was also noted by Tenney
528 < and Maginn\cite{Maginn:2010} in their simulations for shear viscosity
529 < calculations. Figure \ref{thermalHist} shows how these distributions
530 < deviate from an ideal distribution. In the ``hot'' slab, the
509 < probability density is notched at low speeds and has a substantial
528 > and Maginn.\cite{Maginn:2010} Figure \ref{thermalHist} shows how these
529 > distributions deviate from an ideal distribution. In the ``hot'' slab,
530 > the probability density is notched at low speeds and has a substantial
531   shoulder at higher speeds relative to the ideal MB distribution. In
532   the cold slab, the opposite notching and shouldering occurs.  This
533   phenomenon is more obvious at higher swapping rates.
534  
535 < In the velocity distributions, the ideal Gaussian peak is
536 < substantially flattened in the hot slab, and is overly sharp (with
537 < truncated wings) in the cold slab. This problem is rooted in the
538 < mechanism of the swapping method. Continually depleting low (high)
539 < speed particles in the high (low) temperature slab is not complemented
540 < by diffusions of low (high) speed particles from neighboring slabs,
541 < unless the swapping rate is sufficiently small. Simutaneously, surplus
542 < low speed particles in the low temperature slab do not have sufficient
543 < time to diffuse to neighboring slabs.  Since the thermal exchange rate
544 < must reach a minimum level to produce an observable thermal gradient,
545 < the swapping-method RNEMD has a relatively narrow choice of exchange
546 < times that can be utilized.
535 > The peak of the velocity distribution is substantially flattened in
536 > the hot slab, and is overly sharp (with truncated wings) in the cold
537 > slab. This problem is rooted in the mechanism of the swapping method.
538 > Continually depleting low (high) speed particles in the high (low)
539 > temperature slab is not complemented by diffusions of low (high) speed
540 > particles from neighboring slabs, unless the swapping rate is
541 > sufficiently small. Simutaneously, surplus low speed particles in the
542 > low temperature slab do not have sufficient time to diffuse to
543 > neighboring slabs.  Since the thermal exchange rate must reach a
544 > minimum level to produce an observable thermal gradient, the
545 > swapping-method RNEMD has a relatively narrow choice of exchange times
546 > that can be utilized.
547  
548   For comparison, NIVS-RNEMD produces a speed distribution closer to the
549   Maxwell-Boltzmann curve (Figure \ref{thermalHist}).  The reason for
# Line 536 | Line 557 | velocity distributions in the two slabs.
557  
558   \begin{figure}
559   \includegraphics[width=\linewidth]{thermalHist}
560 < \caption{Speed distribution for thermal conductivity using
561 <  ``swapping'' and NIVS-RNEMD methods. Shown is from simulations under
562 <  ${\langle T^* \rangle = 0.8}$ with an swapping interval of 200
563 <  time steps (equivalent ${J_z^*\sim 0.2}$). In circled areas,
564 <  distributions from ``swapping'' RNEMD simulation have deviations
565 <  from ideal Maxwell-Boltzmann distributions.}
560 > \caption{Velocity and speed distributions that develop under the
561 >  swapping and NIVS-RNEMD methods at high flux.  The distributions for
562 >  the hot bins (upper panels) and cold bins (lower panels) were
563 >  obtained from Lennard-Jones simulations with $\langle T^* \rangle =
564 >  4.5$ with a flux of $J_z^* \sim 5$ (equivalent to a swapping interval
565 >  of 10 time steps).  This is a relatively large flux which shows the
566 >  non-thermal distributions that develop under the swapping method.
567 >  NIVS does a better job of producing near-thermal distributions in
568 >  the bins.}
569   \label{thermalHist}
570   \end{figure}
571  
572  
573   \subsubsection*{Shear Viscosity}
574 < Our calculations (Table \ref{LJ}) show that velocity-scaling
575 < RNEMD predicted comparable shear viscosities to swap RNEMD method.  All
576 < the scale method results were from simulations that had a scaling
577 < interval of 10 time steps. The average molecular momentum gradients of
554 < these samples are shown in Figure \ref{shear} (a) and (b).
574 > Our calculations (Table \ref{LJ}) show that velocity-scaling RNEMD
575 > predicted comparable shear viscosities to swap RNEMD method. The
576 > average molecular momentum gradients of these samples are shown in
577 > Figure \ref{shear} (a) and (b).
578  
579   \begin{figure}
580    \includegraphics[width=\linewidth]{shear}
581    \caption{Average momentum gradients in shear viscosity simulations,
582 <    using (a) ``swapping'' method and (b) NIVS-RNEMD method
583 <    respectively. (c) Temperature difference among $x$ and $y, z$
584 <    dimensions observed when using NIVS-RNEMD with ${j_z^*(p_x)\sim 0.09}$.}
582 >    using ``swapping'' method (top panel) and NIVS-RNEMD method
583 >    (middle panel). NIVS-RNEMD produces a thermal anisotropy artifact
584 >    in the hot and cold bins when used for shear viscosity.  This
585 >    artifact does not appear in thermal conductivity calculations.}
586    \label{shear}
587   \end{figure}
588  
589 < However, observations of temperatures along three dimensions show that
590 < inhomogeneity occurs in scaling RNEMD simulations, particularly in the
591 < two slabs which were scaled. Figure \ref{shear} (c) indicate that with
592 < relatively large imposed momentum flux, the temperature difference among $x$
593 < and the other two dimensions was significant. This would result from the
594 < algorithm of scaling method. From Eq. \ref{eq:fluxPlane}, after
595 < momentum gradient is set up, $P_c^x$ would be roughly stable
596 < ($<0$). Consequently, scaling factor $x$ would most probably larger
597 < than 1. Therefore, the kinetic energy in $x$-dimension $K_c^x$ would
598 < keep increase after most scaling steps. And if there is not enough time
599 < for the kinetic energy to exchange among different dimensions and
600 < different slabs, the system would finally build up temperature
601 < (kinetic energy) difference among the three dimensions. Also, between
578 < $y$ and $z$ dimensions in the scaled slabs, temperatures of $z$-axis
579 < are closer to neighbor slabs. This is due to momentum transfer along
580 < $z$ dimension between slabs.
589 > Observations of the three one-dimensional temperatures in each of the
590 > slabs shows that NIVS-RNEMD does produce some thermal anisotropy,
591 > particularly in the hot and cold slabs.  Figure \ref{shear} (c)
592 > indicates that with a relatively large imposed momentum flux,
593 > $j_z(p_x)$, the $x$ direction approaches a different temperature from
594 > the $y$ and $z$ directions in both the hot and cold bins.  This is an
595 > artifact of the scaling constraints.  After the momentum gradient has
596 > been established, $P_c^x < 0$.  Consequently, the scaling factor $x$
597 > is nearly always greater than one in order to satisfy the constraints.
598 > This will continually increase the kinetic energy in $x$-dimension,
599 > $K_c^x$.  If there is not enough time for the kinetic energy to
600 > exchange among different directions and different slabs, the system
601 > will exhibit the observed thermal anisotropy in the hot and cold bins.
602  
603   Although results between scaling and swapping methods are comparable,
604 < the inherent temperature inhomogeneity even in relatively low imposed
605 < exchange momentum flux simulations makes scaling RNEMD method less
606 < attractive than swapping RNEMD in shear viscosity calculation.
604 > the inherent temperature anisotropy does make NIVS-RNEMD method less
605 > attractive than swapping RNEMD for shear viscosity calculations.  We
606 > note that this problem appears only when momentum flux is applied, and
607 > does not appear in thermal flux calculations.
608  
587
609   \subsection{Bulk SPC/E water}
610  
611   We compared the thermal conductivity of SPC/E water using NIVS-RNEMD
# Line 593 | Line 614 | principle is also adopted in our simulations. Scaling
614    al.}\cite{Bedrov:2000} argued that exchange of the molecule
615   center-of-mass velocities instead of single atom velocities in a
616   molecule conserves the total kinetic energy and linear momentum.  This
617 < principle is also adopted in our simulations. Scaling was applied to
617 > principle is also adopted Fin our simulations. Scaling was applied to
618   the center-of-mass velocities of the rigid bodies of SPC/E model water
619   molecules.
620  
# Line 603 | Line 624 | by equilibration, first in the canonical (NVT) ensembl
624   ensemble.\cite{melchionna93} A fixed volume was chosen to match the
625   average volume observed in the NPT simulations, and this was followed
626   by equilibration, first in the canonical (NVT) ensemble, followed by a
627 < 100ps period under constant-NVE conditions without any momentum
628 < flux. 100ps was allowed to stabilize the system with an imposed
629 < momentum transfer to create a gradient, and 1ns was alotted for
630 < data collection under RNEMD.
627 > 100~ps period under constant-NVE conditions without any momentum flux.
628 > Another 100~ps was allowed to stabilize the system with an imposed
629 > momentum transfer to create a gradient, and 1~ns was allotted for data
630 > collection under RNEMD.
631  
632 < In our simulations, temperature gradients were established similar to
633 < the previous work. Our simulation results under 318K are in well
632 > In our simulations, the established temperature gradients were similar
633 > to the previous work.  Our simulation results at 318K are in good
634   agreement with those from Bedrov {\it et al.} (Table
635   \ref{spceThermal}). And both methods yield values in reasonable
636 < agreement with experimental value. A larger difference between
616 < simulation result and experiment is found under 300K. This could
617 < result from the force field that is used in simulation.
636 > agreement with experimental values.  
637  
619 \begin{figure}
620  \includegraphics[width=\linewidth]{spceGrad}
621  \caption{Temperature gradients in SPC/E water thermal conductivity
622    simulations.}
623  \label{spceGrad}
624 \end{figure}
625
638   \begin{table*}
639    \begin{minipage}{\linewidth}
640      \begin{center}
# Line 661 | Line 673 | Model ({\sc eam})~\cite{PhysRevB.33.7983} and Sutton-C
673   conductivities using two atomistic models for gold.  Several different
674   potential models have been developed that reasonably describe
675   interactions in transition metals. In particular, the Embedded Atom
676 < Model ({\sc eam})~\cite{PhysRevB.33.7983} and Sutton-Chen ({\sc
677 <  sc})~\cite{Chen90} potential have been used to study a wide range of
678 < phenomena in both bulk materials and
676 > Model (EAM)~\cite{PhysRevB.33.7983} and Sutton-Chen (SC)~\cite{Chen90}
677 > potential have been used to study a wide range of phenomena in both
678 > bulk materials and
679   nanoparticles.\cite{ISI:000207079300006,Clancy:1992,Vardeman:2008fk,Vardeman-II:2001jn,ShibataT._ja026764r,Sankaranarayanan:2005lr,Chui:2003fk,Wang:2005qy,Medasani:2007uq}
680   Both potentials are based on a model of a metal which treats the
681   nuclei and core electrons as pseudo-atoms embedded in the electron
682   density due to the valence electrons on all of the other atoms in the
683 < system. The {\sc sc} potential has a simple form that closely
684 < resembles the Lennard Jones potential,
683 > system. The SC potential has a simple form that closely resembles the
684 > Lennard Jones potential,
685   \begin{equation}
686   \label{eq:SCP1}
687   U_{tot}=\sum _{i}\left[ \frac{1}{2}\sum _{j\neq i}D_{ij}V^{pair}_{ij}(r_{ij})-c_{i}D_{ii}\sqrt{\rho_{i}}\right] ,
# Line 689 | Line 701 | Sutton-Chen ({\sc q-sc}) formulation matches these pro
701   that assures a dimensionless form for $\rho$. These parameters are
702   tuned to various experimental properties such as the density, cohesive
703   energy, and elastic moduli for FCC transition metals. The quantum
704 < Sutton-Chen ({\sc q-sc}) formulation matches these properties while
705 < including zero-point quantum corrections for different transition
706 < metals.\cite{PhysRevB.59.3527}  The {\sc eam} functional forms differ
707 < slightly from {\sc sc} but the overall method is very similar.
704 > Sutton-Chen (QSC) formulation matches these properties while including
705 > zero-point quantum corrections for different transition
706 > metals.\cite{PhysRevB.59.3527} The EAM functional forms differ
707 > slightly from SC but the overall method is very similar.
708  
709 < In this work, we have utilized both the {\sc eam} and the {\sc q-sc}
710 < potentials to test the behavior of scaling RNEMD.
709 > In this work, we have utilized both the EAM and the QSC potentials to
710 > test the behavior of scaling RNEMD.
711  
712   A face-centered-cubic (FCC) lattice was prepared containing 2880 Au
713   atoms (i.e. ${6\times 6\times 20}$ unit cells). Simulations were run
# Line 710 | Line 722 | excluded in thermal gradient linear regession. {\sc ea
722  
723   The results for the thermal conductivity of gold are shown in Table
724   \ref{AuThermal}.  In these calculations, the end and middle slabs were
725 < excluded in thermal gradient linear regession. {\sc eam} predicts
726 < slightly larger thermal conductivities than {\sc q-sc}.  However, both
727 < values are smaller than experimental value by a factor of more than
728 < 200. This behavior has been observed previously by Richardson and
729 < Clancy, and has been attributed to the lack of electronic contribution
730 < in these force fields.\cite{Clancy:1992} The non-equilibrium MD method
731 < employed in their simulations was only able to give a rough estimation
732 < of thermal conductance for {\sc eam} gold, and the result was an
733 < average over a wide temperature range (300-800K). Comparatively, our
734 < results were based on measurements with linear temperature gradients,
735 < and thus of higher reliability and accuracy. It should be noted that
724 < the density of the metal being simulated also has an observable effect
725 < on thermal conductance. With an expanded lattice, lower thermal
726 < conductance is expected (and observed). We also observed a decrease in
727 < thermal conductance at higher temperatures, a trend that agrees with
728 < experimental measurements.\cite{AshcroftMermin}
725 > excluded in thermal gradient linear regession. EAM predicts slightly
726 > larger thermal conductivities than QSC.  However, both values are
727 > smaller than experimental value by a factor of more than 200. This
728 > behavior has been observed previously by Richardson and Clancy, and
729 > has been attributed to the lack of electronic contribution in these
730 > force fields.\cite{Clancy:1992} It should be noted that the density of
731 > the metal being simulated has an effect on thermal conductance. With
732 > an expanded lattice, lower thermal conductance is expected (and
733 > observed). We also observed a decrease in thermal conductance at
734 > higher temperatures, a trend that agrees with experimental
735 > measurements.\cite{AshcroftMermin}
736  
737   \begin{table*}
738    \begin{minipage}{\linewidth}
# Line 736 | Line 743 | experimental measurements.\cite{AshcroftMermin}
743          experimental and equilibrated densities and at a range of
744          temperatures and thermal flux rates. Uncertainties are
745          indicated in parentheses. Richardson {\it et
746 <          al.}\cite{Clancy:1992} gave an estimatioin for {\sc eam} gold
747 <        of 1.74$\mathrm{W m}^{-1}\mathrm{K}^{-1}$.}
746 >          al.}\cite{Clancy:1992} give an estimate of 1.74 $\mathrm{W
747 >          m}^{-1}\mathrm{K}^{-1}$ for EAM gold
748 >         at a density of 19.263 g / cm$^3$.}
749        
750        \begin{tabular}{|c|c|c|cc|}
751          \hline
752          Force Field & $\rho$ (g/cm$^3$) & ${\langle T\rangle}$ (K) &
753          $\langle dT/dz\rangle$ (K/\AA) & $\lambda (\mathrm{W m}^{-1} \mathrm{K}^{-1})$\\
754          \hline
755 <        \multirow{7}{*}{\sc q-sc} & \multirow{3}{*}{19.188} & \multirow{3}{*}{300} & 1.44 & 1.10(0.06)\\
755 >        \multirow{7}{*}{QSC} & \multirow{3}{*}{19.188} & \multirow{3}{*}{300} & 1.44 & 1.10(0.06)\\
756          &        &     & 2.86 & 1.08(0.05)\\
757          &        &     & 5.14 & 1.15(0.07)\\\cline{2-5}
758          & \multirow{4}{*}{19.263} & \multirow{2}{*}{300} & 2.31 & 1.25(0.06)\\
# Line 752 | Line 760 | experimental measurements.\cite{AshcroftMermin}
760          &        & \multirow{2}{*}{575} & 3.02 & 1.02(0.07)\\
761          &        &     & 4.84 & 0.92(0.05)\\
762          \hline
763 <        \multirow{8}{*}{\sc eam} & \multirow{3}{*}{19.045} & \multirow{3}{*}{300} & 1.24 & 1.24(0.16)\\
763 >        \multirow{8}{*}{EAM} & \multirow{3}{*}{19.045} & \multirow{3}{*}{300} & 1.24 & 1.24(0.16)\\
764          &        &     & 2.06 & 1.37(0.04)\\
765          &        &     & 2.55 & 1.41(0.07)\\\cline{2-5}
766          & \multirow{5}{*}{19.263} & \multirow{3}{*}{300} & 1.06 & 1.45(0.13)\\
# Line 780 | Line 788 | After simulations of bulk water and crystal gold, a mi
788   molecules within 3 \AA radius of any gold atom.  The final
789   configuration contained 1862 SPC/E water molecules.
790  
791 < After simulations of bulk water and crystal gold, a mixture system was
792 < constructed, consisting of 1188 Au atoms and 1862 H$_2$O
793 < molecules. Spohr potential was adopted in depicting the interaction
794 < between metal atom and water molecule.\cite{ISI:000167766600035} A
795 < similar protocol of equilibration was followed. Several thermal
788 < gradients was built under different target thermal flux. It was found
789 < out that compared to our previous simulation systems, the two phases
790 < could have large temperature difference even under a relatively low
791 < thermal flux.
791 > The Spohr potential was adopted in depicting the interaction between
792 > metal atoms and water molecules.\cite{ISI:000167766600035} A similar
793 > protocol of equilibration to our water simulations was followed.  We
794 > observed that the two phases developed large temperature differences
795 > even under a relatively low thermal flux.
796  
797 + The low interfacial conductance is probably due to an acoustic
798 + impedance mismatch between the solid and the liquid
799 + phase.\cite{Cahill:793,RevModPhys.61.605} Experiments on the thermal
800 + conductivity of gold nanoparticles and nanorods in solvent and in
801 + glass cages have predicted values for $G$ between 100 and 350
802 + (MW/m$^2$/K).  The experiments typically have multiple gold surfaces
803 + that have been protected by a capping agent (citrate or CTAB) or which
804 + are in direct contact with various glassy solids.  In these cases, the
805 + acoustic impedance mismatch would be substantially reduced, leading to
806 + much higher interfacial conductances.  It is also possible, however,
807 + that the lack of electronic effects that gives rise to the low thermal
808 + conductivity of EAM gold is also causing a low reading for this
809 + particular interface.
810  
811 < After simulations of homogeneous water and gold systems using
812 < NIVS-RNEMD method were proved valid, calculation of gold/water
813 < interfacial thermal conductivity was followed. It is found out that
814 < the low interfacial conductance is probably due to the hydrophobic
815 < surface in our system. Figure \ref{interface} (a) demonstrates mass
816 < density change along $z$-axis, which is perpendicular to the
817 < gold/water interface. It is observed that water density significantly
818 < decreases when approaching the surface. Under this low thermal
819 < conductance, both gold and water phase have sufficient time to
803 < eliminate temperature difference inside respectively (Figure
804 < \ref{interface} b). With indistinguishable temperature difference
805 < within respective phase, it is valid to assume that the temperature
806 < difference between gold and water on surface would be approximately
807 < the same as the difference between the gold and water phase. This
808 < assumption enables convenient calculation of $G$ using
809 < Eq. \ref{interfaceCalc} instead of measuring temperatures of thin
810 < layer of water and gold close enough to surface, which would have
811 > Under this low thermal conductance, both gold and water phase have
812 > sufficient time to eliminate temperature difference inside
813 > respectively (Figure \ref{interface} b). With indistinguishable
814 > temperature difference within respective phase, it is valid to assume
815 > that the temperature difference between gold and water on surface
816 > would be approximately the same as the difference between the gold and
817 > water phase. This assumption enables convenient calculation of $G$
818 > using Eq.  \ref{interfaceCalc} instead of measuring temperatures of
819 > thin layer of water and gold close enough to surface, which would have
820   greater fluctuation and lower accuracy. Reported results (Table
821   \ref{interfaceRes}) are of two orders of magnitude smaller than our
822   calculations on homogeneous systems, and thus have larger relative
# Line 815 | Line 824 | errors than our calculation results on homogeneous sys
824  
825   \begin{figure}
826   \includegraphics[width=\linewidth]{interface}
827 < \caption{Simulation results for Gold/Water interfacial thermal
828 <  conductivity: (a) Significant water density decrease is observed on
829 <  crystalline gold surface, which indicates low surface contact and
830 <  leads to low thermal conductance. (b) Temperature profiles for a
831 <  series of simulations. Temperatures of different slabs in the same
823 <  phase show no significant differences.}
827 > \caption{Temperature profiles of the Gold / Water interface at four
828 >  different values for the thermal flux.  Temperatures for slabs
829 >  either in the gold or in the water show no significant differences,
830 >  although there is a large discontinuity between the materials
831 >  because of the relatively low interfacial thermal conductivity.}
832   \label{interface}
833   \end{figure}
834  
# Line 868 | Line 876 | Support for this project was provided by the National
876   calculations.
877  
878   \section{Acknowledgments}
879 < Support for this project was provided by the National Science
880 < Foundation under grant CHE-0848243. Computational time was provided by
881 < the Center for Research Computing (CRC) at the University of Notre
882 < Dame.  \newpage
879 > The authors would like to thank Craig Tenney and Ed Maginn for many
880 > helpful discussions.  Support for this project was provided by the
881 > National Science Foundation under grant CHE-0848243. Computational
882 > time was provided by the Center for Research Computing (CRC) at the
883 > University of Notre Dame.  
884 > \newpage
885  
886   \bibliography{nivsRnemd}
887  

Diff Legend

Removed lines
+ Added lines
< Changed lines
> Changed lines