Hard scaling challenges for ab-initio molecular dynamics capabilities in NWChem: Using 100,000 CPUs per second

Size: px
Start display at page:

Download "Hard scaling challenges for ab-initio molecular dynamics capabilities in NWChem: Using 100,000 CPUs per second"

Transcription

1 Hard scaling challenges for ab-initio molecular dynamics capabilities in NWChem: Using 100,000 CPUs per second Eric J. Bylaska, Kevin Glass, and Doug Baxter (PNNL) Scott B. Baden and John H. Weare (UCSD)

2 Outline Ab-Initio Molecular Dynamics Example simulations Plane-wave methods and their cost Performance of Parallel AIMD simulations Distribution of basis Extensions based on 2d processor geometry New algorithms for exact exchange in AIMD Data replication algorithm Incomplete butterfly algorithm 2

3 Ab-initio molecular dynamics For problems beyond classical MD simulations Chemistry in Extreme Environments Computational Biology Systems with unusual chemical bonding Clusters, surfaces and defects Metallic and semiconductor liquids Diffusion of impurities and defects Complex chemical transformations involving changes in electronic structure Band gap of semiconductors in liquid phase Solvation in polar liquids Chemical reactions Critical to computational biology, material science, hydrogen economy, environmental science,. Hydrogen Economy Polymers Environmental Science Material Science

4 Computational geochemistry Trivalent aluminum ions 1 st coordination shell of Al 3+ is an unsolved problem. ph < 3.0, exists almost entirely as the octahedral Al(H 2 O) 6 3+ ion (ph > 7), has a tetrahedral Al(OH) 4 structure. In the biochemically and geochemically critical ph range of 4.3 to 7.0, the structures are less clear. Many species, such as AlOH (aq) 2+, exist and are traditionally assumed to be hexa-coordinate. The kinetics of proton- and water exchange on aqueous Al 3+, coupled with AIMD simulations, support a five-coordinate Al(H 2 O) 4 OH 2+ ion as the predominant form of AlOH (aq) 2+ under ambient conditions. This result contrasts Al 3+ with other trivalent metal aqua ions, for which there is no evidence for stable penta-coordinate hydrolysis products. Thomas W. Swaddle, Jörgen Rosenqvist, Ping Yu, Eric Bylaska, Brian L. Philiips, and William H. Casey (2005) Kinetic evidence for fivecoordination in AlOHaq2+ ion, Science, vol. 308, pages

5 Computational actinide chemistry Uranyl (UO 2 2+ ) ions Experimental and simulated extended x-ray absorption fine structure spectra of UO 2 2+ in water are in perfect agreement. Proper description of dynamics needed Static ab initio misses H 2 O in the apical regions For MD, UO water interaction difficult to parameterize Patrick Nichols, Eric J. Bylaska, G. Schenter, and Wibe A. de Jong (2008), Structured and Unstructured Solvent shells of the UO 2 2+ Ion, Journal of Chemical Physics, vol. 128(12):

6 Conventional versus ab-initio molecular dynamics Conventional molecular dynamics Empirical, usually two-body potentials Difficult to treat reactions Ab-initio molecular dynamics Potential obtained from Schrodinger equation, includes allbody and electronic behavior Empirical potentials parameterized for a small range of PT Equally applicable under all conditions 10 5 particles no problem 600 particles with significant dynamics 10 3 ps no problem 10 s of ps difficult 6

7 Basic features of ab-initio molecular dynamics H i r + ( 1 )V x DFT Equations H i = i i ()= V l ()+ r V ˆ NL + V H []r () []r ()+ V c []r () i r () K ij () r j () r j CP dynamics: Ion and wavefunction motion coupled. Ground state energy μ=0 μ i = H i M I R I = F I N e i=1 ij j H F I = i i R I i=1 Want to do this in ~1second per step N e Plane-wave basis sets, pseudopotentials are used to solve PDE 7

8 Why do we need a second per step? Current ab-initio molecular dynamics simulations for 10 to 100 picoseconds can take several months to complete The step length in ab initio molecular dynamics simulation is on the order of fs/step 20 ps of simulation time 200,000 steps At 1 second per step 2-3 days At 10 seconds per step 23 days At 30 seconds per step 70 days 1 ns of simulation time 10,000,000 steps at 1 second per step 115 days of computing time At 10 seconds per step 3 years At 30 seconds per step 9 years At 0.1 seconds per step 11.5 days

9 Cost of AIMD step Na=500, Ne=500, Ng=256^3 Ne*Ng=8.4e9 Ne*Ng*Log(Ng)=2.0e11 Na*Ne*Ng=4.2e12, Ne*Ne*Ng=4.2e12 Remember we want to do this 100,000+ times For hybrid-dft: A day of computation on the PNNL Chinook system $16K/ 9 Hybrid-DFT: Ne*(Ne+1)*Ng*Log(Ng) = 1.0e14

10 Parallel strategies for plane-wave programs (w/o exact exchange) Ne N g basis N e molecular orbitals Three types of data distributions Distribute molecular orbitals (one eigenvector per cpu) < i j > requires communication Distribute basis(i.e. FFT grid) FFT requires communication proc=1 proc=2 proc=3 proc=... Minimal load balancing slab decomposition

11 Column decomposition Real Real and and k-space representation of of each each wavefunction is is distributed over over all all processors Requires parallel FFT FFT Column decomposition of of each each wavefunction across across parallel processor 11 Processor 1 Processor 5 Processor 2 Processor Processor 6 Processor 3 Processor Processor 1 Processor 7 Processor 4 Processor Processor Processor 8 Processor Processor Processor 1 Processor 5Processor N Processor 2 Processor Processor 6 Processor 3 Processor Processor Processor 7 Processor 4 Processor Processor Processor 8 Processor Processor 1Processor L N e Processor 5Processor N Processor 2 Processor Processor 6 Processor 3 Processor Processor Processor 7 Processor 4 Processor Processor Processor 8 Processor Processor Processor N

12 Parallel timings for UO H 2 O - distributing the basis Bottlenecks Parallel 3d FFT stalls by 100 cpus, (stalls by N g 1/3 ) Non-local pseudopotential stalls by 1000 cpus because of a broadcast across all cpus 12

13 2d processor geometry N orbitals N orbitals N grid =N 1 xn 2 xn 3 N grid =N 1 xn 2 xn 3 Old parallel distribution New parallel distribution (Gygi et al. Supercomputing 06) 13

14 2d processor geometry timings 14

15 Why do we need higher levels of solution to the electronic Schrödinger equation? Localized excess electron calculated at the hybrid DFT level with full surface hydration. The charge is localized at an Fe 3+ Fe 2+ center as a result of exact exchange. DFT often fails for Elements with f and d valence electrons Reaction barriers Localized states Such failures often corrected by including exact exchange DFT & all independent particle methods do not describe long range forces e.g. interaction of water with (soft) surfaces and species Can result in too low of solvent coordination

16 Calculating exact exchange Algorithm 1: Serial algorithm for calculating exact exchange in a planewave basis Input: - N g x N e array Output: K - N g x N e array for m=1,n e for n=1,m (:) FFT_rc( (:,m)*. (:,n))) V(:) FFT_cr(f cutoff (:)*. (:)) K (:,m) -= V(:)*. (:,n); if m<>n K (:,n) -= V(:)*. (:,m) end for end for For Ne= (500+1) = 250,500 three-dimension FFTs per step For Ng=200x200x200 calculation can readily be run on leadership class machines (e.g cores, 4 to each of 9660 processing nodes) 16

17 Simple parallel algorithm for exact exchange Log Npj Multicast N e N e N e N e N e N e to big H big to The algorithm is scalable because: Computation ~Npj^2, Message passing ~Npj Use replicated space to compute exchange using 3d parallel FFTs along columns (load balanced) 17

18 Exact exchange timings 80 atom cell of hematite Exchange term is dominant Previous algorithm simple to implement Requires lots of workspace Sends approximately twice as much data as necessary Basic algorithm works fairly well - stalls at 7 seconds by 4096 cpus Can be improved 18

19 Combinations needed to compute exchange P0 P1 P2 P3 P4 P5 P6 P Data replicated unique pairs 19

20 Combinations needed to compute exchange P0 P1 P2 P3 P4 P5 P6 P N 2 Unique pairs need to be computed Pairs contained in two groups 20

21 Combinations needed to compute exchange P0 P1 P2 P3 P4 P5 P6 P Load balance by transposing the lower corner 21

22 Combinations needed to compute exchange P0 P1 P2 P3 P4 P5 P6 P Share the computations along the diagonal Pairs contained in two groups 22

23 Incomplete butterfly ( ) Only ( Floor (log ) 2 N ) N blocks are propagated in the last butterfly step 23

24 Incomplete butterfly timings 80 (160) atom cell of hematite 24

25 Incomplete butterfly algorithm timings Fitting performance model from 80 atom hematite PERFORMANCE MODEL t exchange = N e ( Ne + 1) t Npj + 4 (1/ 2) + 4 Log 2 N g 1 fft N Npi ( Npj) e Using this formula we find that the maximum number of CPUs that can be gainfully used in the 80 and 160 atom Fe 2 O 3 Hybrid-DFT calculations to be 14,977 CPUs and 48,032 CPUs respectively and we plan to validate these results in the future. 25

26 Conclusions An incomplete butterfly implementation of exact exchange has been implemented that makes judicious use of data replication Overall performances of our AIMD are reasonable Serial and threaded optimization on-going Communications overheads are still and issue we are currently exploring latency hiding techniques via run-time substrates that implement a dataflow execution model (Taragon) Significant progress has been made in terms of accuracy, efficiency, and scalability of AIMD methods in recent years. However the algorithms and implementations of these methods need to be constantly upgraded to capture the performance of emerging computers Acknowledgements ASCR Multiscale Mathematics program, BES Geosciences program, BES Heavy element program, and EMSL of the U.S. Department of Energy, Office of Science ~ DE- AC06-76RLO EMSL operations are supported by the DOE's Office of Biological and Environmental Research. We wish to thank the Scientific Computing Staff, Office of Energy Research, and the U. S. Department of Energy for a grant of computer time at the National Energy Research Scientific Computing Center (Berkeley, CA). Some of the calculations were performed on the Chinook computing systems at the Molecular Science Computing Facility in the William R. Wiley Environmental Molecular Sciences Laboratory (EMSL) at PNNL. 26

27 Why Wannier? In general, a complete set of Bloch orbitals (complete sampling of the Brillouin zone) is needed to evaluate the complete set of Wannier orbitals. However, for non-metallic systems with sufficiently large unit cells, it turns out that one can obtain at least one of the complete sets of Wannier orbitals contained in the manifold of the sets of Wannier orbitals from having only the -point Bloch functions, of all the occupied bands. The strategy for doing this is quite simple. The trick is to apply a Marzari-Vanderbilt localization unitary transformation (which is the counterpart of the Foster-Boys transformation for finite systems) over n to produce a new set of -point Bloch functions to. These new orbitals, which are maximally localized, are extremely localized within each cell for non-metallic systems with a sufficiently large unit cells. If this is the case, then can be represented as a sum of piece-wise localized functions by Since this is just the defn of Wannier with k=0, complete set of Wannier orbitals contained in the manifold of the sets of Wannier functions is formed. With this new set of localized orbitals the exchange term per unit cell can be written as 27

28 Calculating E Exch with Wannier Functions Wannier functions constructed from single -point Kohn- Sham Bloch states, have infinitely many artificial periodic replicas. To use the plane-wave method to calculate E Exch, one has to limit integration to a single unit cell. N N * Exch nm() mn( ) n m ( ) E = drdr A r A r f r r To handle extended systems, we replace the Coulomb interaction by a screened Coulomb interaction: f () r N N ( 1 exp{ ( r / R) }) 1 = r This kernel is nearly equal to 1/r for r<r and rapidly decays to 0 for r>r. 28

29 Ab Initio Molecular Dynamics For Problems Beyond Classical MD Simulations Systems with unusual chemical bonding Clusters, surfaces and defects Metallic and semiconductor liquids Diffusion of impurities and defects Phenomena involving changes in electronic structure Band gap of semiconductors in liquid phase Solvation in polar liquids Chemical reactions 29

30 Incomplete Butterfly ( ) Only ( Floor (log ) 2 N ) N blocks are propagated in the last butterfly step 30

31 Parallel Strategy: One dimensional slab decomposition for N e orbitals Processor N Processor N Processor N Processor N Processor Processor Processor Processor Processor 2 Processor 2 Processor 2 Processor 2 Processor 1 Processor 1 Processor 1 Processor L Ne Real Real and and k-space representation of of each each wavefunction is is distributed over over all all processors Requires parallel FFT FFT Parallel scaling restricted to to number of of points along a single dimension 31

32 Conventional Versus ab-initio Molecular Dynamics Needs for geochemical/materials applications Accurately capture many-body interactions, reactions, polarization Extrapolates to difficult PT conditions Treat sufficient number of particles to capture chemistry. Thermodynamics? Conventional molecular dynamics Empirical usually twobody potentials, reactions difficult to treat Empirical potentials parameterized for a small range of PT 10 5 particles no problem 1 st principles molecular dynamics Potential from Schrödinger eq. All - body and electronic behavior included Equally applicable to all conditions 600 particles with significant dynamics Treat long time scales 10 3 ps no problem 10s of ps difficult

33 10 ps AIMD simulation of UO H 2 O (UO H 2 O 22ps) Average UO H 2 O (64 H 2 O) AIMD Exp. r U-O 1.77 (1.77) U-O 0.06 (0.06) 0.04 < OUO (174.1) < HOH 3.2 (3.2) r U-OI 2.46 (2.44) U-OI 0.11 (0.10) st shell tilt 32.5 (32.9) --- #H 2 O 1st 5 (5) r U-OII 4.59 (4.59) U-OII 0.11 (0.12) r OI-OII 2.74 (2.72) < OI-H-OII (163.5) # 2 2 nd 16.2 (14.8) 14 *Conventional molecular dynamics (2 and 33 3-body potential) lead to incorrect results.

34 New Capabilities Developed AIMD/MM internal MD potential MM potential is fairly general also interfaced to NWMD (CHARM, ) Useful for equilibration, but recent results shown it can model solvated cations very well. Tera Petascale Parallelization parallel decomposition which the orbitals are distributed in a 2d processor grid. this decomposition only requires (O(log(p 1 )+O(log(p 2 )) communications per processor (where the total number of processors, P, can be written as P=p 1 p 2 ). uses of parallel matrix libraries, and MPI communicators. New algorithm developed for Exact-Exchange (MP2)

35 Molecular Dynamics Loop (1) Compute Forces on atoms, F I (t) for current atomic configuration, R I (t) F I (t) calculate using classical potentials (can do large systems and long simulation times) calculate directly from first principles by solving many-electron Schrödinger equations (can treat very complex chemistry, but simulations times are very long) (2) Update atom positions using Newtons laws R I (t+ t) 2*R I (t) R I (t- t) + t 2 /(M I )*F I (t) 35

36 Geochemistry 5 coordinated AlOH AIMD simulations of first hydrolysis species of Al 3+ (aq) performed for Casey et al. AlOH(H 2 O) 2+ 5 AlOH(H 2 O) 2+ 4 MD and ab initio cluster models with COSMO fail to predict 5-fold species! Thomas W. Swaddle, Jörgen Rosenqvist, Ping Yu, Eric Bylaska, Brian L. Philiips, and William H. Casey (2005) Kinetic evidence for five-coordination in AlOHaq2+ ion, Science, vol. 308, pages

37 10 ps AIMD simulation of UO H 2 O (UO H 2 O 22ps) Average UO H 2 O (64 H 2 O) AIMD Exp. r U-O 1.77 (1.77) U-O 0.06 (0.06) 0.04 < OUO (174.1) < HOH 3.2 (3.2) r U-OI 2.46 (2.44) U-OI 0.11 (0.10) st shell tilt 32.5 (32.9) --- #H 2 O 1st 5 (5) r U-OII 4.59 (4.59) U-OII 0.11 (0.12) r OI-OII 2.74 (2.72) < OI-H-OII (163.5) # 2 2 nd 16.2 (14.8) 14 37

38 38 Simple Parallel Algorithm for Exact Exchange Algorithm 2: Parallel algorithm for calculating exact exchange in a plane-wave basis using a two-dimensional processor grid Input: - (N g /Npi) x (N e /Npj) array Output: K -(N g /Npi) x (N e /Npj) array Work Space: (N g /Npi) x N e array K (N g /Npi) x N e array N e = total number of orbitals Np = total number of processors, where Np=Npi*Npj Npi/ Npj = size of column (row) processor group taskid_i/j = rank along the column (row) processor group (:,:), (:,:) = 0 s=taskid_j*(n e /Npj); e = s+(n e /Npj); (:,s:e) = Row_Reduction( ) counter = 0 for m=1,n e for n=1,m if counter==taskid_j then (:) Column_FFT_rc( ( (:,m) *. (:,n)) ) V(:) Column_FFT_cr( (f screened (:) *. (:)) ) K (:,m ) -=V(:)*. (:,n) if m!= n then K (:,n) -=V(:)*. (:,m) end if end if counter = mod(counter + 1,Npj) end for end for Row_Reduce(K ) K =H (:,s:e)

39 Parallel FFT for Column Decomposed Data Need to reduce communication costs Parallel 2D data mapping dimension 2 Dimension 2 Dimension 3 dimension 3 i 39

40 Uranyl EXAFS The EXAFS spectra for the UO H 2 O and UO H 2 O simulations were simulated using MD-EXAFS procedure of Palmer et al.. As input to this procedure an ensemble of UO 2+ 2 (H 2 O) n clusters were generated from every 60 fs of the AIMD simulation in which the 100 nearest atoms to the uranium atom were extracted subject to periodic boundary conditions. Each cluster of the ensemble was then used as input into the FEFF electron multiple scattering code to generate the EXAFS fine structure factor and its windowed transform, i.e. 1 () R = k () k W() k e i kr dk Analysis performed by G. Schenter

Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT

Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT Self-Consistent Implementation of Self-Interaction Corrected DFT and of the Exact Exchange Functionals in Plane-Wave DFT Kiril Tsemekhman (a), Eric Bylaska (b), Hannes Jonsson (a,c) (a) Department of Chemistry,

More information

Car-Parrinello Molecular Dynamics

Car-Parrinello Molecular Dynamics Car-Parrinello Molecular Dynamics Eric J. Bylaska HPCC Group Moral: A man dreams of a miracle and wakes up with loaves of bread Erich Maria Remarque Molecular Dynamics Loop (1) Compute Forces on atoms,

More information

Basic introduction of NWChem software

Basic introduction of NWChem software Basic introduction of NWChem software Background NWChem is part of the Molecular Science Software Suite Designed and developed to be a highly efficient and portable Massively Parallel computational chemistry

More information

Supporting Information for. Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite. Edge Water Interface

Supporting Information for. Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite. Edge Water Interface Supporting Information for Ab Initio Metadynamics Study of VO + 2 /VO2+ Redox Reaction Mechanism at the Graphite Edge Water Interface Zhen Jiang, Konstantin Klyukin, and Vitaly Alexandrov,, Department

More information

Parallel programming using MPI. Analysis and optimization. Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco

Parallel programming using MPI. Analysis and optimization. Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco Parallel programming using MPI Analysis and optimization Bhupender Thakur, Jim Lupo, Le Yan, Alex Pacheco Outline l Parallel programming: Basic definitions l Choosing right algorithms: Optimal serial and

More information

Integrating CML, FoX, Avogadro, NWChem, and EMSLHub to develop a computational chemistry knowledge and discovery base

Integrating CML, FoX, Avogadro, NWChem, and EMSLHub to develop a computational chemistry knowledge and discovery base Integrating CML, FoX, Avogadro, NWChem, and EMSLHub to develop a computational chemistry knowledge and discovery base Wibe A. de Jong, David M. Brown, Andrew Walker, Marcus D. Hanwell Data is key to scientific

More information

Basic introduction of NWChem software

Basic introduction of NWChem software Basic introduction of NWChem software Background! NWChem is part of the Molecular Science Software Suite! Designed and developed to be a highly efficient and portable Massively Parallel computational chemistry

More information

ab initio Electronic Structure Calculations

ab initio Electronic Structure Calculations ab initio Electronic Structure Calculations New scalability frontiers using the BG/L Supercomputer C. Bekas, A. Curioni and W. Andreoni IBM, Zurich Research Laboratory Rueschlikon 8803, Switzerland ab

More information

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set Chapter 3 The (L)APW+lo Method 3.1 Choosing A Basis Set The Kohn-Sham equations (Eq. (2.17)) provide a formulation of how to practically find a solution to the Hohenberg-Kohn functional (Eq. (2.15)). Nevertheless

More information

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers

Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Efficient Parallelization of Molecular Dynamics Simulations on Hybrid CPU/GPU Supercoputers Jaewoon Jung (RIKEN, RIKEN AICS) Yuji Sugita (RIKEN, RIKEN AICS, RIKEN QBiC, RIKEN ithes) Molecular Dynamics

More information

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch Electronic Structure Theory for Periodic Systems: The Concepts Christian Ratsch Institute for Pure and Applied Mathematics and Department of Mathematics, UCLA Motivation There are 10 20 atoms in 1 mm 3

More information

Molecular Dynamics Simulation Study of the Ionic Mobility of OH Using the OSS2 Model

Molecular Dynamics Simulation Study of the Ionic Mobility of OH Using the OSS2 Model 1154 Bull. Korean Chem. Soc. 2006, Vol. 27, No. 8 Song Hi Lee Molecular Dynamics Simulation Study of the Ionic Mobility of OH Using the OSS2 Model Song Hi Lee Department of Chemistry, Kyungsung University,

More information

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations

Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations September 18, 2012 Extending Parallel Scalability of LAMMPS and Multiscale Reactive Molecular Simulations Yuxing Peng, Chris Knight, Philip Blood, Lonnie Crosby, and Gregory A. Voth Outline Proton Solvation

More information

Institute for Functional Imaging of Materials (IFIM)

Institute for Functional Imaging of Materials (IFIM) Institute for Functional Imaging of Materials (IFIM) Sergei V. Kalinin Guiding the design of materials tailored for functionality Dynamic matter: information dimension Static matter Functional matter Imaging

More information

STRUCTURAL AND MECHANICAL PROPERTIES OF AMORPHOUS SILICON: AB-INITIO AND CLASSICAL MOLECULAR DYNAMICS STUDY

STRUCTURAL AND MECHANICAL PROPERTIES OF AMORPHOUS SILICON: AB-INITIO AND CLASSICAL MOLECULAR DYNAMICS STUDY STRUCTURAL AND MECHANICAL PROPERTIES OF AMORPHOUS SILICON: AB-INITIO AND CLASSICAL MOLECULAR DYNAMICS STUDY S. Hara, T. Kumagai, S. Izumi and S. Sakai Department of mechanical engineering, University of

More information

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3

Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun Fu 1, Xuebin Chi 1, Weiguo Gao 2, Lin-Wang Wang 3 A plane wave pseudopotential density functional theory molecular dynamics code on multi-gpu machine - GPU Technology Conference, San Jose, May 17th, 2012 Weile Jia 1, Long Wang 1, Zongyan Cao 1, Jiyun

More information

Parallelization and benchmarks

Parallelization and benchmarks Parallelization and benchmarks Content! Scalable implementation of the DFT/LCAO module! Plane wave DFT code! Parallel performance of the spin-free CC codes! Scalability of the Tensor Contraction Engine

More information

Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that. Keith Refson STFC Rutherford Appleton Laboratory

Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that. Keith Refson STFC Rutherford Appleton Laboratory Electronic band structure, sx-lda, Hybrid DFT, LDA+U and all that Keith Refson STFC Rutherford Appleton Laboratory LDA/GGA DFT is good but... Naive LDA/GGA calculation severely underestimates band-gaps.

More information

Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC

Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC Structure of Cement Phases from ab initio Modeling Crystalline C-S-HC Sergey V. Churakov sergey.churakov@psi.ch Paul Scherrer Institute Switzerland Cement Phase Composition C-S-H H Solid Solution Model

More information

Intro to ab initio methods

Intro to ab initio methods Lecture 2 Part A Intro to ab initio methods Recommended reading: Leach, Chapters 2 & 3 for QM methods For more QM methods: Essentials of Computational Chemistry by C.J. Cramer, Wiley (2002) 1 ab initio

More information

Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory.

Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory. Walter Kohn was awarded with the Nobel Prize in Chemistry in 1998 for his development of the density functional theory. Walter Kohn receiving his Nobel Prize from His Majesty the King at the Stockholm

More information

Large Scale Electronic Structure Calculations

Large Scale Electronic Structure Calculations Large Scale Electronic Structure Calculations Jürg Hutter University of Zurich 8. September, 2008 / Speedup08 CP2K Program System GNU General Public License Community Developers Platform on "Berlios" (cp2k.berlios.de)

More information

Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić

Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić Introduction to Density Functional Theory with Applications to Graphene Branislav K. Nikolić Department of Physics and Astronomy, University of Delaware, Newark, DE 19716, U.S.A. http://wiki.physics.udel.edu/phys824

More information

Ab initio molecular dynamics

Ab initio molecular dynamics Ab initio molecular dynamics Kari Laasonen, Physical Chemistry, Aalto University, Espoo, Finland (Atte Sillanpää, Jaakko Saukkoriipi, Giorgio Lanzani, University of Oulu) Computational chemistry is a field

More information

Part II. Fundamentals of X-ray Absorption Fine Structure: data analysis

Part II. Fundamentals of X-ray Absorption Fine Structure: data analysis Part II Fundamentals of X-ray Absorption Fine Structure: data analysis Sakura Pascarelli European Synchrotron Radiation Facility, Grenoble, France Page 1 S. Pascarelli HERCULES 2016 Data Analysis: EXAFS

More information

All-electron density functional theory on Intel MIC: Elk

All-electron density functional theory on Intel MIC: Elk All-electron density functional theory on Intel MIC: Elk W. Scott Thornton, R.J. Harrison Abstract We present the results of the porting of the full potential linear augmented plane-wave solver, Elk [1],

More information

Molecular and Electronic Dynamics Using the OpenAtom Software

Molecular and Electronic Dynamics Using the OpenAtom Software Molecular and Electronic Dynamics Using the OpenAtom Software Sohrab Ismail-Beigi (Yale Applied Physics) Subhasish Mandal (Yale), Minjung Kim (Yale), Raghavendra Kanakagiri (UIUC), Kavitha Chandrasekar

More information

Molecular Mechanisms and Selectivity of Cs Binding to Clay Minerals

Molecular Mechanisms and Selectivity of Cs Binding to Clay Minerals JAEA Cesium Workshop: Fukushima Recovery Molecular Mechanisms and Selectivity of Cs Binding to Clay Minerals Kevin M. Rosso Pacific Northwest National Laboratory, Washington, USA September 30, 2013 Science

More information

CRYSTAL in parallel: replicated and distributed (MPP) data. Why parallel?

CRYSTAL in parallel: replicated and distributed (MPP) data. Why parallel? CRYSTAL in parallel: replicated and distributed (MPP) data Roberto Orlando Dipartimento di Chimica Università di Torino Via Pietro Giuria 5, 10125 Torino (Italy) roberto.orlando@unito.it 1 Why parallel?

More information

Speeding up path integral simulations

Speeding up path integral simulations Speeding up path integral simulations Thomas Markland and David Manolopoulos Department of Chemistry University of Oxford Funded by the US Office of Naval Research and the UK EPSRC Outline 1. Ring polymer

More information

CP2K. New Frontiers. ab initio Molecular Dynamics

CP2K. New Frontiers. ab initio Molecular Dynamics CP2K New Frontiers in ab initio Molecular Dynamics Jürg Hutter, Joost VandeVondele, Valery Weber Physical-Chemistry Institute, University of Zurich Ab Initio Molecular Dynamics Molecular Dynamics Sampling

More information

Bonding and Dynamics. Outline Bonding and Dynamics Water Interactions Self Ionization of Water Homework

Bonding and Dynamics. Outline Bonding and Dynamics Water Interactions Self Ionization of Water Homework Liquid Water Structure In liquid water, most of the water molecules have the same local environment as in ice but the long range structure of ice disappears due to motion of the molecules. Bonds between

More information

Periodic Relationships

Periodic Relationships Periodic Relationships 1 Tabulation of Elements Mendeleev (1869) Arranged by mass Tabulation by chem.& physical properties Predicted missing elements and properties 2 Modern Periodic Table Argon vs. potassium

More information

New Perspective on structure and bonding in water using XAS and XRS

New Perspective on structure and bonding in water using XAS and XRS New Perspective on structure and bonding in water using XAS and XRS Anders Nilsson Stanford Synchrotron Radiation Laboratory (SSRL) and Stockholm University, Sweden R. Ludwig Angew. Chem. 40, 1808 (2001)

More information

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005

Multi-reference Density Functional Theory. COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Multi-reference Density Functional Theory COLUMBUS Workshop Argonne National Laboratory 15 August 2005 Capt Eric V. Beck Air Force Institute of Technology Department of Engineering Physics 2950 Hobson

More information

Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together.

Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together. Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together. For example Nacl In the Nacl lattice, each Na atom is

More information

Linking electronic and molecular structure: Insight into aqueous chloride solvation. Supplementary Information

Linking electronic and molecular structure: Insight into aqueous chloride solvation. Supplementary Information Linking electronic and molecular structure: Insight into aqueous chloride solvation Ling Ge, Leonardo Bernasconi, and Patricia Hunt Department of Chemistry, Imperial College London, London SW7 2AZ, United

More information

CHEM6085: Density Functional Theory

CHEM6085: Density Functional Theory Lecture 11 CHEM6085: Density Functional Theory DFT for periodic crystalline solids C.-K. Skylaris 1 Electron in a one-dimensional periodic box (in atomic units) Schrödinger equation Energy eigenvalues

More information

Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University

Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University Ab-initio molecular dynamics: from the basics up to quantum effects Roberto Car Princeton University Hands-on Tutorial Workshop on Ab-Initio Molecular Simulations, Fritz- Haber-Institut, Berlin, July 12-21,

More information

University of Denmark, Bldg. 307, DK-2800 Lyngby, Denmark, has been developed at CAMP based on message passing, currently

University of Denmark, Bldg. 307, DK-2800 Lyngby, Denmark, has been developed at CAMP based on message passing, currently Parallel ab-initio molecular dynamics? B. Hammer 1, and Ole H. Nielsen 1 2 1 Center for Atomic-scale Materials Physics (CAMP), Physics Dept., Technical University of Denmark, Bldg. 307, DK-2800 Lyngby,

More information

Charge equilibration

Charge equilibration Charge equilibration Taylor expansion of energy of atom A @E E A (Q) =E A0 + Q A + 1 @Q A 0 2 Q2 A @ 2 E @Q 2 A 0 +... The corresponding energy of cation/anion and neutral atom E A (+1) = E A0 + @E @Q

More information

Computer simulation methods (2) Dr. Vania Calandrini

Computer simulation methods (2) Dr. Vania Calandrini Computer simulation methods (2) Dr. Vania Calandrini in the previous lecture: time average versus ensemble average MC versus MD simulations equipartition theorem (=> computing T) virial theorem (=> computing

More information

Potentials, periodicity

Potentials, periodicity Potentials, periodicity Lecture 2 1/23/18 1 Survey responses 2 Topic requests DFT (10), Molecular dynamics (7), Monte Carlo (5) Machine Learning (4), High-throughput, Databases (4) NEB, phonons, Non-equilibrium

More information

Practical Guide to Density Functional Theory (DFT)

Practical Guide to Density Functional Theory (DFT) Practical Guide to Density Functional Theory (DFT) Brad Malone, Sadas Shankar Quick recap of where we left off last time BD Malone, S Shankar Therefore there is a direct one-to-one correspondence between

More information

Modeling Biomolecular Systems II. BME 540 David Sept

Modeling Biomolecular Systems II. BME 540 David Sept Modeling Biomolecular Systems II BME 540 David Sept Introduction Why do we perform simulations? What makes simulations possible? How do we perform simulations? What types of things/systems do we simulate?

More information

Chapter 7. Generally, the electronic structure of atoms correlates w. the prop. of the elements

Chapter 7. Generally, the electronic structure of atoms correlates w. the prop. of the elements Chapter 7 Periodic Properties of the Elements I) Development of the P.T. Generally, the electronic structure of atoms correlates w. the prop. of the elements - reflected by the arrangement of the elements

More information

Computational Methods. Chem 561

Computational Methods. Chem 561 Computational Methods Chem 561 Lecture Outline 1. Ab initio methods a) HF SCF b) Post-HF methods 2. Density Functional Theory 3. Semiempirical methods 4. Molecular Mechanics Computational Chemistry " Computational

More information

Electrons in a periodic potential

Electrons in a periodic potential Chapter 3 Electrons in a periodic potential 3.1 Bloch s theorem. We consider in this chapter electrons under the influence of a static, periodic potential V (x), i.e. such that it fulfills V (x) = V (x

More information

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation Electrochemistry project, Chemistry Department, November 2006 Ab-initio Molecular Dynamics Simulation Outline Introduction Ab-initio concepts Total energy concepts Adsorption energy calculation Project

More information

Supplementary Information

Supplementary Information Supplementary Information Supplementary Figure 1. X-ray diffraction patterns of (a) pure LDH, (b) AuCl 4 ion-exchanged LDH and (c) the Au/LDH hybrid catalyst. The refined cell parameters for pure, ion-exchanged,

More information

Electron Correlation

Electron Correlation Electron Correlation Levels of QM Theory HΨ=EΨ Born-Oppenheimer approximation Nuclear equation: H n Ψ n =E n Ψ n Electronic equation: H e Ψ e =E e Ψ e Single determinant SCF Semi-empirical methods Correlation

More information

COSMO-RS Theory. The Basics

COSMO-RS Theory. The Basics Theory The Basics From µ to properties Property µ 1 µ 2 activity coefficient vapor pressure Infinite dilution Gas phase Pure compound Pure bulk compound Partition coefficient Phase 1 Phase 2 Liquid-liquid

More information

The Plane-Wave Pseudopotential Method

The Plane-Wave Pseudopotential Method Hands-on Workshop on Density Functional Theory and Beyond: Computational Materials Science for Real Materials Trieste, August 6-15, 2013 The Plane-Wave Pseudopotential Method Ralph Gebauer ICTP, Trieste

More information

First principle calculations of plutonium and plutonium compounds: part 1

First principle calculations of plutonium and plutonium compounds: part 1 First principle calculations of plutonium and plutonium compounds: part 1 A. B. Shick Institute of Physics ASCR, Prague, CZ Outline: u Lecture 1: Methods of Correlated band theory DFT and DFT+U u Lecture

More information

A Computation- and Communication-Optimal Parallel Direct 3-body Algorithm

A Computation- and Communication-Optimal Parallel Direct 3-body Algorithm A Computation- and Communication-Optimal Parallel Direct 3-body Algorithm Penporn Koanantakool and Katherine Yelick {penpornk, yelick}@cs.berkeley.edu Computer Science Division, University of California,

More information

The Solid State. Phase diagrams Crystals and symmetry Unit cells and packing Types of solid

The Solid State. Phase diagrams Crystals and symmetry Unit cells and packing Types of solid The Solid State Phase diagrams Crystals and symmetry Unit cells and packing Types of solid Learning objectives Apply phase diagrams to prediction of phase behaviour Describe distinguishing features of

More information

Carlo Cavazzoni, HPC department, CINECA

Carlo Cavazzoni, HPC department, CINECA Large Scale Parallelism Carlo Cavazzoni, HPC department, CINECA Parallel Architectures Two basic architectural scheme: Distributed Memory Shared Memory Now most computers have a mixed architecture + accelerators

More information

Periodic Relationships

Periodic Relationships Periodic Relationships 1 Tabulation of Elements Mendeleev (1869) Arranged by mass Tabulation by chem.& physical properties Predicted missing elements and properties 2 Modern Periodic Table Argon vs. potassium

More information

Fernando O. Raineri. Office Hours: MWF 9:30-10:30 AM Room 519 Tue. 3:00-5:00 CLC (lobby).

Fernando O. Raineri. Office Hours: MWF 9:30-10:30 AM Room 519 Tue. 3:00-5:00 CLC (lobby). Fernando O. Raineri Office Hours: MWF 9:30-10:30 AM Room 519 Tue. 3:00-5:00 CLC (lobby). P1) What is the reduction potential of the hydrogen electrode g bar H O aq Pt(s) H,1 2 3 when the aqueous solution

More information

Schrodinger equation

Schrodinger equation CH1. Atomic Structure orbitals periodicity 1 Schrodinger equation - (h 2 /2p 2 m e2 ) [d 2 Y/dx 2 +d 2 Y/dy 2 +d 2 Y/dz 2 ] + V Y = E Y h = constant m e = electron mass V = potential E gives quantized

More information

Teoría del Funcional de la Densidad (Density Functional Theory)

Teoría del Funcional de la Densidad (Density Functional Theory) Teoría del Funcional de la Densidad (Density Functional Theory) Motivation: limitations of the standard approach based on the wave function. The electronic density n(r) as the key variable: Functionals

More information

Photon Interaction. Spectroscopy

Photon Interaction. Spectroscopy Photon Interaction Incident photon interacts with electrons Core and Valence Cross Sections Photon is Adsorbed Elastic Scattered Inelastic Scattered Electron is Emitted Excitated Dexcitated Stöhr, NEXAPS

More information

OVERVIEW OF QUANTUM CHEMISTRY METHODS

OVERVIEW OF QUANTUM CHEMISTRY METHODS OVERVIEW OF QUANTUM CHEMISTRY METHODS Outline I Generalities Correlation, basis sets Spin II Wavefunction methods Hartree-Fock Configuration interaction Coupled cluster Perturbative methods III Density

More information

The Fast Multipole Method in molecular dynamics

The Fast Multipole Method in molecular dynamics The Fast Multipole Method in molecular dynamics Berk Hess KTH Royal Institute of Technology, Stockholm, Sweden ADAC6 workshop Zurich, 20-06-2018 Slide BioExcel Slide Molecular Dynamics of biomolecules

More information

Electron Configurations and the Periodic Table

Electron Configurations and the Periodic Table Electron Configurations and the Periodic Table The periodic table can be used as a guide for electron configurations. The period number is the value of n. Groups 1A and 2A have the s-orbital filled. Groups

More information

Supplementary Figure 1 Two-dimensional map of the spin-orbit coupling correction to the scalar-relativistic DFT/LDA band gap. The calculations were

Supplementary Figure 1 Two-dimensional map of the spin-orbit coupling correction to the scalar-relativistic DFT/LDA band gap. The calculations were Supplementary Figure 1 Two-dimensional map of the spin-orbit coupling correction to the scalar-relativistic DFT/LDA band gap. The calculations were performed for the Platonic model of PbI 3 -based perovskites

More information

Introduction to DFTB. Marcus Elstner. July 28, 2006

Introduction to DFTB. Marcus Elstner. July 28, 2006 Introduction to DFTB Marcus Elstner July 28, 2006 I. Non-selfconsistent solution of the KS equations DFT can treat up to 100 atoms in routine applications, sometimes even more and about several ps in MD

More information

Cyclops Tensor Framework

Cyclops Tensor Framework Cyclops Tensor Framework Edgar Solomonik Department of EECS, Computer Science Division, UC Berkeley March 17, 2014 1 / 29 Edgar Solomonik Cyclops Tensor Framework 1/ 29 Definition of a tensor A rank r

More information

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions

Exercise 2: Solvating the Structure Before you continue, follow these steps: Setting up Periodic Boundary Conditions Exercise 2: Solvating the Structure HyperChem lets you place a molecular system in a periodic box of water molecules to simulate behavior in aqueous solution, as in a biological system. In this exercise,

More information

Explanation of Dramatic ph-dependence of Hydrogen Binding on Noble Metal Electrode: Greatly Weakened Water Adsorption at High ph.

Explanation of Dramatic ph-dependence of Hydrogen Binding on Noble Metal Electrode: Greatly Weakened Water Adsorption at High ph. Supplementary Materials Explanation of Dramatic ph-dependence of Hydrogen Binding on Noble Metal Electrode: Greatly Weakened Water Adsorption at High ph. Tao Cheng,, Lu Wang, Boris V Merinov, and William

More information

Massive Parallelization of First Principles Molecular Dynamics Code

Massive Parallelization of First Principles Molecular Dynamics Code Massive Parallelization of First Principles Molecular Dynamics Code V Hidemi Komatsu V Takahiro Yamasaki V Shin-ichi Ichikawa (Manuscript received April 16, 2008) PHASE is a first principles molecular

More information

Atomic Structure & Interatomic Bonding

Atomic Structure & Interatomic Bonding Atomic Structure & Interatomic Bonding Chapter Outline Review of Atomic Structure Atomic Bonding Atomic Structure Atoms are the smallest structural units of all solids, liquids & gases. Atom: The smallest

More information

1. Hydrogen atom in a box

1. Hydrogen atom in a box 1. Hydrogen atom in a box Recall H atom problem, V(r) = -1/r e r exact answer solved by expanding in Gaussian basis set, had to solve secular matrix involving matrix elements of basis functions place atom

More information

A Quantum Chemistry Domain-Specific Language for Heterogeneous Clusters

A Quantum Chemistry Domain-Specific Language for Heterogeneous Clusters A Quantum Chemistry Domain-Specific Language for Heterogeneous Clusters ANTONINO TUMEO, ORESTE VILLA Collaborators: Karol Kowalski, Sriram Krishnamoorthy, Wenjing Ma, Simone Secchi May 15, 2012 1 Outline!

More information

Petascale Quantum Simulations of Nano Systems and Biomolecules

Petascale Quantum Simulations of Nano Systems and Biomolecules Petascale Quantum Simulations of Nano Systems and Biomolecules Emil Briggs North Carolina State University 1. Outline of real-space Multigrid (RMG) 2. Scalability and hybrid/threaded models 3. GPU acceleration

More information

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM

PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM Proceedings of ALGORITMY 25 pp. 22 211 PRECONDITIONING IN THE PARALLEL BLOCK-JACOBI SVD ALGORITHM GABRIEL OKŠA AND MARIÁN VAJTERŠIC Abstract. One way, how to speed up the computation of the singular value

More information

Non-bonded interactions

Non-bonded interactions speeding up the number-crunching continued Marcus Elstner and Tomáš Kubař December 3, 2013 why care? number of individual pair-wise interactions bonded interactions proportional to N: O(N) non-bonded interactions

More information

Chapter 4: Bonding in Solids and Electronic Properties. Free electron theory

Chapter 4: Bonding in Solids and Electronic Properties. Free electron theory Chapter 4: Bonding in Solids and Electronic Properties Free electron theory Consider free electrons in a metal an electron gas. regards a metal as a box in which electrons are free to move. assumes nuclei

More information

Trivially parallel computing

Trivially parallel computing Parallel Computing After briefly discussing the often neglected, but in praxis frequently encountered, issue of trivially parallel computing, we turn to parallel computing with information exchange. Our

More information

Performance optimization of WEST and Qbox on Intel Knights Landing

Performance optimization of WEST and Qbox on Intel Knights Landing Performance optimization of WEST and Qbox on Intel Knights Landing Huihuo Zheng 1, Christopher Knight 1, Giulia Galli 1,2, Marco Govoni 1,2, and Francois Gygi 3 1 Argonne National Laboratory 2 University

More information

Multi-Scale Modeling from First Principles

Multi-Scale Modeling from First Principles m mm Multi-Scale Modeling from First Principles μm nm m mm μm nm space space Predictive modeling and simulations must address all time and Continuum Equations, densityfunctional space scales Rate Equations

More information

Part 1: What is XAFS? What does it tell us? The EXAFS equation. Part 2: Basic steps in the analysis Quick overview of typical analysis

Part 1: What is XAFS? What does it tell us? The EXAFS equation. Part 2: Basic steps in the analysis Quick overview of typical analysis Introduction to XAFS Part 1: What is XAFS? What does it tell us? The EXAFS equation Part 2: Basic steps in the analysis Quick overview of typical analysis Tomorrow Measurement methods and examples The

More information

Rustam Z. Khaliullin University of Zürich

Rustam Z. Khaliullin University of Zürich Rustam Z. Khaliullin University of Zürich Molecular dynamics (MD) MD is a computational method for simulating time evolution of a collection of interacting atoms by numerically integrating Newton s equation

More information

Efficient algorithms for symmetric tensor contractions

Efficient algorithms for symmetric tensor contractions Efficient algorithms for symmetric tensor contractions Edgar Solomonik 1 Department of EECS, UC Berkeley Oct 22, 2013 1 / 42 Edgar Solomonik Symmetric tensor contractions 1/ 42 Motivation The goal is to

More information

From Last Time Important new Quantum Mechanical Concepts. Atoms and Molecules. Today. Symmetry. Simple molecules.

From Last Time Important new Quantum Mechanical Concepts. Atoms and Molecules. Today. Symmetry. Simple molecules. Today From Last Time Important new Quantum Mechanical Concepts Indistinguishability: Symmetries of the wavefunction: Symmetric and Antisymmetric Pauli exclusion principle: only one fermion per state Spin

More information

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water?

Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Can a continuum solvent model reproduce the free energy landscape of a β-hairpin folding in water? Ruhong Zhou 1 and Bruce J. Berne 2 1 IBM Thomas J. Watson Research Center; and 2 Department of Chemistry,

More information

Hybrid static/dynamic scheduling for already optimized dense matrix factorization. Joint Laboratory for Petascale Computing, INRIA-UIUC

Hybrid static/dynamic scheduling for already optimized dense matrix factorization. Joint Laboratory for Petascale Computing, INRIA-UIUC Hybrid static/dynamic scheduling for already optimized dense matrix factorization Simplice Donfack, Laura Grigori, INRIA, France Bill Gropp, Vivek Kale UIUC, USA Joint Laboratory for Petascale Computing,

More information

Photoinduced Water Oxidation at the Aqueous. GaN Interface: Deprotonation Kinetics of. the First Proton-Coupled Electron-Transfer Step

Photoinduced Water Oxidation at the Aqueous. GaN Interface: Deprotonation Kinetics of. the First Proton-Coupled Electron-Transfer Step Supporting Information Photoinduced Water Oxidation at the Aqueous Interface: Deprotonation Kinetics of the First Proton-Coupled Electron-Transfer Step Mehmed Z. Ertem,,,* eerav Kharche,,* Victor S. Batista,

More information

Cyclops Tensor Framework: reducing communication and eliminating load imbalance in massively parallel contractions

Cyclops Tensor Framework: reducing communication and eliminating load imbalance in massively parallel contractions Cyclops Tensor Framework: reducing communication and eliminating load imbalance in massively parallel contractions Edgar Solomonik 1, Devin Matthews 3, Jeff Hammond 4, James Demmel 1,2 1 Department of

More information

Molecular Aggregation

Molecular Aggregation Molecular Aggregation Structure Analysis and Molecular Simulation of Crystals and Liquids ANGELO GAVEZZOTTI University of Milano OXFORD UNIVERSITY PRESS Contents PART I FUNDAMENTALS 1 The molecule: structure,

More information

Ionizing radiation produces tracks defined by the geometry of the energy deposition events. An incident ion loses energy by Coulombic interactions

Ionizing radiation produces tracks defined by the geometry of the energy deposition events. An incident ion loses energy by Coulombic interactions Track Structure Ionizing radiation produces tracks defined by the geometry of the energy deposition events. An incident ion loses energy by Coulombic interactions with electrons of the medium. These primary

More information

Basics of DFT applications to solids and surfaces

Basics of DFT applications to solids and surfaces Basics of DFT applications to solids and surfaces Peter Kratzer Physics Department, University Duisburg-Essen, Duisburg, Germany E-mail: Peter.Kratzer@uni-duisburg-essen.de Periodicity in real space and

More information

Introduction to CPMD 1

Introduction to CPMD 1 Introduction to CPMD 1 CPMD program ab initio electronic structure (DFT) and molecular dynamics program plane wave basis set (PBC), pseudopotentials massively parallelized, linear scaling up to thousands

More information

Algorithms and Computational Aspects of DFT Calculations

Algorithms and Computational Aspects of DFT Calculations Algorithms and Computational Aspects of DFT Calculations Part I Juan Meza and Chao Yang High Performance Computing Research Lawrence Berkeley National Laboratory IMA Tutorial Mathematical and Computational

More information

Using Web-Based Computations in Organic Chemistry

Using Web-Based Computations in Organic Chemistry 10/30/2017 1 Using Web-Based Computations in Organic Chemistry John Keller UAF Department of Chemistry & Biochemistry The UAF WebMO site Practical aspects of computational chemistry theory and nomenclature

More information

GPU Computing Activities in KISTI

GPU Computing Activities in KISTI International Advanced Research Workshop on High Performance Computing, Grids and Clouds 2010 June 21~June 25 2010, Cetraro, Italy HPC Infrastructure and GPU Computing Activities in KISTI Hongsuk Yi hsyi@kisti.re.kr

More information

Advanced Computation for Complex Materials

Advanced Computation for Complex Materials Advanced Computation for Complex Materials Computational Progress is brainpower limited, not machine limited Algorithms Physics Major progress in algorithms Quantum Monte Carlo Density Matrix Renormalization

More information

Supporting Information for. Dynamics Study"

Supporting Information for. Dynamics Study Supporting Information for "CO 2 Adsorption and Reactivity on Rutile TiO 2 (110) in Water: An Ab Initio Molecular Dynamics Study" Konstantin Klyukin and Vitaly Alexandrov,, Department of Chemical and Biomolecular

More information

DFT: Exchange-Correlation

DFT: Exchange-Correlation DFT: Local functionals, exact exchange and other post-dft methods Stewart Clark University of Outline Introduction What is exchange and correlation? Quick tour of XC functionals (Semi-)local: LDA, PBE,

More information

HECToR CSE technical meeting, Oxford Parallel Algorithms for the Materials Modelling code CRYSTAL

HECToR CSE technical meeting, Oxford Parallel Algorithms for the Materials Modelling code CRYSTAL HECToR CSE technical meeting, Oxford 2009 Parallel Algorithms for the Materials Modelling code CRYSTAL Dr Stanko Tomi Computational Science & Engineering Department, STFC Daresbury Laboratory, UK Acknowledgements

More information