Parallel Implementation of the Treecode Ewald Method

Total Page:16

File Type:pdf, Size:1020Kb

Parallel Implementation of the Treecode Ewald Method Parallel Implementation of the Treecode Ewald Method Dongqing Liu*, Zhong-Hui Duan*, Robert Krasny†, Jianping Zhu‡§ * Department of Computer Science, The University of Akron, Akron, OH 44325, USA. † Department of Mathematics, University of Michigan, Ann Arbor, MI 48109, USA ‡ Department of Theoretical and Applied Mathematics, University of Akron, Akron, OH 44325, USA § Corresponding author: [email protected] Abstract achieved using a distributed parallel system with 5000 processors. To bridge the gap between the time interval In this paper, we discuss an efficient parallel of biological interest and that accessible by MD implementation of the treecode Ewald method for fast simulations, there has been extensive effort to improve evaluation of long-range Coulomb interactions in a the computational efficiency. One approach is to periodic system for molecular dynamics simulations. increase the time step size [4]. Another approach is to The parallelization is based on an adaptive decrease the time needed for the force evaluations at decomposition scheme using the Morton order of the each time step. This paper is concerned with the second particles. This decomposition scheme takes advantage approach. of the data locality and involves minimum changes to In an MD simulation of a system of N particles, the the original sequential code. The Message Passing computational cost is dominated by the frequent force Interface (MPI) is used for inter-processor evaluations. The calculation of long-range Coulomb communications, making the code portable to a variety interactions is the most time-consuming part of the of parallel computing platforms. We also discuss evaluations. A straightforward implementation of the 2 communication and performance models for our calculation requires O(N ) operations. In recent years, parallel algorithm. The predicted communication time several methods have been developed to reduce the and parallel performance from these models match the cost of computing Coulomb interactions while measured results well. Timing results obtained using a maintaining accuracy of N-body MD simulations, system of water molecules on the IA32 Cluster at the notably the multipole expansion based tree-codes and Ohio Supercomputer Center demonstrate high speedup Ewald summation based fast algorithms [5-20]. Two of and efficiency of the parallel treecode Ewald method. the earliest tree-codes were developed for problems involving gravitational interaction by Appel [7], Barnes and Hut [8]. Both algorithms employed monopole 1. Introduction approximations with a complexity of O(Nlog(N)). Appel used a cluster-cluster evaluation procedure, The rapid advancement in computational science while Barnes and Hut used a particle-cluster procedure. Greengard and Rokhlin's fast multipole method reduces has dramatically changed the way researchers conduct 2 scientific investigations, particularly in the studies of the operation count from O(N ) to O(N) [9]. To obtain molecular interactions in a biomolecular system [1]. higher accuracy, the fast multipole method uses higher However, the current modeling and simulation order multipole approximations and a procedure for capabilities available to researchers are still vastly evaluating a multipole approximation by converting it inadequate for the study of complex biomolecular into a local Taylor series. There is much ongoing effort systems, although there has been tremendous progress to optimize the performance of the fast multipole in computer hardware, software, modeling, and method. The latest version of the fast multipole method algorithm development [1, 2]. For example, the typical uses more sophisticated analytical techniques that time step in a molecular dynamics (MD) simulation is combine the use of exponential expansions and on the order of 10-15 second, but the time interval of multipole expansions [10]. The Ewald summation biological interest is typically on the order of 10-6 - 1 method has been widely used to handle Coulomb second. This translates to a simulation involving 109 - interactions for systems with periodic boundary 1015 time steps, where each step includes the conditions [15, 16]. The method converts a computation of short-range interactions and extremely conditionally convergent series into a sum of a constant time consuming long-range Coulomb interactions. As a and two rapidly convergent series, a real space sum and result, the longest simulation time that has ever been a reciprocal space sum. The relative computational cost of the two series is controlled by an adaptive splitting reported was 3.8´10-5 seconds [1, 3], which was parameter a. The popular particle-mesh Ewald method method splits the above conditionally convergent series [17] (PME) reduces the complexity of Ewald into a sum of a constant, E(0), and two rapidly summation by choosing a large value for a; the real convergent series, a real space sum E(r) and a reciprocal space sum is computed in O(N) and the cost of space sum E(k), (0) (r ) (k ) evaluating the reciprocal space sum is reduced from E = E + E + E 2 (2) O(N ) to O(Nlog N) using a particle-mesh interpolation where procedure and the fast Fourier transform (FFT). PME N E (0 ) = a q 2 was a major success in the field of biomolecular p 1 / 2 å j (3) computing, but parallelizing PME has been a great j =1 ' N N challenge due to the high communication cost of 3D erfc(a | ri - rj + Ln |) E (r ) = 1 q q FFT. With a relative small value of a.? the Ewald 2 å å å i j (4) n i=1 j=1 | ri - rj + Ln | summation based tree-code [18] approximates the real 2 1 æ p 2 | n |2 ö N æ 2pi ö space sum using a Barnes-Hut tree and the multipole E ( k) = 1 expç- ÷ q expç n× r ÷ (5) 2pL å 2 ç 2 2 ÷ å j j | n | L a j=1 è L ø expansion of the kernel erfc(|x|)/|x| and reduces the n¹0 è ø 2 computational cost from O(N ) to O(Nlog(N)). and a is a positive parameter. The complementary error While parallel implementations of hierarchical tree- function in the real space sum and the exponential codes, including the parallel fast multipole method and function in the reciprocal space sum decay rapidly with the parallel Barnes-Hut tree based multipole method, the index n, therefore cutoffs rc and kc can be used to have been extensively studied [21-26], the parallel compute the Ewald sum, i.e. only terms satisfying implementation of the Ewald summation based | ri – rj + Ln| £ rc (6) treecode [18] for fast evaluation of long-range for E(r) and Coulomb interactions in a periodic system has never |n| £ kc (7) been reported. In this paper, we present an efficient for E(k) are retained for the computation. The magnitude parallel implementation of this method. We describe an of the Ewald parameter a controls the relative rates of adaptive decomposition scheme based on the Morton convergence of the real space sum and the reciprocal order of the particles. This decomposition scheme takes space sum. When a is large, E(r) converges rapidly and advantage of the data locality and involves minimum can be evaluated to a given accuracy in O(N) changes to the original sequential code. We then operations using an appropriate cutoff rc; however in discuss Amdahl’s law and illustrate the performance this case E(k) converges slowly and O(N2) operations improvement gained by making a common sequential are required since the cutoff kc must be large enough to part faster. The parallel algorithm has been attain the desired accuracy. The situation is reversed implemented using the Message Passing Interface when a is small, and therefore in either case, the (MPI), making it portable to a variety of parallel classical Ewald method requires O(N2) operations. The platforms [27, 28]. We then report and discuss detailed cost can be reduced to O(N3/2) by optimizing the numerical results based on the force evaluation for a parameters a, rc, kc as a function of N [16]. The hidden water system on the IA32 Cluster at the Ohio constant in front of N3/2 can be further reduced using Supercomputer Center. The next section describes the the linked-cell method to reduce the computational cost Ewald summation based treecode. The parallel of locating the particles that are within the cutoff radius implementation of the method and timing results are of a given particle [6]. given in Section 3 and Section 4, respectively, The Ewald summation based multipole method is a followed by the conclusions in Section 5. tree-code [18]. A typical tree-code has three basic features: (a) the particles are divided into nested 2. Treecode Ewald method clusters, (b) the far-field influence of a cluster is approximated using a multipole expansion, and (c) a The total electrostatic energy of a periodic system of recursive procedure is applied to evaluate the required N particles can be described in terms of a conditionally force or potential. The Ewald summation based convergent series: treecode uses an oct-tree data structure and Cartesian ' N N 1 E = 1 q q multipole expansions to approximate the real space 2 å å å i j (1) n i=1 j =1 | ri - r j + L n | sum in the Ewald summation. With a relatively small value for a and an appropriate cutoff rc, the method where qi is the charge of particle i, L is the size of the reduces the computational complexity of the real space simulation box, ri is the position of particle i, |r| part from O(N2) to O(Nlog(N)). The reciprocal part can denotes the Euclidean norm, n = (n1, n2, n3) are be computed in O(N) operations using a cutoff kc. integers, and the prime indicates that the i=j terms are In the Ewald summation based treecode, the oct-tree omitted when n=0.
Recommended publications
  • Is the Ewald Summation Still Necessary? Pairwise Alternatives to the Accepted Standard for Long-Range Electrostatics ͒ Christopher J
    THE JOURNAL OF CHEMICAL PHYSICS 124, 234104 ͑2006͒ Is the Ewald summation still necessary? Pairwise alternatives to the accepted standard for long-range electrostatics ͒ Christopher J. Fennell and J. Daniel Gezeltera Department of Chemistry Biochemistry, University of Notre Dame, Notre Dame, Indiana 46556 ͑Received 24 March 2006; accepted 27 April 2006; published online 19 June 2006͒ We investigate pairwise electrostatic interaction methods and show that there are viable computationally efficient ͑O͑N͒͒ alternatives to the Ewald summation for typical modern molecular simulations. These methods are extended from the damped and cutoff-neutralized Coulombic sum originally proposed by Wolf et al. ͓J. Chem. Phys. 110, 8255 ͑1999͔͒. One of these, the damped shifted force method, shows a remarkable ability to reproduce the energetic and dynamic characteristics exhibited by simulations employing lattice summation techniques. Comparisons were performed with this and other pairwise methods against the smooth particle-mesh Ewald summation to see how well they reproduce the energetics and dynamics of a variety of molecular simulations. © 2006 American Institute of Physics. ͓DOI: 10.1063/1.2206581͔ I. INTRODUCTION dling electrostatics have the potential to scale linearly with increasing system size since they involve only simple modi- In molecular simulations, proper accumulation of the fications to the direct pairwise sum. They also lack the added electrostatic interactions is essential and is one of the most periodicity of the Ewald sum, so they can be used for sys- computationally demanding tasks. The common molecular tems which are nonperiodic or which have one-or two- mechanics force fields represent atomic sites with full or par- dimensional periodicity.
    [Show full text]
  • Arxiv:1712.04732V2 [Math.NA] 17 Jan 2021 New Window Function, Runtimes for the SE Method Can Be Further Reduced
    Fast Ewald summation for electrostatic potentials with arbitrary periodicity D. S. Shamshirgar,a) J. Bagge,b) and A.-K. Tornbergc) KTH Mathematics, Swedish e-Science Research Centre, 100 44 Stockholm, Sweden. A unified treatment for fast and spectrally accurate evaluation of electrostatic po- tentials subject to periodic boundary conditions in any or none of the three spatial dimensions is presented. Ewald decomposition is used to split the problem into a real- space and a Fourier-space part, and the FFT-based Spectral Ewald (SE) method is used to accelerate the computation of the latter. A key component in the unified treatment is an FFT-based solution technique for the free-space Poisson problem in three, two or one dimensions, depending on the number of non-periodic directions. The computational cost is furthermore reduced by employing an adaptive FFT for the doubly and singly periodic cases, allowing for different local upsampling factors. The SE method will always be most efficient for the triply periodic case as the cost of computing FFTs will then be the smallest, whereas the computational cost of the rest of the algorithm is essentially independent of periodicity. We show that the cost of removing periodic boundary conditions from one or two directions out of three will only moderately increase the total runtime. Our comparisons also show that the computational cost of the SE method in the free-space case is around four times that of the triply periodic case. The Gaussian window function previously used in the SE method, is here compared to a piecewise polynomial approximation of the Kaiser-Bessel window function.
    [Show full text]
  • A Random Batch Ewald Method for Particle Systems with Coulomb Interactions
    A random batch Ewald method for particle systems with Coulomb interactions Shi Jin∗1,2, Lei Liy1,2, Zhenli Xuz1,2, and Yue Zhaox1 1School of Mathematical Sciences, Shanghai Jiao Tong University, Shanghai, 200240, P. R. China 2Institute of Natural Sciences and MOE-LSC, Shanghai Jiao Tong University, Shanghai, 200240, P. R. China Abstract We develop a random batch Ewald (RBE) method for molecular dynamics simu- lations of particle systems with long-range Coulomb interactions, which achieves an O(N) complexity in each step of simulating the N-body systems. The RBE method is based on the Ewald splitting for the Coulomb kernel with a random \mini-batch" type technique introduced to speed up the summation of the Fourier series for the long-range part of the splitting. Importance sampling is employed to reduce the induced force vari- ance by taking advantage of the fast decay property of the Fourier coefficients. The stochastic approximation is unbiased with controlled variance. Analysis for bounded force fields gives some theoretic support of the method. Simulations of two typical problems of charged systems are presented to illustrate the accuracy and efficiency of the RBE method in comparison to the results from the Debye-H¨uckel theory and the classical Ewald summation, demonstrating that the proposed method has the attrac- tiveness of being easy to implement with the linear scaling and is promising for many practical applications. Key words. Ewald summation, Langevin dynamics, random batch method, s- tochastic differential equations AMS subject classifications. 65C35; 82M37; 65T50 1 Introduction Molecular dynamics simulation is among the most popular numerical methods at the molec- ular or atomic level to understand the dynamical and equilibrium properties of many-body particle systems in many areas such as chemical physics, soft materials and biophysics [8, 17, 16].
    [Show full text]
  • Condensation of Water on Rust Surfaces, and Possible Implications for Hydrate Formation in Pipelines
    Condensation of water on rust surfaces, and possible implications for hydrate formation in pipelines Master of Science thesis in process technology by Christian Anders Bøe Department of Physics and Technology University of Bergen, Norway June 2011 Abstract The threat of climate change has put the spotlight on the increase in carbon emissions and possible methods to attenuate it. As a consequence of this, oil and gas companies have started to consider both how to reduce emissions and use long-term sequestration of produced CO2. Statoil is working on a project which explores the possibilities of storing CO2 in geological formations beneath the sea to mitigate the climate change, as well as to investigate the possibilities for using CO2 gas in Enhanced Oil Recovery (EOR). This project will involve pipeline transport of CO2 gas on the bottom of the North Sea. Because of non-zero water content of this CO2, water can drop out as a liquid within the pipeline. The presence of liquid water and a strong hydrate former like CO2 can lead to hydrate plugging the pipeline under certain conditions. Companies such as Statoil spend large amounts of money on preventing hydrate formation within the pipelines, for example by injecting glycols. Their “best practice” approach commonly uses dew-point temperature curves to determine water dropout conditions. Recent work by Martin Haynes and Jan Thore Vassdal indicates that there is another driving force for water dropout in pipelines since water can adsorb on rusty pipe surfaces before it condenses within the gas phase. If this threat is valid, ignoring it could ultimately could cost the industry a lot of money.
    [Show full text]
  • Arxiv:1712.04732V1 [Math.NA] 13 Dec 2017 fields in Cosmological Formation of Galaxies, and Potentials in Stokes flow Simulations
    Fast Ewald summation for electrostatic potentials with arbitrary periodicity Davood Saffar Shamshirgar, Anna-Karin Tornberg KTH Mathematics, Swedish e-Science Research Centre, 100 44 Stockholm, Sweden. Abstract A unified treatment for fast and spectrally accurate evaluation of electrostatic potentials subject to periodic boundary conditions in any or none of the three space dimensions is presented. Ewald decomposition is used to split the problem into a real space and a Fourier space part, and the FFT based Spectral Ewald (SE) method is used to accelerate the computation of the latter. A key component in the unified treatment is an FFT based solution technique for the free-space Poisson problem in three, two or one dimensions, depending on the number of non-periodic directions. The cost of calculations is furthermore reduced by employing an adaptive FFT for the doubly and singly periodic cases, allowing for different local upsampling rates. The SE method will always be most efficient for the triply periodic case as the cost for computing FFTs will be the smallest, whereas the computational cost for the rest of the algorithm is essentially independent of the periodicity. We show that the cost of removing periodic boundary conditions from one or two directions out of three will only marginally increase the total run time. Our comparisons also show that the computational cost of the SE method for the free-space case is typically about four times more expensive as compared to the triply periodic case. The Gaussian window function previously used in the SE method, is here compared to an approximation of the Kaiser-Bessel window function, recently introduced in [2].
    [Show full text]
  • The Particle Mesh Ewald Algorithm and Its Use in Nucleic Acid Simulations Tom Darden1*, Lalith Perera2, Leping Li1 and Lee Pedersen1,2
    Ways & Means R55 New tricks for modelers from the crystallography toolkit: the particle mesh Ewald algorithm and its use in nucleic acid simulations Tom Darden1*, Lalith Perera2, Leping Li1 and Lee Pedersen1,2 Addresses: 1National Institute of Environmental Health Science, Box The method 12233, MD-F008, RTP, NC 27709, USA and 2Department of The fundamental problem is that of computing the electro- Chemistry, University of North Carolina at Chapel Hill, NC static energy (and first derivatives) of N particles, each with 27599–3290, USA. a unique charge, to arbitrary accuracy. Expressions for the *Corresponding author. energy and its derivatives are necessary to solve Newton’s E-mail: [email protected] equations of motion. Figure 1 summarizes approaches that Structure March 1999, 7:R55–R60 have been taken to date for simulations under periodic http://biomednet.com/elecref/09692126007R0055 boundary conditions. Truncation-based methods [1–6] con- stitute approximations that are perhaps unnecessary with © Elsevier Science Ltd ISSN 0969-2126 the high-speed high-storage computers of today (in fact the more sophisticated cut-off methods are less efficient Introduction than current fast Ewald methods). Of the ‘exact’ methods, The accurate simulation of DNA and RNA has been a the fast multipole method [12–15], which distributes the goal of theoretical biophysicists for a number of years. charges into subcells and then computes the interactions That is, given a high-resolution experimental structure, or between the subcells by multipole expansions in a hier- perhaps a structure modeled from diverse experimental archical fashion, shows promise, but to date applications to data, either of which provide a static view, we seek an realistic molecular systems have been limited.
    [Show full text]
  • Accurate and General Treatment of Electrostatic Interaction in Hamiltonian Adaptive Resolution Simulations
    Eur. Phys. J. Special Topics © EDP Sciences, Springer-Verlag 2016 THE EUROPEAN DOI: 10.1140/epjst/e2016-60151-6 PHYSICAL JOURNAL SPECIAL TOPICS Regular Article Accurate and general treatment of electrostatic interaction in Hamiltonian adaptive resolution simulations M. Heidari1, R. Cortes-Huerto1, D. Donadio2,1, and R. Potestio1,a 1 Max Planck Institute for Polymer Research, Ackermannweg 10, 55128 Mainz, Germany 2 Department of Chemistry, University of California Davis, One Shields Ave. Davis, CA, 95616, USA Received 30 April 2016 / Received in final form 16 June 2016 Published online 18 July 2016 Abstract. In adaptive resolution simulations the same system is con- currently modeled with different resolution in different subdomains of the simulation box, thereby enabling an accurate description in a small but relevant region, while the rest is treated with a computationally parsimonious model. In this framework, electrostatic interaction, whose accurate treatment is a crucial aspect in the realistic modeling of soft matter and biological systems, represents a particularly acute prob- lem due to the intrinsic long-range nature of Coulomb potential. In the present work we propose and validate the usage of a short-range modification of Coulomb potential, the Damped shifted force (DSF) model, in the context of the Hamiltonian adaptive resolution simu- lation (H-AdResS) scheme. This approach, which is here validated on bulk water, ensures a reliable reproduction of the structural and dy- namical properties of the liquid, and enables a seamless embedding in the H-AdResS framework. The resulting dual-resolution setup is imple- mented in the LAMMPS simulation package, and its customized version employed in the present work is made publicly available.
    [Show full text]
  • Development of a Polarizable Transferable Force Field for Vapor-Liquid Equilibria Calculations
    Development of a Polarizable Transferable Force Field for Vapor-Liquid Equilibria Calculations Von der Fakult¨atEnergie-, Verfahrens- und Biotechnik der Universit¨atStuttgart und dem Stuttgart Research Centre for Simulation Technology zur Erlangung der W¨urdeeines Doktors der Ingenieurwissenschaft (Dr.-Ing.) genehmigte Abhandlung Vorgelegt von Christian Waibel aus Schw¨abisch Gm¨und Hauptberichter: Prof. Dr.-Ing. Joachim Groß Mitberichter: Prof. Dr.-Ing. habil. Jadran Vrabec Tag der m¨undlichen Pr¨ufung:28.01.2019 Institut f¨urTechnische Thermodynamik und Thermische Verfahrenstechnik der Universit¨atStuttgart 2019 Erkl¨arungzu meiner Dissertation mit dem Titel: Development of a Polarizable Transferable Force Field for Vapor-Liquid Equilibria Calculations Hiermit erkl¨areich, dass ich die beigef¨ugteDissertation selbstst¨andigverfasst und keine anderen als die angegebenen Hilfsmittel genutzt habe. Alle w¨ortlich oder inhaltlich ¨ubernommenen Stellen habe ich als solche gekennzeichnet. Ich versichere außerdem, dass ich die beigef¨ugteDissertation nur in diesem und keinem an- deren Promotionsverfahren eingereicht habe und dass diesem Promotionsverfahren keine endg¨ultiggescheiterten Promotionsverfahren vorausgegangen sind. Ort, Datum Unterschrift Contents 1 Introduction 15 1.1 Vapor-Liquid Equilibria in Molecular Simulation . 15 1.1.1 Gibbs Ensemble Monte Carlo . 16 1.1.2 Grand Canonical Transition Matrix Monte Carlo . 18 1.2 Molecular Model . 23 1.2.1 Classical Force Fields . 23 1.2.2 Polarizable Force Fields . 25 1.3 Methods for Electrostatic Energy Calculation . 26 1.3.1 Ewald Summation . 27 1.3.2 Wolf Summation . 29 1.4 Outline of this thesis . 29 Bibliography . 30 2 Modification of the Wolf Method and Evaluation for Molecular Simula- tion of Vapor-Liquid Equilibria 35 2.1 Wolf Summation .
    [Show full text]
  • Long-Range Interactions in Many-Particle Simulation
    John von Neumann Institute for Computing Long-Range Interactions in Many-Particle Simulation Paul Gibbon, Godehard Sutmann published in Quantum Simulations of Complex Many-Body Systems: From Theory to Algorithms, Lecture Notes, J. Grotendorst, D. Marx, A. Muramatsu (Eds.), John von Neumann Institute for Computing, Julich,¨ NIC Series, Vol. 10, ISBN 3-00-009057-6, pp. 467-506, 2002. c 2002 by John von Neumann Institute for Computing Permission to make digital or hard copies of portions of this work for personal or classroom use is granted provided that the copies are not made or distributed for profit or commercial advantage and that copies bear this notice and the full citation on the first page. To copy otherwise requires prior specific permission by the publisher mentioned above. http://www.fz-juelich.de/nic-series/volume10 Long-Range Interactions in Many-Particle Simulation Paul Gibbon and Godehard Sutmann John von Neumann Institute for Computing Central Institute for Applied Mathematics Research Centre Julich,¨ 52425 Julich,¨ Germany E-mail: fp.gibbon, [email protected] Numerical algorithms for accelerating the computation of N-body problems dominated by long-range inter-particle forces are reviewed. For periodic systems, the optimised Ewald lattice 3 2 sum with an O(N = ) scaling forms a reference standard against which the newer, potentially faster Particle-Particle Particle-Mesh and Fast Multipole Methods can be measured. The more general N-body problem with arbitrary boundary conditions is also described, in which various multipole methods are now routinely used instead of direct summation for particle numbers in excess of 104.
    [Show full text]
  • Methods for Efficient Computer Simulations of Charged Systems
    Methods for efficient computer simulations of charged systems Axel Arnold Institute for Computational Physics Universit¨atStuttgart August 2010 1 1. Introduction 1.1 Electrostatics We assume N charges qie at positions ri. This corresponds to a charge density N X ρe = qieδ(r − ri): (1.1) i=1 If the charges move slowly, then we can ignore magnetic forces, and the force on each particle is Fi = qieE(ri) (1.2) and the total electrostatic energy Z UE = ρ(r)eE(r)dr; (1.3) where E is the electrostatic field with the properties r · E = ρe/ (1.4) r × E = 0: (1.5) The latter implies that E is the gradient of an up to a constant unique scalar electrostatic potential Φ such that E = −∇Φ. Inserting into (1.4) gives −∇2Φ = ρe/, (1.6) which is a defining differential equation for Φ. For a single charge, it has the solution: 2 qie 1 −∇ = qieδ(r − ri)/ (1.7) 4π r − ri It is convenient to define the Bjerrum length e2 lB = ; (1.8) 4πkBT which is the distance at which two unit charges feel an electrostatic interaction equal to 1kBT ; this means for example that by spontaneous thermal fluctuations, two oppositely charged unit charges can be separated by a distance up to lB. The Bjerrum length in water at room temperature is 0.7nm due to its large relative permittivity of /0 ≈ 80. Then the electrostatic forces and potential are N X qiqj 1 X X qiqj − Fi = kBT lB 3 (ri rj) and UE = kBT lB ; (1.9) jri − rjj 2 ri − rj j=6 i i=1 j=6 i where the (infinite) self interactions of point charges are omitted.
    [Show full text]
  • Non-Uniform FFT and Its Applications in Particle Simulations
    Applied Mathematics, 2014, 5, 520-541 Published Online February 2014 (http://www.scirp.org/journal/am) http://dx.doi.org/10.4236/am.2014.53051 Non-Uniform FFT and Its Applications in Particle Simulations Yong-Lei Wang1, Fredrik Hedman2, Massimiliano Porcu1,3, Francesca Mocci1,3, Aatto Laaksonen1 1Department of Materials and Environmental Chemistry, Arrhenius Laboratory, Stockholm University, Stockholm, Sweden 2Noruna AB, Stockholm, Sweden 3Dipartimento di Scienze Chimiche e Geologiche, Cagliari University, Cittadella Universitaria di Monserrato (CA), Monserrato, Italy Email: [email protected], [email protected], [email protected], [email protected], [email protected] Received October 19, 2013; revised November 19, 2013; accepted November 26, 2013 Copyright © 2014 Yong-Lei Wang et al. This is an open access article distributed under the Creative Commons Attribution License, which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited. In accor- dance of the Creative Commons Attribution License all Copyrights © 2014 are reserved for SCIRP and the owner of the intellectual property Yong-Lei Wang et al. All Copyright © 2014 are guarded by law and by SCIRP as a guardian. ABSTRACT Ewald summation method, based on Non-Uniform FFTs (ENUF) to compute the electrostatic interactions and forces, is implemented in two different particle simulation schemes to model molecular and soft matter, in clas- sical all-atom Molecular Dynamics and in Dissipative Particle Dynamics for coarse-grained particles. The me- thod combines the traditional Ewald method with a non-uniform fast Fourier transform library (NFFT), making it highly efficient. It scales linearly with the number of particles as ()NNlog , while being both robust and ac- curate.
    [Show full text]