DIIS and Hamiltonian Diagonalisation for Total-Energy Minimisation in the ONETEP Program Using the Scalapack Eigensolver

Total Page:16

File Type:pdf, Size:1020Kb

DIIS and Hamiltonian Diagonalisation for Total-Energy Minimisation in the ONETEP Program Using the Scalapack Eigensolver DIIS and Hamiltonian diagonalisation for total-energy minimisation in the ONETEP program using the ScaLAPACK eigensolver. Álvaro Ruiz Serrano August 27, 2010 MSc in High Performance Computing The University of Edinburgh Year of Presentation: 2010 Abstract Direct Inversion in the Iterative Subspace (DIIS) combined with Hamiltonian diagonal- isation has been implemented in the ONETEP code for minimising the total energy of large systems using Density Functional Theory. This novel approach mixes the quan- tum single-particle density matrix at each iteration to accelerate the convergence of the self-consistent method in the inner loop of ONETEP. At each iteration the Hamilto- nian matrix is diagonalised and a new density matrix is generated from its eigenvectors. Eigensolver routines working on dense matrices scale with the third power of the system size which makes difficult to simulate systems of thousands of atoms. The ScaLAPACK parallel eigensolver is assessed as a method for diagonalising the Hamiltonian matrix in this kind of calculations. The results show that the DIIS-Hamiltonian diagonalisa- tion method works to a very high accuracy for systems of up to near 600 atoms and becomes unstable for larger systems. The ScaLAPACK parallel eigensolver has proven to enhance this approach by distributing the data over the processors which cooper- ate to find the solution of the system. The DIIS method is intended to be combined with ensemble-DFT methods for simulating metallic systems, which are not achievable with linear-scaling DFT approaches. The performance results show that it is possible to simulate systems of a few thousands of atoms with a computational effort that is comparable to linear-scaling DFT programs. The code that has been developed for this work will be added to the main ONETEP code repository and will be available to other users for active research on condensed matter theory. Contents 1 Introduction 1 2 Background theory 4 2.1 First-principles methods in computational chemistry . 4 2.2 Density Functional Theory . 6 2.3 Linear-scaling DFT . 8 2.4 The ONETEP code . 10 3 The DIIS algorithm: theory and computational implementation in ONETEP 15 3.1 Description of the original DIIS . 16 3.2 Implementation of the DIIS algorithm in the ONETEP code . 17 3.3 Description of the code . 20 3.4 Eigensolvers . 23 3.4.1 LAPACK serial eigensolver, DSYGVX . 24 3.4.2 ScaLAPACK parallel eigensolver, PDSYGVX . 25 4 Target machines architecture, compilation details and benchmarks 26 4.1 Target machines architecture . 26 4.2 Compilation details . 27 4.3 Benchmarks . 28 5 Validation tests 31 5.1 Results . 31 5.2 Methods for solving the convergence problems of the DIIS algorithm for large systems . 35 5.2.1 DIIS initialisation . 35 5.2.2 Kerker preconditioning . 36 5.2.3 Level shifting . 36 5.2.4 Other approaches . 37 6 Performance results and analysis 38 6.1 Comparison of LAPACK and ScaLAPACK eigensolvers . 39 6.2 Comparison of LNV and DIIS algorithms for the inner loop of ONETEP 42 6.3 Future performance optimisations . 46 i 7 Conclusions 47 ii List of Tables 4.1 Set of small test cases . 28 4.2 Set of benchmarks corresponding to silicon nanorods of different size . 29 4.3 Set of benchmarks corresponding to a the amyloid protein of increasing size . 30 5.1 Energy obtained by LNV and DIIS methods for the set of small test cases. The asterisk * indicates that the calculation did not converge to the standard threshold. 33 5.2 Energy obtained by LNV and DIIS methods for the benchmark set of silicon nanorods. The asterisk * indicates that the calculation did not converge to the standard threshold. 34 6.1 Successful calculations using LAPACK and ScaLAPACK eigensolvers on HECToR and Iridis 3. In all cases, 4 CPUs per node have been used. The asterisk * indicates that a smaller number of nodes has not been tested and it is possible for the calculation to fit on less nodes than that. For saving computational time, the protein systems have not been simulated using LAPACK on Iridis 3. 40 iii List of Figures 2.1 ONETEP energy minimisation procedure. The energy functional is minimised in two nested loops: the inner loop optimises the elements of the density kernel, while the outer loop optimises the NGWFs. 13 3.1 Implementation of the DIIS algorithm in ONETEP. 20 4.1 Set of small benchmarks. 29 4.2 Set of silicon nanorods benchmarks. 29 4.3 Set of benchmarks of cuts to the amyloid protein. 30 5.1 Convergence of the energy of the LNV and DIIS methods for the set of small systems. 32 5.2 Potential energy well generated by the H-bonds between the monomers of the Tennis ball protein. The calculations with LNV and DIIS show very good agreement for this system. 33 5.3 Convergence of the energy of the LNV and DIIS methods for the set of silicon nanorods. 34 6.1 Timings, speed-up, parallel efficiency and serial fraction (Karp-Flatt metric) of the eigensolvers for the Si766H402 silicon nanorod on Iridis 3. 41 6.2 Timings, speed-up, parallel efficiency and serial fraction (Karp-Flatt metric) of the eigensolvers for the p16_20 protein benchmark on HEC- ToR..................................... 42 6.3 Timings, speed-up, parallel efficiency and serial fraction (Karp-Flatt metric) of the the inner loop of ONETEP for the p64_20 protein bench- mark on HECToR. 43 6.4 Timings, speed-up, parallel efficiency and serial fraction (Karp-Flatt metric) of the inner loop of ONETEP for the p64_20 protein benchmark on HECToR. 44 6.5 Comparison of the scaling of the LNV and DIIS algorithms with the system size for the set of silicon nanorods. The systems have been simulating usign 20 nodes and 4 CPUs per node on Iridis 3. 44 6.6 Comparison of the scaling of the LNV and DIIS algorithms with the system size for the set of amyloid benchmarks. The systems have been simulating usign 20 nodes and 4 CPUs per node on HECToR and Iridis 3. 45 iv 6.7 Scaling of the DIIS-Hamiltonian diagonalisation routines with the sys- tem size of the amyloid protein. The systems have been simulating usign 20 nodes and 4 CPUs per node on Iridis 3. 45 v Acknowledgements The author would like to acknowledge the members of the ONETEP developers group for their valuable help and his MSc supervisor, Bartosz Dobrzelecki, for his advice during the completion of this work. This project was done as part of High-End Computing PhD studentship granted to the author, funded by EPSRC and supervised by Dr. Chris-Kriton Skylaris at the University of Southampton. The first two years of this studentship include the part-time partici- pation to the MSc in High Performance Computing at the University of Edinburgh, for which this dissertation is submitted. Chapter 1 Introduction Solid State Physics is the branch of Science that studies the formation and properties of matter. As a result of research on this field, novel materials and compounds have been developed for engineering and medical purposes that expand the capabilities of technology. Condensed matter is formed by atoms that interact with each other accord- ing to the laws of Quantum Mechanics which define the observable properties of the material. Experimental work in the field has to be combined with theoretical models of atoms, molecules and solids in order to overcome the intrinsic difficulty of work- ing in the nanoscale. First-principles calculations provide an an accurate description of the processes that take place at atomic scale, which is derived directly from the basic equations of Quantum Mechanics and do not require parameterisations based on exper- imental results to work. With these calculations, often based on the Born-Oppenheimer approximation [1], it is possible to determine the structure of a molecule or group of molecules and its electronic properties, which, in turn, result in a detailed description of the final behaviour of the real compound. For these reasons, due to its ability for describing the nature of materials, the development of First-Principles techniques con- stitutes an important field of research for academy and industry. Molecules are formed by many atoms which may contain a very large number of elec- trons. Codes for solving such systems represent a major challenge for computational science as they are an example of a problem of N interacting bodies, which, when translated into equations, result in an intractable amount of degrees of freedom to be found. The application of parallel computing techniques into First-Principles Quan- tum Mechanical codes has made possible to simulate systems that would have never been achievable with serial computers. The efficiency and scaling of these algorithms is the key for scaling to new and larger systems like modern nanomaterials or drug compounds. The ONETEP code [2] performs First-Principles Quantum Mechanics calculations based on Density Functional Theory (DFT) [3] with a computational effort that scales linearly with the number of atoms in the system. This program takes advantage of parallel computing to simulate systems of tens of thousands of atoms with a great quantum ac- 1 curacy. The code, which uses Message-Passing directives for massive parallelisation on distributed memory machines, has been designed for maximum parallel performance on modern state-of-the-art clusters. ONETEP uses a Self-Consistent Field (SCF) ap- proach [1] for finding the ground-state of the system by minimising the total energy with respect to the quantum single-particle density matrix in two nested loops. In this work, Direct Inversion in the Iterative Subspace (DIIS) method [4] combined with explicit diagonalisation of the Hamiltonian matrix has been introduced as a new method for minimising the total energy in the inner loop of ONETEP.
Recommended publications
  • Introducing ONETEP: Linear-Scaling Density Functional Simulations on Parallel Computers Chris-Kriton Skylaris,A) Peter D
    THE JOURNAL OF CHEMICAL PHYSICS 122, 084119 ͑2005͒ Introducing ONETEP: Linear-scaling density functional simulations on parallel computers Chris-Kriton Skylaris,a) Peter D. Haynes, Arash A. Mostofi, and Mike C. Payne Theory of Condensed Matter, Cavendish Laboratory, Madingley Road, Cambridge CB3 0HE, United Kingdom ͑Received 29 September 2004; accepted 4 November 2004; published online 23 February 2005͒ We present ONETEP ͑order-N electronic total energy package͒, a density functional program for parallel computers whose computational cost scales linearly with the number of atoms and the number of processors. ONETEP is based on our reformulation of the plane wave pseudopotential method which exploits the electronic localization that is inherent in systems with a nonvanishing band gap. We summarize the theoretical developments that enable the direct optimization of strictly localized quantities expressed in terms of a delocalized plane wave basis. These same localized quantities lead us to a physical way of dividing the computational effort among many processors to allow calculations to be performed efficiently on parallel supercomputers. We show with examples that ONETEP achieves excellent speedups with increasing numbers of processors and confirm that the time taken by ONETEP as a function of increasing number of atoms for a given number of processors is indeed linear. What distinguishes our approach is that the localization is achieved in a controlled and mathematically consistent manner so that ONETEP obtains the same accuracy as conventional cubic-scaling plane wave approaches and offers fast and stable convergence. We expect that calculations with ONETEP have the potential to provide quantitative theoretical predictions for problems involving thousands of atoms such as those often encountered in nanoscience and biophysics.
    [Show full text]
  • Natural Bond Orbital Analysis in the ONETEP Code: Applications to Large Protein Systems Louis P
    WWW.C-CHEM.ORG FULL PAPER Natural Bond Orbital Analysis in the ONETEP Code: Applications to Large Protein Systems Louis P. Lee,*[a] Daniel J. Cole,[a] Mike C. Payne,[a] and Chris-Kriton Skylaris[b] First principles electronic structure calculations are typically Generalized Wannier Functions of ONETEP to natural atomic performed in terms of molecular orbitals (or bands), providing a orbitals, NBO analysis can be performed within a localized straightforward theoretical avenue for approximations of region in such a way that ensures the results are identical to an increasing sophistication, but do not usually provide any analysis on the full system. We demonstrate the capabilities of qualitative chemical information about the system. We can this approach by performing illustrative studies of large derive such information via post-processing using natural bond proteins—namely, investigating changes in charge transfer orbital (NBO) analysis, which produces a chemical picture of between the heme group of myoglobin and its ligands with bonding in terms of localized Lewis-type bond and lone pair increasing system size and between a protein and its explicit orbitals that we can use to understand molecular structure and solvent, estimating the contribution of electronic delocalization interactions. We present NBO analysis of large-scale calculations to the stabilization of hydrogen bonds in the binding pocket of with the ONETEP linear-scaling density functional theory package, a drug-receptor complex, and observing, in situ, the n ! p* which we have interfaced with the NBO 5 analysis program. In hyperconjugative interactions between carbonyl groups that ONETEP calculations involving thousands of atoms, one is typically stabilize protein backbones.
    [Show full text]
  • Density Functional Theory (DFT)
    Herramientas mecano-cuánticas basadas en DFT para el estudio de moléculas y materiales en Materials Studio 7.0 Javier Ramos Biophysics of Macromolecular Systems group (BIOPHYM) Departamento de Física Macromolecular Instituto de Estructura de la Materia – CSIC [email protected] Webinar, 26 de Junio 2014 Anteriores webinars Como conseguir los videos y las presentaciones de anteriores webminars: Linkedin: Grupo de Química Computacional http://www.linkedin.com/groups/Química-computacional-7487634 Índice Density Functional Theory (DFT) The Jacob’s ladder DFT modules in Maretials Studio DMOL3, CASTEP and ONETEP XC functionals Basis functions Interfaces in Materials Studio Tasks Properties Example: n-butane conformations Density Functional Theory (DFT) DFT is built around the premise that the energy of an electronic system can be defined in terms of its electron probability density (ρ). (Hohenberg-Kohn Theorem) E 0 [ 0 ] Te [ 0 ] E ne [ 0 ] E ee [ 0 ] (easy) Kinetic Energy for ????? noninteracting (r )v (r ) dr electrons(easy) 1 E[]()()[]1 r r d r d r E e e2 1 2 1 2 X C r12 Classic Term(Coulomb) Non-classic Kohn-Sham orbitals Exchange & By minimizing the total energy functional applying the variational principle it is Correlation possible to get the SCF equations (Kohn-Sham) The Jacob’s Ladder Accurate form of XC potential Meta GGA Empirical (Fitting to Non-Empirical Generalized Gradient Approx. atomic properties) (physics rules) Local Density Approximation DFT modules in Materials Studio DMol3: Combine computational speed with the accuracy of quantum mechanical methods to predict materials properties reliably and quickly CASTEP: CASTEP offers simulation capabilities not found elsewhere, such as accurate prediction of phonon spectra, dielectric constants, and optical properties.
    [Show full text]
  • Compact Orbitals Enable Low-Cost Linear-Scaling Ab Initio Molecular Dynamics for Weakly-Interacting Systems Hayden Scheiber,1, A) Yifei Shi,1 and Rustam Z
    Compact orbitals enable low-cost linear-scaling ab initio molecular dynamics for weakly-interacting systems Hayden Scheiber,1, a) Yifei Shi,1 and Rustam Z. Khaliullin1, b) Department of Chemistry, McGill University, 801 Sherbrooke St. West, Montreal, QC H3A 0B8, Canada Today, ab initio molecular dynamics (AIMD) relies on the locality of one-electron density matrices to achieve linear growth of computation time with systems size, crucial in large-scale simulations. While Kohn-Sham orbitals strictly localized within predefined radii can offer substantial computational advantages over density matrices, such compact orbitals are not used in AIMD because a compact representation of the electronic ground state is difficult to find. Here, a robust method for maintaining compact orbitals close to the ground state is coupled with a modified Langevin integrator to produce stable nuclear dynamics for molecular and ionic systems. This eliminates a density matrix optimization and enables first orbital-only linear-scaling AIMD. An application to liquid water demonstrates that low computational overhead of the new method makes it ideal for routine medium-scale simulations while its linear-scaling complexity allows to extend first- principle studies of molecular systems to completely new physical phenomena on previously inaccessible length scales. Since the unification of molecular dynamics and den- LS methods restrict their use in dynamical simulations sity functional theory (DFT)1, ab initio molecular dy- to very short time scales, systems of low dimensions, namics (AIMD) has become an important tool to study and low-quality minimal basis sets6,18–20. On typical processes in molecules and materials. Unfortunately, the length and time scales required in practical and accurate computational cost of the conventional Kohn-Sham (KS) AIMD simulations, LS DFT still cannot compete with DFT grows cubically with the number of atoms, which the straightforward low-cost cubically-scaling KS DFT.
    [Show full text]
  • Quantum Chemistry (QC) on Gpus Feb
    Quantum Chemistry (QC) on GPUs Feb. 2, 2017 Overview of Life & Material Accelerated Apps MD: All key codes are GPU-accelerated QC: All key codes are ported or optimizing Great multi-GPU performance Focus on using GPU-accelerated math libraries, OpenACC directives Focus on dense (up to 16) GPU nodes &/or large # of GPU nodes GPU-accelerated and available today: ACEMD*, AMBER (PMEMD)*, BAND, CHARMM, DESMOND, ESPResso, ABINIT, ACES III, ADF, BigDFT, CP2K, GAMESS, GAMESS- Folding@Home, GPUgrid.net, GROMACS, HALMD, HOOMD-Blue*, UK, GPAW, LATTE, LSDalton, LSMS, MOLCAS, MOPAC2012, LAMMPS, Lattice Microbes*, mdcore, MELD, miniMD, NAMD, NWChem, OCTOPUS*, PEtot, QUICK, Q-Chem, QMCPack, OpenMM, PolyFTS, SOP-GPU* & more Quantum Espresso/PWscf, QUICK, TeraChem* Active GPU acceleration projects: CASTEP, GAMESS, Gaussian, ONETEP, Quantum Supercharger Library*, VASP & more green* = application where >90% of the workload is on GPU 2 MD vs. QC on GPUs “Classical” Molecular Dynamics Quantum Chemistry (MO, PW, DFT, Semi-Emp) Simulates positions of atoms over time; Calculates electronic properties; chemical-biological or ground state, excited states, spectral properties, chemical-material behaviors making/breaking bonds, physical properties Forces calculated from simple empirical formulas Forces derived from electron wave function (bond rearrangement generally forbidden) (bond rearrangement OK, e.g., bond energies) Up to millions of atoms Up to a few thousand atoms Solvent included without difficulty Generally in a vacuum but if needed, solvent treated classically
    [Show full text]
  • Introduction to DFT and the Plane-Wave Pseudopotential Method
    Introduction to DFT and the plane-wave pseudopotential method Keith Refson STFC Rutherford Appleton Laboratory Chilton, Didcot, OXON OX11 0QX 23 Apr 2014 Parallel Materials Modelling Packages @ EPCC 1 / 55 Introduction Synopsis Motivation Some ab initio codes Quantum-mechanical approaches Density Functional Theory Electronic Structure of Condensed Phases Total-energy calculations Introduction Basis sets Plane-waves and Pseudopotentials How to solve the equations Parallel Materials Modelling Packages @ EPCC 2 / 55 Synopsis Introduction A guided tour inside the “black box” of ab-initio simulation. Synopsis • Motivation • The rise of quantum-mechanical simulations. Some ab initio codes Wavefunction-based theory • Density-functional theory (DFT) Quantum-mechanical • approaches Quantum theory in periodic boundaries • Plane-wave and other basis sets Density Functional • Theory SCF solvers • Molecular Dynamics Electronic Structure of Condensed Phases Recommended Reading and Further Study Total-energy calculations • Basis sets Jorge Kohanoff Electronic Structure Calculations for Solids and Molecules, Plane-waves and Theory and Computational Methods, Cambridge, ISBN-13: 9780521815918 Pseudopotentials • Dominik Marx, J¨urg Hutter Ab Initio Molecular Dynamics: Basic Theory and How to solve the Advanced Methods Cambridge University Press, ISBN: 0521898633 equations • Richard M. Martin Electronic Structure: Basic Theory and Practical Methods: Basic Theory and Practical Density Functional Approaches Vol 1 Cambridge University Press, ISBN: 0521782856
    [Show full text]
  • What's New in Biovia Materials Studio 2020
    WHAT’S NEW IN BIOVIA MATERIALS STUDIO 2020 Datasheet BIOVIA Materials Studio 2020 is the latest release of BIOVIA’s predictive science tools for chemistry and materials science research. Materials Studio empowers researchers to understand the relationships between a material’s mo- lecular or crystal structure and its properties in order to make more informed decisions about materials research and development. More often than not materials performance is influenced by phenomena at multiple scales. Scientists using Materials Studio 2020 have an extensive suite of world class solvers and parameter sets operating from atoms to microscale for simulating more materials and more properties than ever before. Furthermore, the predicted properties can now be used in multi-physics modeling and in systems modeling software such as SIMULIA Abaqus and CATIA Dymola to predict macroscopic behaviors. In this way multiscale simulations can be used to solve some of the toughest pro- blems in materials design and product optimization. BETTER MATERIALS - BETTER BATTERIES Safe, fast charging batteries with high energy density and long life are urgently needed for a host of applications - not least for the electrification of all modes of transportation as an alternative to fossil fuel energy sources. Battery design relies on a complex interplay between thermal, mechanical and chemical processes from the smallest scales of the material (electronic structure) through to the geometry of the battery cell and pack design. Improvements to the component materials used in batteries and capacitors are fundamental to providing the advances in performance needed. Materials Studio provides new functionality to enable the simula- tion of key materials parameters for both liquid electrolytes and electrode components.
    [Show full text]
  • O (N) Methods in Electronic Structure Calculations
    O(N) Methods in electronic structure calculations D R Bowler1;2;3 and T Miyazaki4 1London Centre for Nanotechnology, UCL, 17-19 Gordon St, London WC1H 0AH, UK 2Department of Physics & Astronomy, UCL, Gower St, London WC1E 6BT, UK 3Thomas Young Centre, UCL, Gower St, London WC1E 6BT, UK 4National Institute for Materials Science, 1-2-1 Sengen, Tsukuba, Ibaraki 305-0047, JAPAN E-mail: [email protected] E-mail: [email protected] Abstract. Linear scaling methods, or O(N) methods, have computational and memory requirements which scale linearly with the number of atoms in the system, N, in contrast to standard approaches which scale with the cube of the number of atoms. These methods, which rely on the short-ranged nature of electronic structure, will allow accurate, ab initio simulations of systems of unprecedented size. The theory behind the locality of electronic structure is described and related to physical properties of systems to be modelled, along with a survey of recent developments in real-space methods which are important for efficient use of high performance computers. The linear scaling methods proposed to date can be divided into seven different areas, and the applicability, efficiency and advantages of the methods proposed in these areas is then discussed. The applications of linear scaling methods, as well as the implementations available as computer programs, are considered. Finally, the prospects for and the challenges facing linear scaling methods are discussed. Submitted to: Rep. Prog. Phys. arXiv:1108.5976v5 [cond-mat.mtrl-sci] 3 Nov 2011 O(N) Methods 2 1.
    [Show full text]
  • Porting the DFT Code CASTEP to Gpgpus
    Porting the DFT code CASTEP to GPGPUs Toni Collis [email protected] EPCC, University of Edinburgh CASTEP and GPGPUs Outline • Why are we interested in CASTEP and Density Functional Theory codes. • Brief introduction to CASTEP underlying computational problems. • The OpenACC implementation http://www.nu-fuse.com CASTEP: a DFT code • CASTEP is a commercial and academic software package • Capable of Density Functional Theory (DFT) and plane wave basis set calculations. • Calculates the structure and motions of materials by the use of electronic structure (atom positions are dictated by their electrons). • Modern CASTEP is a re-write of the original serial code, developed by Universities of York, Durham, St. Andrews, Cambridge and Rutherford Labs http://www.nu-fuse.com CASTEP: a DFT code • DFT/ab initio software packages are one of the largest users of HECToR (UK national supercomputing service, based at University of Edinburgh). • Codes such as CASTEP, VASP and CP2K. All involve solving a Hamiltonian to explain the electronic structure. • DFT codes are becoming more complex and with more functionality. http://www.nu-fuse.com HECToR • UK National HPC Service • Currently 30- cabinet Cray XE6 system – 90,112 cores • Each node has – 2×16-core AMD Opterons (2.3GHz Interlagos) – 32 GB memory • Peak of over 800 TF and 90 TB of memory http://www.nu-fuse.com HECToR usage statistics Phase 3 statistics (Nov 2011 - Apr 2013) Ab initio codes (VASP, CP2K, CASTEP, ONETEP, NWChem, Quantum Espresso, GAMESS-US, SIESTA, GAMESS-UK, MOLPRO) GS2NEMO ChemShell 2%2% SENGA2% 3% UM Others 4% 34% MITgcm 4% CASTEP 4% GROMACS 6% DL_POLY CP2K VASP 5% 8% 19% http://www.nu-fuse.com HECToR usage statistics Phase 3 statistics (Nov 2011 - Apr 2013) 35% of the Chemistry software on HECToR is using DFT methods.
    [Show full text]
  • HPC Issues for DFT Calculations
    HPC Issues for DFT Calculations Adrian Jackson EPCC Scientific Simulation • Simulation fast becoming 4 th pillar of science – Observation, Theory, Experimentation, Simulation • Explore universe through simulation rather than experimentation – Test theories – Predict or validate experiments – Simulate “untestable” science • Reproduce “real world” in computers – Generally simplified – Dimensions and timescales restricted – Simulation of scientific problem or environment – Input of real data – Output of simulated data – Parameter space studies – Wide range of approaches http://www.nu-fuse.com Reduce runtime • Serial code optimisations – Reduce runtime through efficiencies – Unlikely to produce required savings • Upgrade hardware – 1965: Moore’s law predicts growth in complexity of processors – Doubling of CPU performance – Performance often improved through on chip parallelism http://www.nu-fuse.com Parallel Background • Why not just make a faster chip? – Theoretical • Physical limitations to size and speed of a single chip • Capacitance increases with complexity • Speed of light, size of atoms, dissipation of heat • The power used by a CPU core is proportional to Clock Frequency x Voltage 2 • Voltage reduction vs Clock speed for power requirements – Voltages become too small for “digital” differences – Practical • Developing new chips is incredibly expensive • Must make maximum use of existing technology http://www.nu-fuse.com Parallel Systems • Different types of parallel systems P M – Shared memory P M P M – Distributed memory P M Interconnect
    [Show full text]
  • Lawrence Berkeley National Laboratory Recent Work
    Lawrence Berkeley National Laboratory Recent Work Title From NWChem to NWChemEx: Evolving with the Computational Chemistry Landscape. Permalink https://escholarship.org/uc/item/4sm897jh Journal Chemical reviews, 121(8) ISSN 0009-2665 Authors Kowalski, Karol Bair, Raymond Bauman, Nicholas P et al. Publication Date 2021-04-01 DOI 10.1021/acs.chemrev.0c00998 Peer reviewed eScholarship.org Powered by the California Digital Library University of California From NWChem to NWChemEx: Evolving with the computational chemistry landscape Karol Kowalski,y Raymond Bair,z Nicholas P. Bauman,y Jeffery S. Boschen,{ Eric J. Bylaska,y Jeff Daily,y Wibe A. de Jong,x Thom Dunning, Jr,y Niranjan Govind,y Robert J. Harrison,k Murat Keçeli,z Kristopher Keipert,? Sriram Krishnamoorthy,y Suraj Kumar,y Erdal Mutlu,y Bruce Palmer,y Ajay Panyala,y Bo Peng,y Ryan M. Richard,{ T. P. Straatsma,# Peter Sushko,y Edward F. Valeev,@ Marat Valiev,y Hubertus J. J. van Dam,4 Jonathan M. Waldrop,{ David B. Williams-Young,x Chao Yang,x Marcin Zalewski,y and Theresa L. Windus*,r yPacific Northwest National Laboratory, Richland, WA 99352 zArgonne National Laboratory, Lemont, IL 60439 {Ames Laboratory, Ames, IA 50011 xLawrence Berkeley National Laboratory, Berkeley, 94720 kInstitute for Advanced Computational Science, Stony Brook University, Stony Brook, NY 11794 ?NVIDIA Inc, previously Argonne National Laboratory, Lemont, IL 60439 #National Center for Computational Sciences, Oak Ridge National Laboratory, Oak Ridge, TN 37831-6373 @Department of Chemistry, Virginia Tech, Blacksburg, VA 24061 4Brookhaven National Laboratory, Upton, NY 11973 rDepartment of Chemistry, Iowa State University and Ames Laboratory, Ames, IA 50011 E-mail: [email protected] 1 Abstract Since the advent of the first computers, chemists have been at the forefront of using computers to understand and solve complex chemical problems.
    [Show full text]
  • Virt&L-Comm.3.2012.1
    Virt&l-Comm.3.2012.1 A MODERN APPROACH TO AB INITIO COMPUTING IN CHEMISTRY, MOLECULAR AND MATERIALS SCIENCE AND TECHNOLOGIES ANTONIO LAGANA’, DEPARTMENT OF CHEMISTRY, UNIVERSITY OF PERUGIA, PERUGIA (IT)* ABSTRACT In this document we examine the present situation of Ab initio computing in Chemistry and Molecular and Materials Science and Technologies applications. To this end we give a short survey of the most popular quantum chemistry and quantum (as well as classical and semiclassical) molecular dynamics programs and packages. We then examine the need to move to higher complexity multiscale computational applications and the related need to adopt for them on the platform side cloud and grid computing. On this ground we examine also the need for reorganizing. The design of a possible roadmap to establishing a Chemistry Virtual Research Community is then sketched and some examples of Chemistry and Molecular and Materials Science and Technologies prototype applications exploiting the synergy between competences and distributed platforms are illustrated for these applications the middleware and work habits into cooperative schemes and virtual research communities (part of the first draft of this paper has been incorporated in the white paper issued by the Computational Chemistry Division of EUCHEMS in August 2012) INTRODUCTION The computational chemistry (CC) community is made of individuals (academics, affiliated to research institutions and operators of chemistry related companies) carrying out computational research in Chemistry, Molecular and Materials Science and Technology (CMMST). It is to a large extent registered into the CC division (DCC) of the European Chemistry and Molecular Science (EUCHEMS) Society and is connected to other chemistry related organizations operating in Chemical Engineering, Biochemistry, Chemometrics, Omics-sciences, Medicinal chemistry, Forensic chemistry, Food chemistry, etc.
    [Show full text]