Automatic code generation in density functional theory

Size: px
Start display at page:

Download "Automatic code generation in density functional theory"

Transcription

1 Computer Physics Communications 136 (2001) Automatic code generation in density functional theory R. Strange F.R. Manby P.J. Knowles School of Chemistry University of Birmingham Edgbaston Birmingham B15 2TT UK Received 18 December 2000 Abstract We present a program dfauto that uses automatic code generation to produce Fortran code and LATEX documentation for implementing density functionals in a Kohn Sham program. The user provides the formulae that define the density functional and dfauto produces Fortran to evaluate the exchange-correlation kernel on an integration grid along with the gradients necessary for Kohn Sham calculations. The program is implemented in Bourne shell and Maple Elsevier Science B.V. All rights reserved. PACS: Ew Keywords: DFT; Density functional theory; Kohn Sham theory; Automatic code generation PROGRAM SUMMARY Title of program: dfauto Catalogue identifier: ADNY Program Summary URL: Program obtainable from: CPC Program Library Queen s University of Belfast N. Ireland Licensing provision: Those pertaining to Maple Computers: UNIX platforms Operating systems under which program has been tested: Linux OSF1 Programming languages used: Maple V (version 5) Bourne shell (sh) Fortran LATEX No. of bits in a word: 32 No. of bytes in distributed program including test data: Distribution format: gzip file Keywords: DFT density functional theory Kohn Sham theory automatic code generation Nature of physical problem Density functional theory of electronic structure. Method of solution Automatic code generation. Restrictions on the complexity of the problem Functionals only of the density its first and second derivatives and the kinetic energy density are treated. Typical running time Functional dependent but typically of the order of one minute. * Corresponding author. address: P.J.Knowles@bham.ac.uk (P.J. Knowles) /01/$ see front matter 2001 Elsevier Science B.V. All rights reserved. PII: S (01)

2 R. Strange et al. / Computer Physics Communications 136 (2001) Introduction The Kohn Sham (KS) [1] construction of density functional theory (DFT) [23] has proven to be extremely useful in treating the electronic structure of large systems. DFT uses the electronic density a simple function in three-dimensional space as the primary variational quantity in place of the complicated N-electron wavefunction. In KS theory the density ρ is generated from the KS determinant which also provides the non-interacting kinetic energy. The non-local effects of exchange and correlation (including the correction to the kinetic energy) are treated by a local effective potential v xc related to the elusive exchange-correlation functional E xc by v xc = δe xc δρ. (1) The usual Fock equations of Hartree Fock (HF) theory are then replaced by the KS equations [ ] + v ext + v J + v xc ψi = ɛ i ψ i (2) where v ext and v J are the external and Coulomb potentials. The orbitals ψ i are typically expanded in an atomic orbital (AO) basis ψ i = a c ia η a (3) and the coefficients c ia are determined by solving the matrix form of Eq. (2) to self-consistency. The general exchange-correlation functional has the form E xc [ρτ]= d rk ( ρ( r)σ( r)υ( r)τ( r) ) (4) where σ = ρ 2 υ = 2 ρ and τ is the kinetic energy density of the KS determinant. The electronic and kinetic energy densities can be represented in canonical or atomic orbitals: ρ = ψ i 2 = γ ab ηa η b (5) i occ ab and τ = ψ i 2 = γ ab [ η a ] [ η b ] (6) i occ ab where γ is the AO density matrix. Higher gradients of the density may be used in forming the exchange-correlation functional but we do not consider them here. The exchange-correlation contribution f xc to the Fock matrix should apparently involve an integration over the exchange correlation potential v xc. However one can and should avoid the evaluation of the functional derivative in Eq. (1) by considering the derivatives of E xc with respect to the elements of the density matrix: fab xc = E xc[ρτ] = d r K. (7) γ ab γ ab These and not the integrals involving the functional derivative are exactly what are required for the variational minimization of the energy with respect to the orbital coefficients. Using the chain rule we have f xc ab = ξ {ρσυτ} d r ξ( r) γ ab v ξ ( r) where v ξ K/ ξ. The partial derivatives with respect to γ ab have simple forms in terms of the AOs and their gradients for instance ρ/ γ ab = η a η b. The contributions to the Fock matrix arising from exact exchange (present in so-called hybrid functionals [4]) have the usual HF form. (8)

3 312 R. Strange et al. / Computer Physics Communications 136 (2001) The integral in Eq. (8) is usually performed on a numerical quadrature grid [5 9] by evaluating the orbitals their gradients K and its partial derivatives v ξ at each grid point. Writing the subroutines for complicated functionals is a time-consuming and error-prone process: in the current work we use automatic code generation to produce the subroutine and its documentation directly from the formulae that define the density functional. 2. Implementation For a general treatment of an N-electron system the spin densities ρ α and ρ β have to be treated independently. K consists of a spin-summed term (as for exchange) and a coupling term between the spins (present in correlation functionals): K = g(ρ s ρ s σ ss σ s s σ s s υ s υ s τ s τ s ) s {αβ} + f(ρ α ρ β σ αα σ αβ σ ββ υ α υ β τ α τ β ) where s is the conjugate spin to s. Functionals are usually derived in terms of these spin indexed densities (and related objects) but for computational convenience functionals are implemented using the total density ρ ρ c = ρ α + ρ β and the spin (or open-shell) density ρ o = ρ α ρ β. Similar total- and open-shell quantities are used for the gradient terms with υ c υ o and τ c τ o being obvious generalizations of ρ c ρ o ; σ cc σ co and σ oo are constructed from ρ c and ρ o to give e.g. σ co σ oc =[ ρ c ] [ ρ o ]. The exchange-correlationkernel that appears in Eq. (4) is then a function of the nine co-indexed quantities listed above and we require in addition to K at each grid point the values of the partial derivatives v ξ with respect to each of these objects. For closed-shell systems all quantities with subscripts containing an o can be neglected increasing the efficiency of the computation. The derivatives with respect to quantities absent from the density functional can of course be neglected. For example to evaluate the Dirac exchange for a closed-shell system a possible fragment of Fortran code is do i=1n zk(i)=-cf*rhoc(i)**(4d0/3d0) vrhoc(i)=-4d0/3d0*cf*rhoc(i)**(1d0/3d0) enddo where the array zk stores the exchange-correlation kernel on the n grid points labeled i rhoc ρ c vrhoc v ρc and cf is the closed-shell Fermi constant. The program presented here dfauto converts a Maple [10] expression for a density functional given in α β form to Fortran code like that above and produces a manual page documenting the functional. The program takes care of the transition from the usual α β form of functionals to the computationally convenient co form. dfauto is implemented in Bourne shell (sh) under the UNIX operating system and the mathematical manipulations and translations to Fortran and LATEX are performed by Maple. To generate the body of the loop in the above code the Maple input k:=-cf*rhoc[i]^(4/3): fortran([zk[i]=kvrhoc[i]=diff(krhoc[i])]precision=double); returns zk(i) = -cf*rhoc(i)**(4.d0/3.d0) vrhoc(i) = -4.D0/3.D0*cf*rhoc(i)**(1.D0/3.D0) and the command latex(k=k):

4 R. Strange et al. / Computer Physics Communications 136 (2001) produces the LATEX K=-{\it cf}\{{\it rhoc}_{{i}}}^{4/3} for documentation. The Fortran generated by dfauto is optimized by Maple but for technical reasons Maple s simplifying procedure is not invoked. 3. Using dfauto In order to use dfauto aunix system with Maple a Fortran compiler and LATEX with the standard packages breqn [11] and inlinebib [12] are needed. Although dfauto was originally written to introduce new density functionals into the quantum chemistry package MOLPRO [13] it can be used with any suitably designed Fortran file. To run dfauto a Maple input file must be created with the suffix.df e.g. fn.df. The file should contain the definitions of f and/or g along with any auxiliary definitions such as constants that appear in the formulae. Although not all features of Maple have been tested with dfauto most should be acceptable in the.df file so that for example user defined procedures arrays and summations present no difficulty. Given input fn.df dfauto appends a subroutine dftacg_fn to a specified Fortran file and creates a manual page in the file fn.tex. The density functional program must test a character string key which specifies the density functional to be used. By default the files dftfun.f dftuser.f and base/src/dft/dftfun.f are scanned to prevent repetition of a key; the defaults can be overridden by setting the environment variable DFTFILES. In order to insert the call for a new subroutine dfauto requires the presence of a marker in the Fortran file. The tag c:dfauto needs to appear directly above an elseif in or the endif of the key test and the call to the new functional is inserted directly above it. The relevant part of such a file might be if(key.eq. FUNC1 ) then call func1(...) elseif(key.eq. FUNC2 ) then call func2(...) c:dfauto endif and after running the command dfauto fn.df would be if(key.eq. FUNC1 ) then call func1(...)... c:fncallstart elseif(key.eq. FN ) then call dftacg_fn(namefderivopenigradnptrhocrhoo > sigmaccsigmacosigmaootauctauo > upsiloncupsilono > zkvrhocvrhoo > vsigmaccvsigmacovsigmaoovtaucvtauo > vupsiloncvupsilono) c:fncallend c:dfauto endif The c:fncallstart and c:fncallend tags are introduced to allow dfauto to remove the functional FN.

5 314 R. Strange et al. / Computer Physics Communications 136 (2001) The subroutine dftacg_fn takes as input the number of grid points npt; arrays rhoc rhoo sigmacc sigmaco sigmaoo tauc tauo upsilonc upsilono defining the corresponding functions on the grid; the logicals fderiv and open indicating whether gradients should be computed and if the system is open-shell; the value of the functional is returnedin zk and the derivatives with respect to ξ are accumulated in the arrays vξ; name is the string Automatically generated FN. igrad is set to an integer between 0 and 2 by the subroutine specifying the highest order gradient present in the functional; thus the subroutine can be called with zero grid points to ascertain which of ρστ and υ must be computed. Everynewequationinfn.df must occur on a new line but very long equations may be split over many lines using a backslash for continuation. The variables ρ s σ s s υ s τ s and the reduced (or dimensionless) spin density gradients χ s = ρ s ρ 4/3 s = σss ρ 4/3 s are entered rho sigma upsilon tau and chi with the subscripts α β s and s appended a b s and s_ in parentheses. For example ρ α and σ s s are entered rho(a) and sigma(ss_) respectively. The objects in parentheses are protected names and cannot be assigned in an input file e.g. the line s:=rho(s): will cause an error. Spin summed quantities are entered unindexed so that rho ρ α + ρ β ; there is no spin-summed χ. Special attention has to be paid to functionals that contain χ s or other objects that diverge when ρ s 0. Consider Becke s 1986 exchange functional [14] K = s [ 3 2 ( 3 4π ) 1/3 ρs 4/3 + β ρ4/3 s χs λχs 2 ] where β and λ are constants. The second term vanishes as ρ s 0 despite the presence of χ s.ifthiskindof singularity occurs dfauto prompts the user to insert an equation in the input file defining the limit G when one of the spin densities goes to zero. G is inputed in the same way as g without terms involving s_; seesample input and output for an example. The value of the functional for the hydrogen atom (ρ α = e 2r /π) is evaluated on a 90 point grid to test the generated Fortran. For compilation the environment variable MFILES lists the make dependencies of the Fortran file to which the subroutine is appended. For the manual generation a title reference and description of the functional may be given in the variables title ref and blurb protected by double quotes. References are entered in Bibtex format and dfauto places them in the file acg.bib multiple entries in acg.bib are not checked for. The file fn.tex does not contain any preamble information dfauto wraps the output in suitable LATEX and produces a DVI and/or postscript file acg.dvi or.ps. The usage of dfauto is: dfauto [-lpdz] [-x ptsize] [-t paper] [-f font] [-mras] [-o ffile] <.df files > -l produce LATEX only no Fortran -p postscript output no DVI -d DVI output -z suppress G in manual -x ptsize font size in pts -t paper paper size -f font font option

6 R. Strange et al. / Computer Physics Communications 136 (2001) m produce Fortran only no LATEX -r remove subroutine -a append subroutine -s replace subroutine -o ffile Fortran file The arguments <.df files > are the input files. By default ffile is dftuser.f and the DVI file is generated. With the flag -p only postscript output is produced;with -dp both files are produced.the printing of G may be suppressed using the -z flag. Acknowledgements The authors acknowledge support from the EPSRC (grant number: GR/N07912) and FRM is grateful for financial support from the Royal Society. RS would like to thank Dr S.J. McNicholas for helpful discussions. References [1] W. Kohn L.J. Sham Phys. Rev. A 140 (1965) [2] P. Hohenberg W. Kohn Phys. Rev. B 136 (1964) 864. [3] R. Parr W. Yang Density-Functional Theory of Atoms and Molecules Oxford University Press New York [4] A.D. Becke J. Chem. Phys. 98 (1993) [5] S.F. Boys P. Rajagopal Adv. Quantum Chem. 2 (1965) 1. [6] A.D. Becke J. Chem. Phys. 88 (1988) [7] C.W. Murray N.C. Handy G.J. Laming Mol. Phys. 78 (1993) 997. [8] O. Treutler R. Ahlrichs Chem. Phys. Lett. 102 (1995) 346. [9] M.E. Mura P.J. Knowles J. Chem. Phys. 104 (1996) [10] B.W. Char K.O. Geddes G.H. Gonnet B.L. Leong M.B. Monagan S.M. Watt Maple V Language Reference Manual Springer New York [11] ftp://ftp.tex.ac.uk/tex-archive/help/catalogue/entries/breqn.html. [12] ftp://ftp.tex.ac.uk/tex-archive/help/catalogue/entries/inlinebib.html. [13] MOLPRO is a package of ab initio programs written by H.-J. Werner and P.J. Knowles with contributions from R.D. Amos A. Bernhardsson A. Berning P. Celani D.L. Cooper M.J.O. Deegan A.J. Dobbyn F. Eckert C. Hampel G. Hetzer T. Korona R. Lindh A.W. Lloyd S.J. McNicholas F.R. Manby W. Meyer M.E. Mura A. Nicklass P. Palmieri R. Pitzer G. Rauhut M. Schütz H. Stoll A.J. Stone R. Tarroni and T. Thorsteinsson. [14] A.D. Becke J. Chem. Phys. 84 (1986) [15] D.J. Tozer N.C. Handy J. Chem. Phys. 108 (1998) 2545.

7 316 R. Strange et al. / Computer Physics Communications 136 (2001) Sample input The TH1 functional of Tozer and Handy [15] involves a summation over a range of optimized parameters which may be conveniently expressed in an array. Unlike other variables arrays must be defined before they are used. The following file th1.df illustrates the use of arrays to input the TH1 functional. Note the use of backslashes to protect the quotes in the reference. t:=array([7/68/69/610/68/69/610/611/69/610/6\ 11/612/69/610/611/612/67/68/69/610/61]): u:=array([ ]): v:=array([ ]): w:=array([ ]): omega:=array([ \ \ \ \ ]): n:=21: R[i]:=rho(a)^t[i]+rho(b)^t[i]: S[i]:=((rho(a)-rho(b))/rho)^(2*u[i]): X[i]:=(sqrt(sigma(aa))^v[i] + sqrt(sigma(bb))^v[i]) / (2*rho^(4*v[i]/3)): Y[i]:=((sigma(aa)+sigma(bb)-2*(sigma(aa)^(1/2)*sigma(bb)^(1/2)))/\ rho^(8/3))^w[i]: f:=sum(omega[i]*r[i]*s[i]*x[i]*y[i]i=1..n): ref:="@article{th1 author=\"d. J. Tozer and N. C. Handy\"\ journal=\"j. Chem.\\ Phys.\" volume=108 number=6 pages=2545 year=1998}": blurb:="density and gradient dependent first row exchange-correlation \ functional": title:="tozer and Handy 1998": G:=sum(omega[i]*rho(s)^t[i]*sqrt(sigma(ss))^v[i]/(2*rho(s)^(4*v[i]/3))*\ (sigma(ss)/rho(s)^(8/3))^w[i]i=1..n):

8 R. Strange et al. / Computer Physics Communications 136 (2001) Sample output On issuing the command dfauto -o mydft.f th1.df the following standard output is generated: ACG: th1.df --> th1.tex ACG: th1.df --> subroutine dftacg_th1 in mydft.f Testing for singularities No singularities found in TH1 Functional value for the Hydrogen atom = au and 500 lines of Fortran are placed in mydft.f. A manual page is generated and forms the remainder of this section: TH1: Tozer and Handy 1998 D.J. Tozer and N.C. Handy J. Chem. Phys. 108 (6) (1998) Density and gradient dependent first row exchange-correlation functional where n K = ω i R i S i X i Y i i=1 n = 21 R i = (ρ α ) t i + (ρ β ) t i t = [ 7/6 4/3 3/2 5/3 4/3 3/2 5/ ( ) ρα ρ 2 ui β S i = ρ X i = 1/2 ( σ αα ) v i + ( σ ββ ) v i ρ 4/3 v i ( σαα + σ ββ 2 ) σ αα σββ wi Y i = ρ 8/ /2 5/ /2 5/ /6 4/3 3/2 5/3 1] u =[ ] v =[ ] w =[ ] and ω =[ ]. To avoid singularities in the limit ρ s 0 G = n i=1 1/2 ω i (ρ s ) t ( ( ) ) wi i vi σss ( σss (ρs (ρ s ) 8/3 ) 4/3 v ) i 1.

9 318 R. Strange et al. / Computer Physics Communications 136 (2001) Bibliography D.J. Tozer and N.C. Handy J. Chem. Phys. 108 (6):

Marek Pederzoli J. Heyrovský Institute of Physical Chemistry, Academy of Sciences of the Czech Republic, v.v.i.,

Marek Pederzoli J. Heyrovský Institute of Physical Chemistry, Academy of Sciences of the Czech Republic, v.v.i., Supplementary Material: A New Approach to Molecular Dynamics with Non-adiabatic and Spin-orbit Effects with Applications to QM/MM Simulations of Thiophene and Selenophene Marek Pederzoli J. Heyrovský Institute

More information

Homologation of Boronic Esters with Organolithium Compounds: A Computational Assessment of Mechanism

Homologation of Boronic Esters with Organolithium Compounds: A Computational Assessment of Mechanism Homologation of Boronic Esters with Organolithium Compounds: A Computational Assessment of Mechanism Stéphanie Essafi,*,1 Simone Tomasi, 2 Varinder K. Aggarwal, 1 Jeremy Harvey*,1 1 School of Chemistry,

More information

Static Dipole Moments and Electronic Structure Calculations of the Low-Lying Electronic States of the Molecule Zinc Selinum ZnSe

Static Dipole Moments and Electronic Structure Calculations of the Low-Lying Electronic States of the Molecule Zinc Selinum ZnSe Modern Applied Science; Vol. 11, No. 9; 2017 ISSN 1913-1844 E-ISSN 1913-1852 Published by Canadian Center of Science and Education Static Dipole Moments and Electronic Structure Calculations of the Low-Lying

More information

Density Functional Theory - II part

Density Functional Theory - II part Density Functional Theory - II part antonino.polimeno@unipd.it Overview From theory to practice Implementation Functionals Local functionals Gradient Others From theory to practice From now on, if not

More information

Comment on: Estimating the Hartree Fock limit from finite basis set calculations [Jensen F (2005) Theor Chem Acc 113:267]

Comment on: Estimating the Hartree Fock limit from finite basis set calculations [Jensen F (2005) Theor Chem Acc 113:267] Comment on: Estimating the Hartree Fock limit from finite basis set calculations [Jensen F (2005) Theor Chem Acc 113:267] Amir Karton and Jan M.L. Martin Department of Organic Chemistry, Weizmann Institute

More information

Basis set convergence in extended systems: infinite hydrogen fluoride and hydrogen chloride chains

Basis set convergence in extended systems: infinite hydrogen fluoride and hydrogen chloride chains Chemical Physics Letters 398 (2004) 44 49 www.elsevier.com/locate/cplett Basis set convergence in extended systems: infinite hydrogen fluoride and hydrogen chloride chains Christian Buth *, Beate Paulus

More information

Supporting Information for

Supporting Information for Supporting Information for Carbon-Bridged Phenylene-Vinylenes: On the Common Diradicaloid Origin of Their Photonic and Chemical Properties Rafael C. González-Cano, a Simone di Motta, b Xiaozhang Zhu, c,

More information

Ab initio calculations on the ground and low-lying excited states of InI

Ab initio calculations on the ground and low-lying excited states of InI MOLECULAR PHYSICS, 1OCTOBER 23, VOL. 11, NO. 19, 2963 2968 Ab initio calculations on the ground and low-lying excited states of InI WENLI ZOU, MEIRONG LIN*, XINZHENG YANG and BAOZHENG ZHANG Institute of

More information

Inversion Vibrational Energy Levels of PH 3 + ( X 2 A 2) Calculated by a New Two-dimension Variational Method

Inversion Vibrational Energy Levels of PH 3 + ( X 2 A 2) Calculated by a New Two-dimension Variational Method CHINESE JOURNAL OF CHEMICAL PHYSICS VOLUME 6, NUMBER APRIL 7, 03 ARTICLE Inversion Vibrational Energy Levels of PH 3 + ( X A ) Calculated by a New Two-dimension Variational Method Zu-yang Dai, Yu-xiang

More information

arxiv:physics/ v2 [physics.atom-ph] 31 May 2004

arxiv:physics/ v2 [physics.atom-ph] 31 May 2004 arxiv:physics/0405136v2 [physics.atom-ph] 31 May 2004 Pure spin angular momentum coefficients for non scalar one particle operators in jj coupling G. Gaigalas a and S. Fritzsche b a Institute of Theoretical

More information

Title. Author(s)Kayanumai, Megumi; Taketsugu, Tetsuya; Ishii, Keisak. CitationChemical Physics Letters, 418(4-6): Issue Date

Title. Author(s)Kayanumai, Megumi; Taketsugu, Tetsuya; Ishii, Keisak. CitationChemical Physics Letters, 418(4-6): Issue Date Title Ab initio surface hopping simulation on dissociative Author(s)Kayanumai, Megumi; Taketsugu, Tetsuya; Ishii, Keisak CitationChemical Physics Letters, 418(4-6): 511-518 Issue Date 26-2 Doc URL http://hdl.handle.net/2115/5592

More information

Exchange correlation potentials and local energies per particle along nonlinear adiabatic connections

Exchange correlation potentials and local energies per particle along nonlinear adiabatic connections Molecular Physics, Vol. 13, No. 2, 2 October 25, 2725 2734 Ehange correlation potentials and local energies per particle along nonlinear adiabatic connections JULIEN TOULOUSE, FRANC OIS COLONNA and ANDREAS

More information

arxiv:cond-mat/ v2 [cond-mat.other] 21 Nov 2005

arxiv:cond-mat/ v2 [cond-mat.other] 21 Nov 2005 arxiv:cond-mat/0408243v2 [cond-mat.other] 21 Nov 2005 Basis set convergence in extended systems: infinite hydrogen fluoride and hydrogen chloride chains Christian Buth, Beate Paulus Max-Planck-Institut

More information

Computation of photoelectron and Auger-electron diffraction III. Evaluation of angle-resolved intensities PAD3

Computation of photoelectron and Auger-electron diffraction III. Evaluation of angle-resolved intensities PAD3 Computer Physics Communications 112 (1998) 911101 Computation of photoelectron and Auger-electron diffraction III. Evaluation of angle-resolved intensities PAD3 X.Chen,G.R.Harp 1,Y.Ueda,D.K.Saldin 2 Department

More information

On Newton-type methods with cubic convergence

On Newton-type methods with cubic convergence Journal of Computational and Applied Mathematics 176 (2005) 425 432 www.elsevier.com/locate/cam On Newton-type methods with cubic convergence H.H.H. Homeier a,b, a Science + Computing Ag, IT Services Muenchen,

More information

Chemical Physics 412 (2013) Contents lists available at SciVerse ScienceDirect. Chemical Physics

Chemical Physics 412 (2013) Contents lists available at SciVerse ScienceDirect. Chemical Physics Chemical Physics 1 (013) 109 116 Contents lists available at SciVerse ScienceDirect Chemical Physics journal homepage: www.elsevier.com/locate/chemphys Electronic structure with spin orbit calculations

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

Supporting Information. Surface Chemistry of 1- and 3-Hexyne on Pt(111): Desorption, Decomposition and Dehydrocyclization

Supporting Information. Surface Chemistry of 1- and 3-Hexyne on Pt(111): Desorption, Decomposition and Dehydrocyclization Supporting Information Surface Chemistry of 1- and 3-Hexyne on Pt(111): Desorption, Decomposition and Dehydrocyclization M. D. Rötzer 1, M. Krause 1, A. S. Crampton 1,2, E. Mitterreiter 1, H. H. Heenen

More information

Density-Fitting Approximations to the Electron Repulsion Integrals

Density-Fitting Approximations to the Electron Repulsion Integrals Density-Fitting Approximations to the Electron Repulsion Integrals C. David Sherrill School of Chemistry and Biochemistry Georgia Institute of Technology Created on 19 July 2010 Here we will follow some

More information

Key concepts in Density Functional Theory (I) Silvana Botti

Key concepts in Density Functional Theory (I) Silvana Botti From the many body problem to the Kohn-Sham scheme European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Temporary Address: Centre

More information

Density Functional Theory. Martin Lüders Daresbury Laboratory

Density Functional Theory. Martin Lüders Daresbury Laboratory Density Functional Theory Martin Lüders Daresbury Laboratory Ab initio Calculations Hamiltonian: (without external fields, non-relativistic) impossible to solve exactly!! Electrons Nuclei Electron-Nuclei

More information

The performance of the Hartree-Fock-Wigner correlation model for light diatomic molecules

The performance of the Hartree-Fock-Wigner correlation model for light diatomic molecules The performance of the Hartree-Fock-Wigner correlation model for light diatomic molecules Rebecca Fondermann, Michael Hanrath, Michael Dolg Institut für Theoretische Chemie, Universität zu Köln, Greinstr.

More information

MOLPRO. User s Manual Version

MOLPRO. User s Manual Version MOLPRO User s Manual Version 2006.1 H.-J. Werner Institut für Theoretische Chemie Universität Stuttgart Pfaffenwaldring 55 D-70569 Stuttgart Federal Republic of Germany P. J. Knowles School of Chemistry

More information

CHEM6085: Density Functional Theory

CHEM6085: Density Functional Theory Lecture 5 CHEM6085: Density Functional Theory Orbital-free (or pure ) DFT C.-K. Skylaris 1 Consists of three terms The electronic Hamiltonian operator Electronic kinetic energy operator Electron-Electron

More information

Minnesota Functional Module Version 1.8

Minnesota Functional Module Version 1.8 1 Minnesota Functional Module Version 1.8 Subroutines for evaluating the M05, M05-2X, M06-L, M06-HF, M06, M06-2X, M08-HX, M08-SO, M11, M11-L, MN12-L, SOGGA, SOGGA11, SOGGA11-X, N12, N12-SX Functionals

More information

THE JOURNAL OF CHEMICAL PHYSICS 127,

THE JOURNAL OF CHEMICAL PHYSICS 127, THE JOUNAL OF CHEMICAL PHYSICS 127, 214103 2007 Avoiding singularity problems associated with meta-gga generalized gradient approximation exchange and correlation functionals containing the kinetic energy

More information

Charge Exchange in Low-Energy H, D + C 4+ Collisions with Full Account of Electron Translation

Charge Exchange in Low-Energy H, D + C 4+ Collisions with Full Account of Electron Translation Int. J. Mol. Sci. 2002, 3, 190-208 Int. J. Mol. Sci. ISSN 1422-0067 www.mdpi.org/ijms/ Charge Exchange in Low-Energy H, D + C 4+ Collisions with Full Account of Electron Translation A. K. Belyaev 1, J.

More information

Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride. Dimer. Philip Straughn

Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride. Dimer. Philip Straughn Exchange Correlation Functional Investigation of RT-TDDFT on a Sodium Chloride Dimer Philip Straughn Abstract Charge transfer between Na and Cl ions is an important problem in physical chemistry. However,

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

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

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

Orbital dependent correlation potentials in ab initio density functional theory

Orbital dependent correlation potentials in ab initio density functional theory Orbital dependent correlation potentials in ab initio density functional theory noniterative - one step - calculations Ireneusz Grabowski Institute of Physics Nicolaus Copernicus University Toruń, Poland

More information

MOLPRO. User s Manual Version

MOLPRO. User s Manual Version MOLPRO User s Manual Version 2002.6 H.-J. Werner Institut für Theoretische Chemie Universität Stuttgart Pfaffenwaldring 55 D-70569 Stuttgart Federal Republic of Germany P. J. Knowles School of Chemical

More information

v(r i r j ) = h(r i )+ 1 N

v(r i r j ) = h(r i )+ 1 N Chapter 1 Hartree-Fock Theory 1.1 Formalism For N electrons in an external potential V ext (r), the many-electron Hamiltonian can be written as follows: N H = [ p i i=1 m +V ext(r i )]+ 1 N N v(r i r j

More information

MO Calculation for a Diatomic Molecule. /4 0 ) i=1 j>i (1/r ij )

MO Calculation for a Diatomic Molecule. /4 0 ) i=1 j>i (1/r ij ) MO Calculation for a Diatomic Molecule Introduction The properties of any molecular system can in principle be found by looking at the solutions to the corresponding time independent Schrodinger equation

More information

Fast and accurate Coulomb calculation with Gaussian functions

Fast and accurate Coulomb calculation with Gaussian functions Fast and accurate Coulomb calculation with Gaussian functions László Füsti-Molnár and Jing Kong Q-CHEM Inc., Pittsburgh, Pennysylvania 15213 THE JOURNAL OF CHEMICAL PHYSICS 122, 074108 2005 Received 8

More information

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz November 29, 2010 The self interaction error and its correction Perdew-Zunger SIC Average-density approximation Weighted density approximation

More information

Advanced Quantum Chemistry III: Part 3. Haruyuki Nakano. Kyushu University

Advanced Quantum Chemistry III: Part 3. Haruyuki Nakano. Kyushu University Advanced Quantum Chemistry III: Part 3 Haruyuki Nakano Kyushu University 2013 Winter Term 1. Hartree-Fock theory Density Functional Theory 2. Hohenberg-Kohn theorem 3. Kohn-Sham method 4. Exchange-correlation

More information

Diphosphene Photobehaviour

Diphosphene Photobehaviour Electronic Supplementary Information P=P Bond Photophysics in an Ar-P=P-Ar Diphosphene Huo-Lei Peng, John L. Payton, John D. Protasiewicz, M. Cather Simpson Full references for Gaussian and MolPro. (9)

More information

MOLPRO. User s Manual Version

MOLPRO. User s Manual Version MOLPRO User s Manual Version 2008.1 H.-J. Werner Institut für Theoretische Chemie Universität Stuttgart Pfaffenwaldring 55 D-70569 Stuttgart Federal Republic of Germany P. J. Knowles School of Chemistry

More information

Ab initio mechanism for efficient population of triplet states in cytotoxic sulfur substituted DNA bases: the case of 6- Thioguanine.

Ab initio mechanism for efficient population of triplet states in cytotoxic sulfur substituted DNA bases: the case of 6- Thioguanine. Ab initio mechanism for efficient population of triplet states in cytotoxic sulfur substituted DNA bases: the case of 6- Thioguanine. Lara Martínez-Fernández, a Leticia González b and Inés Corral *a a

More information

DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY

DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY DENSITY FUNCTIONAL THEORY FOR NON-THEORISTS JOHN P. PERDEW DEPARTMENTS OF PHYSICS AND CHEMISTRY TEMPLE UNIVERSITY A TUTORIAL FOR PHYSICAL SCIENTISTS WHO MAY OR MAY NOT HATE EQUATIONS AND PROOFS REFERENCES

More information

DFT calculations of NMR indirect spin spin coupling constants

DFT calculations of NMR indirect spin spin coupling constants DFT calculations of NMR indirect spin spin coupling constants Dalton program system Program capabilities Density functional theory Kohn Sham theory LDA, GGA and hybrid theories Indirect NMR spin spin coupling

More information

Radiative Transition Probabilities and Lifetimes for the Band Systems A 2 Π X 2 Σ + of the Isovalent Molecules BeF, MgF and CaF

Radiative Transition Probabilities and Lifetimes for the Band Systems A 2 Π X 2 Σ + of the Isovalent Molecules BeF, MgF and CaF 950 Brazilian Journal of Physics, vol. 35, no. 4A, December, 2005 Radiative Transition Probabilities and Lifetimes for the Band Systems of the Isovalent Molecules BeF, MgF and CaF Marina Pelegrini a, Ciro

More information

Dispersion relations in the nuclear optical model

Dispersion relations in the nuclear optical model Computer Physics Communications 153 (2003) 97 105 www.elsevier.com/locate/cpc Dispersion relations in the nuclear optical model J.M. Quesada a,,r.capote a,b,1,a.molina a,m.lozano a a Departamento de Física

More information

Lecture 8: Introduction to Density Functional Theory

Lecture 8: Introduction to Density Functional Theory Lecture 8: Introduction to Density Functional Theory Marie Curie Tutorial Series: Modeling Biomolecules December 6-11, 2004 Mark Tuckerman Dept. of Chemistry and Courant Institute of Mathematical Science

More information

Density Functional Theory

Density Functional Theory Chemistry 380.37 Fall 2015 Dr. Jean M. Standard October 28, 2015 Density Functional Theory What is a Functional? A functional is a general mathematical quantity that represents a rule to convert a function

More information

On the Development of a New Computational Chemistry Software

On the Development of a New Computational Chemistry Software On the Development of a New Computational Chemistry Software Han Ung Lee, Hayan Lee and Wilfredo Credo Chung* Department of Chemistry, De La Salle University Manila, 2401 Taft Avenue, Manila, 1004 Philippines

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

Notes on Density Functional Theory

Notes on Density Functional Theory Notes on Density Functional Theory Rocco Martinazzo E-mail: rocco.martinazzo@unimi.it Contents 1 Introduction 1 Density Functional Theory 7 3 The Kohn-Sham approach 11 1 Introduction We consider here a

More information

Solid State Theory: Band Structure Methods

Solid State Theory: Band Structure Methods Solid State Theory: Band Structure Methods Lilia Boeri Wed., 11:15-12:45 HS P3 (PH02112) http://itp.tugraz.at/lv/boeri/ele/ Plan of the Lecture: DFT1+2: Hohenberg-Kohn Theorem and Kohn and Sham equations.

More information

Self-consistent Field

Self-consistent Field Chapter 6 Self-consistent Field A way to solve a system of many electrons is to consider each electron under the electrostatic field generated by all other electrons. The many-body problem is thus reduced

More information

Density matrix functional theory vis-á-vis density functional theory

Density matrix functional theory vis-á-vis density functional theory Density matrix functional theory vis-á-vis density functional theory 16.4.007 Ryan Requist Oleg Pankratov 1 Introduction Recently, there has been renewed interest in density matrix functional theory (DMFT)

More information

All electron optimized effective potential method for solids

All electron optimized effective potential method for solids All electron optimized effective potential method for solids Institut für Theoretische Physik Freie Universität Berlin, Germany and Fritz Haber Institute of the Max Planck Society, Berlin, Germany. 22

More information

Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory

Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory Electronic structure theory: Fundamentals to frontiers. 2. Density functional theory MARTIN HEAD-GORDON, Department of Chemistry, University of California, and Chemical Sciences Division, Lawrence Berkeley

More information

MOLPRO. Users Manual Version

MOLPRO. Users Manual Version MOLPRO Users Manual Version 2010.1 H.-J. Werner Institut für Theoretische Chemie Universität Stuttgart Pfaffenwaldring 55 D-70569 Stuttgart Federal Republic of Germany P. J. Knowles School of Chemistry

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

Density functional calculation of nuclear magnetic resonance chemical shifts

Density functional calculation of nuclear magnetic resonance chemical shifts Density functional calculation of nuclear magnetic resonance chemical shifts Christoph van Wüllen Lehrstuhl für Theoretische Chemie, Ruhr-Universität Bochum, D-44780 Bochum, Germany Received 22 August

More information

Density functional theory in the solid state

Density functional theory in the solid state Density functional theory in the solid state Ari P Seitsonen IMPMC, CNRS & Universités 6 et 7 Paris, IPGP Department of Applied Physics, Helsinki University of Technology Physikalisch-Chemisches Institut

More information

The Al + CO2 AlO + CO Reaction: Experiment vs. Theory

The Al + CO2 AlO + CO Reaction: Experiment vs. Theory The Al + CO2 AlO + CO Reaction: Experiment vs. Theory Zhi Sun, [a] Kevin B. Moore III, [a] and Henry F. Schaefer III *[a] [a] Center for Computational Quantum Chemistry, University of Georgia Athens, Georgia

More information

Orbital currents in the Colle-Salvetti correlation energy functional and the degeneracy problem. Abstract

Orbital currents in the Colle-Salvetti correlation energy functional and the degeneracy problem. Abstract Orbital currents in the Colle-Salvetti correlation energy functional and the degeneracy problem S. Pittalis 1, S. Kurth 1, S. Sharma 1,2 and E.K.U. Gross 1 1 Institut für Theoretische Physik, Freie Universität

More information

MOLPRO. User s Manual Version

MOLPRO. User s Manual Version MOLPRO User s Manual Version 2002.1 H.-J. Werner Institut für Theoretische Chemie Universität Stuttgart Pfaffenwaldring 55 D-70569 Stuttgart Federal Republic of Germany P. J. Knowles School of Chemical

More information

Density Func,onal Theory (Chapter 6, Jensen)

Density Func,onal Theory (Chapter 6, Jensen) Chem 580: DFT Density Func,onal Theory (Chapter 6, Jensen) Hohenberg- Kohn Theorem (Phys. Rev., 136,B864 (1964)): For molecules with a non degenerate ground state, the ground state molecular energy and

More information

Supporting Information

Supporting Information Supporting Information Probing the Electronic and Structural Properties of Chromium Oxide Clusters (CrO ) n and (CrO ) n (n = 1 5): Photoelectron Spectroscopy and Density Functional Calculations Hua-Jin

More information

Module 6 1. Density functional theory

Module 6 1. Density functional theory Module 6 1. Density functional theory Updated May 12, 2016 B A DDFT C K A bird s-eye view of density-functional theory Authors: Klaus Capelle G http://arxiv.org/abs/cond-mat/0211443 R https://trac.cc.jyu.fi/projects/toolbox/wiki/dft

More information

Density Functional Theory for Electrons in Materials

Density Functional Theory for Electrons in Materials Density Functional Theory for Electrons in Materials Richard M. Martin Department of Physics and Materials Research Laboratory University of Illinois at Urbana-Champaign 1 Density Functional Theory for

More information

Introduction to Density Functional Theory

Introduction to Density Functional Theory Introduction to Density Functional Theory S. Sharma Institut für Physik Karl-Franzens-Universität Graz, Austria 19th October 2005 Synopsis Motivation 1 Motivation : where can one use DFT 2 : 1 Elementary

More information

NWChem: Hartree-Fock, Density Functional Theory, Time-Dependent Density Functional Theory

NWChem: Hartree-Fock, Density Functional Theory, Time-Dependent Density Functional Theory NWChem: Hartree-Fock, Density Functional Theory, Time-Depent Density Functional Theory Hartree-Fock! Functionality! Input! Wavefunctions! Initial MO vectors! Direct and semidirect algorithms! Convergence,

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

TDDFT in Chemistry and Biochemistry III

TDDFT in Chemistry and Biochemistry III TDDFT in Chemistry and Biochemistry III Dmitrij Rappoport Department of Chemistry and Chemical Biology Harvard University TDDFT Winter School Benasque, January 2010 Dmitrij Rappoport (Harvard U.) TDDFT

More information

Session 1. Introduction to Computational Chemistry. Computational (chemistry education) and/or (Computational chemistry) education

Session 1. Introduction to Computational Chemistry. Computational (chemistry education) and/or (Computational chemistry) education Session 1 Introduction to Computational Chemistry 1 Introduction to Computational Chemistry Computational (chemistry education) and/or (Computational chemistry) education First one: Use computational tools

More information

Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues

Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues PHYSICAL REVIEW B VOLUME 55, NUMBER 24 15 JUNE 1997-II Generalized generalized gradient approximation: An improved density-functional theory for accurate orbital eigenvalues Xinlei Hua, Xiaojie Chen, and

More information

Consequently, the exact eigenfunctions of the Hamiltonian are also eigenfunctions of the two spin operators

Consequently, the exact eigenfunctions of the Hamiltonian are also eigenfunctions of the two spin operators VI. SPIN-ADAPTED CONFIGURATIONS A. Preliminary Considerations We have described the spin of a single electron by the two spin functions α(ω) α and β(ω) β. In this Sect. we will discuss spin in more detail

More information

Oslo node. Highly accurate calculations benchmarking and extrapolations

Oslo node. Highly accurate calculations benchmarking and extrapolations Oslo node Highly accurate calculations benchmarking and extrapolations Torgeir Ruden, with A. Halkier, P. Jørgensen, J. Olsen, W. Klopper, J. Gauss, P. Taylor Explicitly correlated methods Pål Dahle, collaboration

More information

MRCI calculations in MOLPRO

MRCI calculations in MOLPRO 1 MRCI calculations in MOLPRO Molpro is a software package written in Fortran and maintained by H.J. Werner and P.J. Knowles. It is often used for performing sophisticated electronic structure calculations,

More information

Introduction to Density Functional Theory

Introduction to Density Functional Theory 1 Introduction to Density Functional Theory 21 February 2011; V172 P.Ravindran, FME-course on Ab initio Modelling of solar cell Materials 21 February 2011 Introduction to DFT 2 3 4 Ab initio Computational

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

Minnesota Functional Module Version 2.0

Minnesota Functional Module Version 2.0 1 Minnesota Functional Module Version 2.0 Subroutines for evaluating the M05, M05-2X, M06-L, M06-HF, M06, M06-2X, M08-HX, M08-SO, M11, M11-L, MN12-L, GAM, MN15-L, MN15, SOGGA, SOGGA11, SOGGA11-X, N12,

More information

Exact diagonalization methods

Exact diagonalization methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Exact diagonalization methods Anders W. Sandvik, Boston University Representation of states in the computer bit

More information

Assessment of range-separated time-dependent density-functional theory for calculating C 6 dispersion coefficients

Assessment of range-separated time-dependent density-functional theory for calculating C 6 dispersion coefficients 1/10 Assessment of range-separated time-dependent density-functional theory for calculating C 6 dispersion coefficients Julien Toulouse 1,2, Elisa Rebolini 1, Tim Gould 3, John F. Dobson 3, Prasenjit Seal

More information

MANUAL Minnesota Functional Module

MANUAL Minnesota Functional Module 1 MANUAL Minnesota Functional Module Version 4.0 Subroutines for evaluating the following exchange-correlation functionals: GAM, M05, M05-2X, M06, M06-2X, M06-HF, M06-L, M08-HX, M08-SO, M11, M11-L, MN12-L,

More information

1 Density functional theory (DFT)

1 Density functional theory (DFT) 1 Density functional theory (DFT) 1.1 Introduction Density functional theory is an alternative to ab initio methods for solving the nonrelativistic, time-independent Schrödinger equation H Φ = E Φ. The

More information

Band calculations: Theory and Applications

Band calculations: Theory and Applications Band calculations: Theory and Applications Lecture 2: Different approximations for the exchange-correlation correlation functional in DFT Local density approximation () Generalized gradient approximation

More information

Numerical differentiation

Numerical differentiation Chapter 3 Numerical differentiation 3.1 Introduction Numerical integration and differentiation are some of the most frequently needed methods in computational physics. Quite often we are confronted with

More information

Electronic structures of one-dimension carbon nano wires and rings

Electronic structures of one-dimension carbon nano wires and rings IOP Publishing Journal of Physics: Conference Series 61 (2007) 252 256 doi:10.1088/1742-6596/61/1/051 International Conference on Nanoscience and Technology (ICN&T 2006) Electronic structures of one-dimension

More information

Kinetic-energy systems, density scaling, and homogeneity relations in density-functional theory

Kinetic-energy systems, density scaling, and homogeneity relations in density-functional theory PHYSICAL REVIEW A VOLUME 59, NUMBER 4 APRIL 1999 Kinetic-energy systems, density scaling, and homogeneity relations in density-functional theory Garnet Kin-Lic Chan and Nicholas C. Handy Department of

More information

Post Hartree-Fock: MP2 and RPA in CP2K

Post Hartree-Fock: MP2 and RPA in CP2K Post Hartree-Fock: MP2 and RPA in CP2K A tutorial Jan Wilhelm jan.wilhelm@chem.uzh.ch 4 September 2015 Further reading MP2 and RPA by Mauro Del Ben, Jürg Hutter, Joost VandeVondele Del Ben, M; Hutter,

More information

arxiv:cond-mat/ v1 10 May 1996

arxiv:cond-mat/ v1 10 May 1996 Cohesive energies of cubic III-V semiconductors Beate Paulus, Peter Fulde Max-Planck-Institut für Physik komplexer Systeme, Bayreuther Str. 40, 01187 Dresden, Germany arxiv:cond-mat/9605064v1 10 May 1996

More information

7/29/2014. Electronic Structure. Electrons in Momentum Space. Electron Density Matrices FKF FKF. Ulrich Wedig

7/29/2014. Electronic Structure. Electrons in Momentum Space. Electron Density Matrices FKF FKF. Ulrich Wedig Electron Density Matrices Density matrices Γ, an alternative to the wavefunction Ψ, for the description of a quantum system Electronic Structure The N-particle density matrix Electrons in Momentum Space

More information

Ultrasoft pseudopotentials for lanthanide solvation complexes: Core or valence character of the 4f electrons

Ultrasoft pseudopotentials for lanthanide solvation complexes: Core or valence character of the 4f electrons Ultrasoft pseudopotentials for lanthanide solvation complexes: Core or valence character of the 4f electrons Rodolphe Pollet, C. Clavaguéra, J.-P. Dognon To cite this version: Rodolphe Pollet, C. Clavaguéra,

More information

Notes on GGA 9/1/04 NAWH. General Equations: E xc = d 3 rf(n(r), n(r) ). (1) n n. ( f(n, n ) ). (2) v xc (r) = n n. Using FFT s n(r) = G

Notes on GGA 9/1/04 NAWH. General Equations: E xc = d 3 rf(n(r), n(r) ). (1) n n. ( f(n, n ) ). (2) v xc (r) = n n. Using FFT s n(r) = G Notes on GGA 9//04 NAWH General Equations: v xc r = E xc = d 3 rfnr, nr. fn, fn, n. 2 Using FFT s nr = G ñge ig r. 3 [ nr = G G x ñge ig r 2 + G G y ñge ig r 2 + G G z ñge ig r 2 ] /2. 4 Algorithm to calculate

More information

Adiabatic connection for near degenerate excited states

Adiabatic connection for near degenerate excited states PHYSICAL REVIEW A 69, 052510 (2004) Adiabatic connection for near degenerate excited states Fan Zhang Department of Physics and Astronomy, Rutgers University, 136 Frelinghuysen Road, Piscataway, New Jersey

More information

Contents. basic algebra. Learning outcomes. Time allocation. 1. Mathematical notation and symbols. 2. Indices. 3. Simplification and factorisation

Contents. basic algebra. Learning outcomes. Time allocation. 1. Mathematical notation and symbols. 2. Indices. 3. Simplification and factorisation basic algebra Contents. Mathematical notation and symbols 2. Indices 3. Simplification and factorisation 4. Arithmetic of algebraic fractions 5. Formulae and transposition Learning outcomes In this workbook

More information

Finite-Temperature Hartree-Fock Exchange and Exchange- Correlation Free Energy Functionals. Travis Sjostrom. IPAM 2012 Workshop IV

Finite-Temperature Hartree-Fock Exchange and Exchange- Correlation Free Energy Functionals. Travis Sjostrom. IPAM 2012 Workshop IV 1 of 45 Finite-Temperature Hartree-Fock Exchange and Exchange- Correlation Free Energy Functionals Travis Sjostrom Quantum Theory Project Depts. of Physics and Chemistry IPAM 2012 Workshop IV 2012 2 of

More information

Sloppy Nuclear Energy Density Functionals: effective model optimisation. T. Nikšić and D. Vretenar

Sloppy Nuclear Energy Density Functionals: effective model optimisation. T. Nikšić and D. Vretenar Sloppy Nuclear Energy Density Functionals: effective model optimisation T. Nikšić and D. Vretenar Energy Density Functionals the nuclear many-body problem is effectively mapped onto a one-body problem

More information

Electronic Supplementary Information

Electronic Supplementary Information Electronic Supplementary Material (ESI) for CrystEngComm. This journal is The Royal Society of Chemistry 2014 Electronic Supplementary Information Configurational and energetical study of the (100) and

More information

Key concepts in Density Functional Theory

Key concepts in Density Functional Theory From the many body problem to the Kohn-Sham scheme ILM (LPMCN) CNRS, Université Lyon 1 - France European Theoretical Spectroscopy Facility (ETSF) December 12, 2012 Lyon Outline 1 The many-body problem

More information

Hartree-Fock-Roothan Self-Consistent Field Method

Hartree-Fock-Roothan Self-Consistent Field Method Hartree-Fock-Roothan Self-Consistent Field Method 1. Helium Here is a summary of the derivation of the Hartree-Fock equations presented in class. First consider the ground state of He and start with with

More information

The Binding of Ag+ and Au+ to Ethene

The Binding of Ag+ and Au+ to Ethene Chemistry Publications Chemistry 3-2009 The Binding of Ag and Au to Ethene Nina J. Barnett Iowa State University Lyudmila V. Slipchenko Iowa State University Mark S. Gordon Iowa State University, mgordon@iastate.edu

More information

Introduction to Density Functional Theory (DFT)

Introduction to Density Functional Theory (DFT) Introduction to Density Functional Theory (DFT) Brad Malone, Sadas Shankar The Problem: What's the big deal? Materials we are often interested in contain a macroscopically large number of particles (~1023

More information