Case Study: Beyond Homogeneous Decomposition with Qbox Scaling Long-Range Forces on Massively Parallel Systems

Total Page:16

File Type:pdf, Size:1020Kb

Case Study: Beyond Homogeneous Decomposition with Qbox Scaling Long-Range Forces on Massively Parallel Systems Case Study: Beyond Homogeneous Decomposition with Qbox Scaling Long-Range Forces on Massively Parallel Systems Donald Frederick, LLNL – Presented at Supercomputing ‘11 Lawrence Livermore National Laboratory, P. O. Box 808, Livermore, CA 94551! LLNL-PRES-508651 Case Study: Outline • Problem DescripBon • Computaonal Approach • Changes For Scaling LLNL-PRES-508651 Computer simulaons oF materials Computer simulaons are widely used to predict the properBes oF new materials or understand the properes of exisng ones LLNL-PRES-508651 Simulaon oF Materials From First- First-principles methods: Principles Calculate properBes oF a given material directly From Fundamental physics equaons. • No empirical parameters Can make predicons about complex or novel materials, under condi-ons where experimental data is unavailable or inconclusive. • Chemically dynamic As atoms move, chemical bonds can be formed or broken. Electron density surrounding • Computaonally expensive water molecules, calculated Solving quantum equa-ons is -me-consuming, limi-ng From first-principles systems sizes (e.g. hundreds of atoms) and simula-on -mescales (e.g. picoseconds) LLNL-PRES-508651 Quantum Mechanics is Hard ProperBes oF a many-body quantum system are given by Schrödinger's Equaon: 2 ⎡⎤−h 2 vv vv v ⎢⎥∇+V()V()V()ionrr + H + xc rrψεψiii () = () r ⎣⎦2m Exact numerical soluBon has exponenal complexity in the number oF quantum degrees oF Freedom, making a brute Force approach impracBcal (e.g. a system with 10,000 electrons would take 2.69 x 1043 Bmes longer to solve than one with only 100 electrons!) Approximate soluBons are needed: Quantum Monte Carlo stochasBcally sample high-dimensional phase space O(N3) Density Func9onal Theory use approximate Form For exchange and correlaon oF electrons Both methods are O(N3), which is expensive, but tractable LLNL-PRES-508651 Density FuncBonal Theory Density FuncBonal theory: total energy oF system can be wriZen as a FuncBonal oF the electron density occ vv*2⎛⎞11 v vvion v ZZ ER{},{}ψψψρ= 2 drr ()−∇ () rdrrVr+ () () +IJ [ iI] ∑∑∫∫ i⎜⎟ i iJI⎝⎠22≠ RRIJ− v xc 1()vv vρ rʹ ++Edrrdr[]ρρ () ʹ vv 2 ∫∫rr− ʹ many-body effects are approximated by a density FuncBonal exchange-correlaon Solve Kohn-Sham equaons selF-consistently to find the ground state electron density defined by the minimum oF this energy FuncBonal (For a given set oF ion posiBons) The total energy allows one to directly compare different structures and configuraons LLNL-PRES-508651 Stac Calculaons: Total Energy Basic idea: For a given configuraon oF atoms, we find the electronic density which gives the lowest total energy Bonding is determined by electronic structure, no bonding inFormaon is supplied a priori LLNL-PRES-508651 First-Principles Molecular Dynamics (FPMD) For dynamical properBes, both ions and electrons have to move simultaneously and consistently: 1. Solve Schrodinger’s Equaon to find ground state electron density. 2. Compute inter-atomic Forces. 3. Move atoms incrementally Forward in Bme. 4. Repeat. Because step 1 represents the vast majority (>99%) oF the computaonal effort, we want to choose Bme steps that are as large as possible, but small enough so that previous soluBon is close to current one Bme t move atoms Bme t + dt LLNL-PRES-508651 PredicBve simulaons oF melBng SOLID LIQUID T = 800 K T = 900 K t = 1.2 ps t = 0.6 ps t = 2.4 ps t = 1.7 ps freezing melng A two-phase simulaon approach combined with local order analysis allows one to calculate phase behavior such as melBng lines with unprecedented accuracy. LLNL-PRES-508651 High-Z Metals From First-Principles • A detailed theoreBcal understanding oF high-Z Effect of radioactive decay metals is important For stockpile stewardship. • Simulaons may require many atoms to capture anisotropy. Dynamical properBes such as melBng require enough atoms to minimize finite-size effects. Response to shocks • Computaonal cost depends on number oF electrons, not atoms. A melBng simulaon oF a high-Z metal with 10-20 valence electrons/ atom will be 1000-8000 mes as expensive as Evolution of aging damage hydrogen! • The complex electronic structure oF high-Z metals requires large basis sets and mulBple k- points. We need a really big computer! LLNL-PRES-508651 The Plaorm: BlueGene/L System (64 cabinets, 64x32x32) 65,536 nodes Cabinet (131,072 CPUs) (32 Node boards, 8x8x16) Node Board (32 chips, 4x4x2) 512 MB/node 16 Compute Cards Compute Card (2 chips, 2x1x1) 180/360 TF/s 16 TB DDR Chip (2 processors) 2.9/5.7 TF/s 256 GB DDR 90/180 GF/s 367 TFlop/s peak 8 GB DDR perFormance 5.6/11.2 GF/s 2.8/5.6 GF/s 0.5 GB DDR 4 MB Can an FPMD code use 131,072 CPUs efficiently? The Code: Qbox Qbox, wriZen by François Gygi, was designed From the ground up to be massively parallel – C++/MPI – Parallelized over plane waves and electronic states – Parallel linear algebra handled with ScaLAPACK/PBLAS libraries. – Communicaon handled by BLACS library and direct MPI calls. – Single-node dual-core dgemm, zgemm opBmized by John Gunnels, IBM – Uses custom distributed 3D complex Fast Fourier TransForms Implementaon details: – Wave FuncBon described with a plane wave basis – Periodic boundary condiBons – PseudopotenBals are used to represent electrons in atomic core, and thereby reduce the total number oF electrons in the simulaon. LLNL-PRES-508651 Qbox Code Structure Qbox ScaLAPACK/PBLAS XercesC (XML parser) BLAS/MASSV BLACS FFTW lib DGEMM lib MPI LLNL-PRES-508651 Parallel SoluBon oF Kohn-Sham Equaons How to efficiently distribute problem over tens oF thousands oF processors? ⎧− Δϕi +V (ρ,r)ϕi = εiϕi i =1…Nel Kohn-Sham equaons ⎪ – soluBons represent molecular ⎪ ρ(rʹ) V (ρ,r) = V (r) + drʹ +V (ρ(r),∇ρ(r)) orbitals (one per electron) ⎪ ion ∫ r − rʹ XC ⎪ – molecular orbitals are complex ⎨ N 3 el 2 scalar FuncBons in R ⎪ρ(r) = ϕ (r) ⎪ ∑ i – coupled, non-linear PDEs ⎪ i=1 – ⎪ ∗ periodic boundary condiBons ϕ (r)ϕ (r) dr = δ ⎩⎪∫ i j ij We use a plane-wave basis For orbitals: ()r ceiqr⋅ ϕkkq,,nn= ∑ + 2 kq+<Ecut Represent func9on as a Fourier series CareFul distribuBon oF wave FuncBon is key to achieving good parallel efficiency Algorithms used in FPMD • Solving the KS equaons: a constrained opBmizaon problem in ⎧− Δϕi +V (ρ,r)ϕi = εiϕi i =1…Nel ⎪ the space oF coefficients cqn ⎪ ρ(rʹ) V (ρ,r) = V (r) + drʹ +V (ρ(r),∇ρ(r)) • Poisson equaon: 3-D FFTs ⎪ ion ∫ r − rʹ XC ⎪ • Computaon oF the electronic charge: ⎨ N el 2 ⎪ρ(r) = ϕ (r) 3-D FFTs ⎪ ∑ i ⎪ i=1 • Orthogonality constraints require ⎪ ∗ ϕ (r)ϕ (r) dr = δ ⎩⎪∫ i j ij dense, complex linear algebra (e.g. A = CHC) Overall cost is O(N3) for N electrons LLNL-PRES-508651 Qbox communica+on pa9erns The matrix oF coefficients cq,n is block ()r ceiqr⋅ distributed (ScaLAPACK data layout) ϕnn= ∑ q, 2 q <Ecut n electronic states 0 8 16 24 Ncolumns 1 9 17 25 0 8 16 24 2 10 18 26 1 9 17 25 q plane 3 11 19 27 N 2 10 18 26 waves (q rows 3 11 19 27 >> n) 4 12 20 28 4 12 20 28 5 13 21 29 5 13 21 29 6 14 22 30 6 14 22 30 7 15 23 31 7 15 23 31 wave FuncBon matrix c process grid LLNL-PRES-508651 Qbox communica+on pa9erns • Computaon oF 3-D Fourier transForms MPI_Alltoallv LLNL-PRES-508651 Qbox communica+on pa9erns • Accumulaon oF electronic charge density MPI_Allreduce LLNL-PRES-508651 Qbox communica+on pa9erns • ScaLAPACK dense linear algebra operaons PDGEMM/PZGEMM PDSYRK PDTRSM LLNL-PRES-508651 Controlling Numerical Errors • For systems with complex electronic structure like high-Z metals, the desired high accuracy is achievable only through careFul control oF all numerical errors. • Numerical errors which must be controlled: – Convergence of Fourier series ()r ceiqr⋅ ϕnn= ∑ q, 2 q <Ecut – Convergence oF system size (number oF atoms) 2 ρψ()rrk= () d 3 – Convergence oF k-space integraon ∫ k,n BZ • We need to systemacally increase – Plane-wave energy cutoff Let’s start with these – Number oF atoms – Number oF k-points in the Brillouin zone integraon BlueGene/L allows us to ensure convergence of all three approximaons High-Z test problem: Mo1000 • Electronic structure oF a 1000-atom Molybdenum sample • 12,000 electrons • 32 non-local projectors For pseudopotenBals • 112 Ry plane-wave energy cutoff Mo1000 • High-accuracy parameters We wanted a test problem which was representave oF the next generaon oF high-Z materials simulaons while at the same Bme straighlorward For others to replicate and compare perFormance LLNL-PRES-508651 QBox PerFormance 1000 Mo atoms: 8 k-points! 207.3 TFlop/s 112 Ry cutoff (56% of peak)! 4 k-points! 12 electrons/atom 1 k-point (2006 Gordon Bell Award)" Communication Comm. Optimizations Complex Arithmetic related Optimal Node Mapping Dual Core MM 1 k-point! LLNL-PRES-508651 PerFormance measurements •! We use the PPC440 HW perFormance counters •! Access the HW counters using the APC library (J. Sexton, IBM) –!Provides a summary file For each task •! Not all double FPU operaons can be counted –!DFPU Fused mulBply-add: ok –!DFPU add/sub: not counted •! FP operaons on the second core are not counted LLNL-PRES-508651 PerFormance measurements •! Using a single-core DGEMM/ZGEMM library –! Measurements are done in three steps: •! 1) count FP ops without using the DFPU •! 2) measure Bmings using the DFPU •! 3) compute flop rate using 1) and 2) •! Problem: some libraries use the DFPU and are not under our control •! DGEMM/ZGEMM uses mostly Fused mulBply-add ops •! In pracBce, we use 2). Some DFPU add/sub are not counted LLNL-PRES-508651 PerFormance measurements •! Using a dual-core DGEMM/ZGEMM library: –!FP operaons on the second core are not counted –!In this case, we must use a 3 step approach: •! 1) count FP ops using the single-core
Recommended publications
  • Free and Open Source Software for Computational Chemistry Education
    Free and Open Source Software for Computational Chemistry Education Susi Lehtola∗,y and Antti J. Karttunenz yMolecular Sciences Software Institute, Blacksburg, Virginia 24061, United States zDepartment of Chemistry and Materials Science, Aalto University, Espoo, Finland E-mail: [email protected].fi Abstract Long in the making, computational chemistry for the masses [J. Chem. Educ. 1996, 73, 104] is finally here. We point out the existence of a variety of free and open source software (FOSS) packages for computational chemistry that offer a wide range of functionality all the way from approximate semiempirical calculations with tight- binding density functional theory to sophisticated ab initio wave function methods such as coupled-cluster theory, both for molecular and for solid-state systems. By their very definition, FOSS packages allow usage for whatever purpose by anyone, meaning they can also be used in industrial applications without limitation. Also, FOSS software has no limitations to redistribution in source or binary form, allowing their easy distribution and installation by third parties. Many FOSS scientific software packages are available as part of popular Linux distributions, and other package managers such as pip and conda. Combined with the remarkable increase in the power of personal devices—which rival that of the fastest supercomputers in the world of the 1990s—a decentralized model for teaching computational chemistry is now possible, enabling students to perform reasonable modeling on their own computing devices, in the bring your own device 1 (BYOD) scheme. In addition to the programs’ use for various applications, open access to the programs’ source code also enables comprehensive teaching strategies, as actual algorithms’ implementations can be used in teaching.
    [Show full text]
  • Quan Wan, "First Principles Simulations of Vibrational Spectra
    THE UNIVERSITY OF CHICAGO FIRST PRINCIPLES SIMULATIONS OF VIBRATIONAL SPECTRA OF AQUEOUS SYSTEMS A DISSERTATION SUBMITTED TO THE FACULTY OF THE INSTITUTE FOR MOLECULAR ENGINEERING IN CANDIDACY FOR THE DEGREE OF DOCTOR OF PHILOSOPHY BY QUAN WAN CHICAGO, ILLINOIS AUGUST 2015 Copyright c 2015 by Quan Wan All Rights Reserved For Jing TABLE OF CONTENTS LISTOFFIGURES .................................... vii LISTOFTABLES ..................................... xii ACKNOWLEDGMENTS ................................. xiii ABSTRACT ........................................ xiv 1 INTRODUCTION ................................... 1 2 FIRST PRINCIPLES CALCULATIONS OF GROUND STATE PROPERTIES . 5 2.1 Densityfunctionaltheory. 5 2.1.1 TheSchr¨odingerEquation . 5 2.1.2 Density Functional Theory and the Kohn-Sham Ansatz . .. 6 2.1.3 Approximations to the Exchange-Correlation Energy Functional... 9 2.1.4 Planewave Pseudopotential Scheme . 11 2.1.5 First Principles Molecular Dynamics . 12 3 FIRST-PRINCIPLES CALCULATIONS IN THE PRESENCE OF EXTERNAL ELEC- TRICFIELDS ..................................... 14 3.1 Density functional perturbation theory for Homogeneous Electric Field Per- turbations..................................... 14 3.1.1 LinearResponsewithinDFPT. 14 3.1.2 Homogeneous Electric Field Perturbations . 15 3.1.3 ImplementationofDFPTintheQboxCode . 17 3.2 Finite Field Methods for Homogeneous Electric Field . 20 3.2.1 Finite Field Methods . 21 3.2.2 Computational Details of Finite Field Implementations . 25 3.2.3 Results for Single Water Molecules and Liquid Water . 27 3.2.4 Conclusions ................................ 32 4 VIBRATIONAL SIGNATURES OF CHARGE FLUCTUATIONS IN THE HYDRO- GENBONDNETWORKOFLIQUIDWATER . 34 4.1 IntroductiontoVibrationalSpectroscopy . ..... 34 4.1.1 NormalModeandTCFApproaches. 35 4.1.2 InfraredSpectroscopy. .. .. 36 4.1.3 RamanSpectroscopy ........................... 37 4.2 RamanSpectroscopyforLiquidWater . 39 4.3 TheoreticalMethods ............................... 41 4.3.1 Simulation Details . 41 4.3.2 Effective molecular polarizabilities .
    [Show full text]
  • Density Functional Theory
    Density Functional Theory Fundamentals Video V.i Density Functional Theory: New Developments Donald G. Truhlar Department of Chemistry, University of Minnesota Support: AFOSR, NSF, EMSL Why is electronic structure theory important? Most of the information we want to know about chemistry is in the electron density and electronic energy. dipole moment, Born-Oppenheimer charge distribution, approximation 1927 ... potential energy surface molecular geometry barrier heights bond energies spectra How do we calculate the electronic structure? Example: electronic structure of benzene (42 electrons) Erwin Schrödinger 1925 — wave function theory All the information is contained in the wave function, an antisymmetric function of 126 coordinates and 42 electronic spin components. Theoretical Musings! ● Ψ is complicated. ● Difficult to interpret. ● Can we simplify things? 1/2 ● Ψ has strange units: (prob. density) , ● Can we not use a physical observable? ● What particular physical observable is useful? ● Physical observable that allows us to construct the Hamiltonian a priori. How do we calculate the electronic structure? Example: electronic structure of benzene (42 electrons) Erwin Schrödinger 1925 — wave function theory All the information is contained in the wave function, an antisymmetric function of 126 coordinates and 42 electronic spin components. Pierre Hohenberg and Walter Kohn 1964 — density functional theory All the information is contained in the density, a simple function of 3 coordinates. Electronic structure (continued) Erwin Schrödinger
    [Show full text]
  • The Plane-Wave Pseudopotential Method
    The Plane-wave Pseudopotential Method i(G+k) r k(r)= ck,Ge · XG Chris J Pickard Electrons in a Solid Nearly Free Electrons Nearly Free Electrons Nearly Free Electrons Electronic Structures Methods Empirical Pseudopotentials Ab Initio Pseudopotentials Ab Initio Pseudopotentials Ab Initio Pseudopotentials Ab Initio Pseudopotentials Ultrasoft Pseudopotentials (Vanderbilt, 1990) Projector Augmented Waves Deriving the Pseudo Hamiltonian PAW vs PAW C. G. van de Walle and P. E. Bloechl 1993 (I) PAW to calculate all electron properties from PSP calculations" P. E. Bloechl 1994 (II)! The PAW electronic structure method" " The two are linked, but should not be confused References David Vanderbilt, Soft self-consistent pseudopotentials in a generalised eigenvalue formalism, PRB 1990 41 7892" Kari Laasonen et al, Car-Parinello molecular dynamics with Vanderbilt ultrasoft pseudopotentials, PRB 1993 47 10142" P.E. Bloechl, Projector augmented-wave method, PRB 1994 50 17953" G. Kresse and D. Joubert, From ultrasoft pseudopotentials to the projector augmented-wave method, PRB 1999 59 1758 On-the-fly Pseudopotentials - All quantities for PAW (I) reconstruction available" - Allows automatic consistency of the potentials with functionals" - Even fewer input files required" - The code in CASTEP is a cut down (fast) pseudopotential code" - There are internal databases" - Other generation codes (Vanderbilt’s original, OPIUM, LD1) exist It all works! Kohn-Sham Equations Being (Self) Consistent Eigenproblem in a Basis Just a Few Atoms In a Crystal Plane-waves
    [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]
  • “Band Structure” for Electronic Structure Description
    www.fhi-berlin.mpg.de Fundamentals of heterogeneous catalysis The very basics of “band structure” for electronic structure description R. Schlögl www.fhi-berlin.mpg.de 1 Disclaimer www.fhi-berlin.mpg.de • This lecture is a qualitative introduction into the concept of electronic structure descriptions different from “chemical bonds”. • No mathematics, unfortunately not rigorous. • For real understanding read texts on solid state physics. • Hellwege, Marfunin, Ibach+Lüth • The intention is to give an impression about concepts of electronic structure theory of solids. 2 Electronic structure www.fhi-berlin.mpg.de • For chemists well described by Lewis formalism. • “chemical bonds”. • Theorists derive chemical bonding from interaction of atoms with all their electrons. • Quantum chemistry with fundamentally different approaches: – DFT (density functional theory), see introduction in this series – Wavefunction-based (many variants). • All solve the Schrödinger equation. • Arrive at description of energetics and geometry of atomic arrangements; “molecules” or unit cells. 3 Catalysis and energy structure www.fhi-berlin.mpg.de • The surface of a solid is traditionally not described by electronic structure theory: • No periodicity with the bulk: cluster or slab models. • Bulk structure infinite periodically and defect-free. • Surface electronic structure theory independent field of research with similar basics. • Never assume to explain reactivity with bulk electronic structure: accuracy, model assumptions, termination issue. • But: electronic
    [Show full text]
  • Simple Molecular Orbital Theory Chapter 5
    Simple Molecular Orbital Theory Chapter 5 Wednesday, October 7, 2015 Using Symmetry: Molecular Orbitals One approach to understanding the electronic structure of molecules is called Molecular Orbital Theory. • MO theory assumes that the valence electrons of the atoms within a molecule become the valence electrons of the entire molecule. • Molecular orbitals are constructed by taking linear combinations of the valence orbitals of atoms within the molecule. For example, consider H2: 1s + 1s + • Symmetry will allow us to treat more complex molecules by helping us to determine which AOs combine to make MOs LCAO MO Theory MO Math for Diatomic Molecules 1 2 A ------ B Each MO may be written as an LCAO: cc11 2 2 Since the probability density is given by the square of the wavefunction: probability of finding the ditto atom B overlap term, important electron close to atom A between the atoms MO Math for Diatomic Molecules 1 1 S The individual AOs are normalized: 100% probability of finding electron somewhere for each free atom MO Math for Homonuclear Diatomic Molecules For two identical AOs on identical atoms, the electrons are equally shared, so: 22 cc11 2 2 cc12 In other words: cc12 So we have two MOs from the two AOs: c ,1() 1 2 c ,1() 1 2 2 2 After normalization (setting d 1 and _ d 1 ): 1 1 () () [2(1 S )]1/2 12 [2(1 S )]1/2 12 where S is the overlap integral: 01 S LCAO MO Energy Diagram for H2 H2 molecule: two 1s atomic orbitals combine to make one bonding and one antibonding molecular orbital.
    [Show full text]
  • Qbox (Qb@Ll Branch)
    Qbox (qb@ll branch) Summary Version 1.2 Purpose of Benchmark Qbox is a first-principles molecular dynamics code used to compute the properties of materials directly from the underlying physics equations. Density Functional Theory is used to provide a quantum-mechanical description of chemically-active electrons and nonlocal norm-conserving pseudopotentials are used to represent ions and core electrons. The method has O(N3) computational complexity, where N is the total number of valence electrons in the system. Characteristics of Benchmark The computational workload of a Qbox run is split between parallel dense linear algebra, carried out by the ScaLAPACK library, and a custom 3D Fast Fourier Transform. The primary data structure, the electronic wavefunction, is distributed across a 2D MPI process grid. The shape of the process grid is defined by the nrowmax variable set in the Qbox input file, which sets the number of process rows. Parallel performance can vary significantly with process grid shape, although past experience has shown that highly rectangular process grids (e.g. 2048 x 64) give the best performance. The majority of the run time is spent in matrix multiplication, Gram-Schmidt orthogonalization and parallel FFTs. Several ScaLAPACK routines do not scale well beyond 100k+ MPI tasks, so threading can be used to run on more cores. The parallel FFT and a few other loops are threaded in Qbox with OpenMP, but most of the threading speedup comes from the use of threaded linear algebra kernels (blas, lapack, ESSL). Qbox requires a minimum of 1GB of main memory per MPI task. Mechanics of Building Benchmark To compile Qbox: 1.
    [Show full text]
  • Electronic Structure Methods
    Electronic Structure Methods • One-electron models – e.g., Huckel theory • Semiempirical methods – e.g., AM1, PM3, MNDO • Single-reference based ab initio methods •Hartree-Fock • Perturbation theory – MP2, MP3, MP4 • Coupled cluster theory – e.g., CCSD(T) • Multi-configurational based ab initio methods • MCSCF and CASSCF (also GVB) • MR-MP2 and CASPT2 • MR-CI •Ab Initio Methods for IPs, EAs, excitation energies •CI singles (CIS) •TDHF •EOM and Greens function methods •CC2 • Density functional theory (DFT)- Combine functionals for exchange and for correlation • Local density approximation (LDA) •Perdew-Wang 91 (PW91) • Becke-Perdew (BP) •BeckeLYP(BLYP) • Becke3LYP (B3LYP) • Time dependent DFT (TDDFT) (for excited states) • Hybrid methods • QM/MM • Solvation models Why so many methods to solve Hψ = Eψ? Electronic Hamiltonian, BO approximation 1 2 Z A 1 Z AZ B H = − ∑∇i − ∑∑∑+ + (in a.u.) 2 riA iB〈〈j rij A RAB 1/rij is what makes it tough (nonseparable)!! Hartree-Fock method: • Wavefunction antisymmetrized product of orbitals Ψ =|φ11 (τφτ ) ⋅⋅⋅NN ( ) | ← Slater determinant accounts for indistinguishability of electrons In general, τ refers to both spatial and spin coordinates For the 2-electron case 1 Ψ = ϕ (τ )ϕ (τ ) = []ϕ (τ )ϕ (τ ) −ϕ (τ )ϕ (τ ) 1 1 2 2 2 1 1 2 2 2 1 1 2 Energy minimized – variational principle 〈Ψ | H | Ψ〉 Vary orbitals to minimize E, E = 〈Ψ | Ψ〉 keeping orbitals orthogonal hi ϕi = εi ϕi → orbitals and orbital energies 2 φ j (r2 ) 1 2 Z J = dr h = − ∇ − A + (J − K ) i ∑ ∫ 2 i i ∑ i i j ≠ i r12 2 riA ϕϕ()rr () Kϕϕ()rdrr= ji22 () ii121∑∫ j ji≠ r12 Characteristics • Each e- “sees” average charge distribution due to other e-.
    [Show full text]
  • The Electronic Structure of Molecules an Experiment Using Molecular Orbital Theory
    The Electronic Structure of Molecules An Experiment Using Molecular Orbital Theory Adapted from S.F. Sontum, S. Walstrum, and K. Jewett Reading: Olmstead and Williams Sections 10.4-10.5 Purpose: Obtain molecular orbital results for total electronic energies, dipole moments, and bond orders for HCl, H 2, NaH, O2, NO, and O 3. The computationally derived bond orders are correlated with the qualitative molecular orbital diagram and the bond order obtained using the NO bond force constant. Introduction to Spartan/Q-Chem The molecule, above, is an anti-HIV protease inhibitor that was developed at Abbot Laboratories, Inc. Modeling of molecular structures has been instrumental in the design of new drug molecules like these inhibitors. The molecular model kits you used last week are very useful for visualizing chemical structures, but they do not give the quantitative information needed to design and build new molecules. Q-Chem is another "modeling kit" that we use to augment our information about molecules, visualize the molecules, and give us quantitative information about the structure of molecules. Q-Chem calculates the molecular orbitals and energies for molecules. If the calculation is set to "Equilibrium Geometry," Q-Chem will also vary the bond lengths and angles to find the lowest possible energy for your molecule. Q- Chem is a text-only program. A “front-end” program is necessary to set-up the input files for Q-Chem and to visualize the results. We will use the Spartan program as a graphical “front-end” for Q-Chem. In other words Spartan doesn’t do the calculations, but rather acts as a go-between you and the computational package.
    [Show full text]
  • Electronic Structure Calculations and Density Functional Theory
    Electronic Structure Calculations and Density Functional Theory Rodolphe Vuilleumier P^olede chimie th´eorique D´epartement de chimie de l'ENS CNRS { Ecole normale sup´erieure{ UPMC Formation ModPhyChem { Lyon, 09/10/2017 Rodolphe Vuilleumier (ENS { UPMC) Electronic Structure and DFT ModPhyChem 1 / 56 Many applications of electronic structure calculations Geometries and energies, equilibrium constants Reaction mechanisms, reaction rates... Vibrational spectroscopies Properties, NMR spectra,... Excited states Force fields From material science to biology through astrochemistry, organic chemistry... ... Rodolphe Vuilleumier (ENS { UPMC) Electronic Structure and DFT ModPhyChem 2 / 56 Length/,("-%0,11,("2,"3,4)(",3"2,"1'56+,+&" and time scales 0,1 nm 10 nm 1µm 1ps 1ns 1µs 1s Variables noyaux et atomes et molécules macroscopiques Modèles Gros-Grains électrons (champs) ! #$%&'(%')$*+," #-('(%')$*+," #.%&'(%')$*+," !" Rodolphe Vuilleumier (ENS { UPMC) Electronic Structure and DFT ModPhyChem 3 / 56 Potential energy surface for the nuclei c The LibreTexts libraries Rodolphe Vuilleumier (ENS { UPMC) Electronic Structure and DFT ModPhyChem 4 / 56 Born-Oppenheimer approximation Total Hamiltonian of the system atoms+electrons: H^T = T^N + V^NN + H^ MI me approximate system wavefunction: ! ~ ~ ~ ΨS (RI ; ~r1;:::; ~rN ) = Ψ(RI )Ψ0(~r1;:::; ~rN ; RI ) ~ Ψ0(~r1;:::; ~rN ; RI ): the ground state electronic wavefunction of the ~ electronic Hamiltonian H^ at fixed ionic configuration RI n o Energy of the electrons at this ionic configuration: ~ E0(RI ) = Ψ0
    [Show full text]
  • The Atomic and Electronic Structure of Dislocations in Ga Based Nitride Semiconductors Imad Belabbas, Pierre Ruterana, Jun Chen, Gérard Nouet
    The atomic and electronic structure of dislocations in Ga based nitride semiconductors Imad Belabbas, Pierre Ruterana, Jun Chen, Gérard Nouet To cite this version: Imad Belabbas, Pierre Ruterana, Jun Chen, Gérard Nouet. The atomic and electronic structure of dislocations in Ga based nitride semiconductors. Philosophical Magazine, Taylor & Francis, 2006, 86 (15), pp.2245-2273. 10.1080/14786430600651996. hal-00513682 HAL Id: hal-00513682 https://hal.archives-ouvertes.fr/hal-00513682 Submitted on 1 Sep 2010 HAL is a multi-disciplinary open access L’archive ouverte pluridisciplinaire HAL, est archive for the deposit and dissemination of sci- destinée au dépôt et à la diffusion de documents entific research documents, whether they are pub- scientifiques de niveau recherche, publiés ou non, lished or not. The documents may come from émanant des établissements d’enseignement et de teaching and research institutions in France or recherche français ou étrangers, des laboratoires abroad, or from public or private research centers. publics ou privés. Philosophical Magazine & Philosophical Magazine Letters For Peer Review Only The atomic and electronic structure of dislocations in Ga based nitride semiconductors Journal: Philosophical Magazine & Philosophical Magazine Letters Manuscript ID: TPHM-05-Sep-0420.R2 Journal Selection: Philosophical Magazine Date Submitted by the 08-Dec-2005 Author: Complete List of Authors: BELABBAS, Imad; ENSICAEN, SIFCOM Ruterana, Pierre; ENSICAEN, SIFCOM CHEN, Jun; IUT, LRPMN NOUET, Gérard; ENSICAEN, SIFCOM Keywords: GaN, atomic structure, dislocations, electronic structure Keywords (user supplied): http://mc.manuscriptcentral.com/pm-pml Page 1 of 87 Philosophical Magazine & Philosophical Magazine Letters 1 2 3 4 The atomic and electronic structure of dislocations in Ga 5 6 based nitride semiconductors 7 8 9 10 11 12 1,3 1 2 1 13 I.
    [Show full text]