Benzene Dimer: dispersion forces and electronic correlation

Size: px
Start display at page:

Download "Benzene Dimer: dispersion forces and electronic correlation"

Transcription

1 Benzene Dimer: dispersion forces and electronic correlation Introduction The Benzene dimer is an ideal example of a system bound by π-π interaction, which is in several cases present in many biologically relevant systems (stacking interactions in DNA base pairs, aromatic side-chain interactions in proteins). An accurate description of the π-π interaction is in general a challenging task for the computational methods, since noncovalent interaction between benzene rings results in a very shallow potential energy surface (PES). Such interaction in benzene dimers has mainly three components: electrostatic quadrupolequadrupole interactions (dipolar terms are obviously vanishing for symmetry reasons) - attractive or repulsive; dispersion forces - attractive, such as London s; exchange repulsion energy [1]. The subtle interplay between such components results into few minimal-energy dimer arrangements, the most important ones are known as T-shaped and parallel displaced (PD). Both T-shaped and PD dimers are found in both gas-phase and solid-state structures, with a larger stability of the T-shaped in the first case and a larger abundance of the PD in the latter. Being more relevant for the analogies with biological systems, we will mainly concentrate today on the parallel displacement (PD) dimer [2]. Due to such complex effects, this is an excellent test case for comparing different computational methods. We will test three levels of theory: 1. B3LYP is one of the most common DFT functionals, widely used in the physical-chemistry literature for many types of calculations. It is based on an approximate treatment of the exchangecorrelation energy, so that in some cases such a functional could be inappropriate. 2. a simple, empirical (and computationally cheap) correction to B3LYP for the dispersion interactions has been introduced by Grimme, and the corrected functional is usually referred to as the B3LYP-D3. 3. a more refined (and more computationally expensive) method, based on the second order Rayleigh-Schroedinger perturbation treatment of the electronic correlation is the Moller-Plesset (MP2) method on the Hartree Fock results. It is worth noting that there exist many other methods able to provide a more accurate treatment of the correlation, rooted into wavefunction theories (based on multideterminant expansions of the wavefunction and usually referred to as the post-hartree-fock methods), Green function approaches (GW) and many body theories. Unfortunately, such methods are very demanding from a computational point of view, and for our system we chose the MP2 method as the optimal compromise between the computational feasibility and the accuracy in the treatment of the correlation. Thus, MP2 will be used as reference for the other methods. In this tutorial you will sample the PES of a benzene dimer along the stacking coordinate of the PD dimer, using these three levels of theory (B3LYP, B3LYP-D3 and MP2). Optionally, you could also test the B2PLYP functional, which is an intermediate level of theory between the B3LYP and the MP2 methods. The other coordinate (displacement) could be also investigated optionally. The gaussian basis set which will be used throughout the tutorial is the Pople s 6-31G(d,p) basis set. Such a basis belongs to the family of the double-zeta basis sets, augmented with diffuse (d) and polarization (p) functions. Using such methods, we will calculate the binding energy as a function of the distance between the monomers (the stacking coordinate), and determine which one appears to be the most appropriate computational method for this system and why. The binding energy (ΔE bind ) as a function of the intermolecular distance (R) can be evaluated with the supramolecular approach, as the difference between the total energy of the dimer and the total energy of the two infinitely distant monomers ΔE bind (R) = E dimer (R) - 2 E momer Generally speaking, a sampling of a molecular PES could be performed either by a series of singlepoint calculations on user-given input geometries, or in an automatized way, implemented in gaussian by the scan keyword. For the latter, the coordinate R corresponding to PES sampling must be defined in internal coordinates in the input file). In this tutorial we will follow the first approach for

2 didactic purposes, and an expert user could still automatize the input preparation by the knowledge of the shell commanding language (i.e. bash). As a final remark, it is worth noting that the binding energies at any point of the PES should be corrected for the Basis Set Superposition Error (BSSE) [1], which is a source of error occurring whenever fragmented systems are treated, due to the finite basis set size. Such an error is usually small when large basis sets are used (possibly including polarization and diffuse functions). In this tutorial we will neglect BSSE: for further reading see [1,3,4]. Procedure Setup: login to vm-linux-cecam-ad.sissa.it with your yoursissausername ssh X yoursissausername@vm-linux-cecam-ad.sissa.it A. Perform a scan along the intramolecular distance of the benzene dimer - part 1 1. in the /scratch/qm_school folder you will find a directory benzene_dimer with the files needed for this exercise Inside the directory you will find a coordinates file (benzene_eq.xyz) in which you have the equilibrium position (optimized geometry) of the parallel displaced benzene dimer obtained at the MP2 level of theory. 2. In this geometry the two benzene rings lie at different z values. All the atoms in the first benzene monomer have the same quota (z=0.0). You can generate different geometries by manually varying the z coordinate of all the atoms of that monomer. We suggest to generate 5 geometries by increasing z (i.e. reducing distance between monomers) with a step of 0.2 Angstrom, and 7 geometries by decreasing z (i.e. increasing distance between monomer) by 0.2 Angstrom and save each geometry in the xyz format. Eventually, you will have 13 xyz files (one file for the equilibrium position z=0, then 5 files with positive z values, 7 files with negative z values). You could later on extend this scan (see OPTIONALS). 3. Copy (or rename) each xyz file giving the gaussian input extension (com) cp geometry_1.xyz geometry_mp2_1.com 4. Open each com file and add the specifications for the number of processors to be used, memory, and methods. Each gaussian input file should appear as %nprocs=4! number of processors %mem=2gb! memory %chk=geometry_mp2_1.chk! a binary repository where the data are saved #p MP2/6-31G(d,p)! method/basis set scf=tight int=ultrafine! convergence criteria! blank line benzene dimer with z=0.4! comment line! blank line 0 1! total charge and spin multiplicity C ! atomic label and cartesian coordinates of all the atoms [...]! [other coordinate lines]! blank line (DON T FORGET this one!!) Just use the B3LYP (and B2PLYP) keywords in place of MP2 when you create the input files for B3LYP and B2PLYP methods, respectively. For the B3LYP-d3 method, the fourth line should be #p B3LYP/6-31G(d,p) EmpiricalDispersion=GD3 We suggest to create a folder relative to each method you are using with the mkdir command, e.g.

3 mkdir b3lyp In case you want a better explanation of the keyword you are using have a look at: For each level of theory you need to perform also a single point calculation on the benzene monomer (see the formula in the introduction). To do so, create one gaussian input file for the monomer for each method. The geometry of the monomer can be taken from the starting file we provided (benzene_eq.xyz), by considering only the first 12 atoms (first monomer). 6. Copy the input files you have generated on the cluster in which you will run the calculations, e.g. scp geometry_mp2_1.com yourcinecausername@login.galileo.cineca.it: in the same folder we have provided you there is also a job submission script g09.sh. Copy also this file to the cluster: scp g09.sh yourcinecausername@login.galileo.cineca.it: Now you will find in the home directory of the clusters the geometries on which to run the calculations and g09.sh file which is the script file to send the calculations on the cluster. In the following we will use XX=B3LYP, MP2, etc. to mean the string equivalent to the method (level of theory), which inputs and outputs filenames are named after. The g09.sh file appears as #!/bin/bash #PBS -l select=1:ncpus=4 #PBS -l walltime=1:00:00 #PBS -e myjob.err #PBS -o myjob.out #PBS -A train_ccecam17 #PBS -q R #PBS -W group_list=train_ccecam17 cd $PBS_O_WORKDIR module load g09. $g09root/g09/bsd/g09.profile # for bash script # source $g09root/g09/bsd/g09.login # for csh script export GAUSS_SCRDIR=$CINECA_SCRATCH/g09_$PBS_JOBID # def. tmp folder in $CINECA_SCRATCH mkdir -p $GAUSS_SCRDIR # the dir must exist g09 < geometry_mp2_1.com > geometry_mp2_1.log g09 < geometry_mp2_2.com > geometry_mp2_2.log g09 < geometry_mp2_3.com > geometry_mp2_3.log g09 < geometry_mp2_4.com > geometry_mp2_4.log g09 < geometry_mp2_5.com > geometry_mp2_5.log g09 < geometry_mp2_6.com > geometry_mp2_6.log rmdir $GAUSS_SCRDIR # remove tmp folder (works only if empty) this script contains the needed commands to submit the calculation using the com input and sending the output in a log file. The g09.sh script need to be present in each directory from which you send the calculations (each directory will contain the input files.com and the corresponding g09.sh script).

4 7. The calculation can be sent on the PBS queue for execution, with the command qsub g09.sh which should be runned for each folder containing your g09 inputs. To check if the calculations are running use the command qstat qstat u yourcinecausername if a R appears close to you job this is running, if a Q appears the job is still queuing For more information have a look to this web page: - UG2.5.1:BatchSchedulerPBS-RunningapplicationsusingPBS In the meanwhile, (while the calculations run.) B. Exploring optimized geometries produced with different methods We have already optimized the geometry of the parallel displaced benzene dimer using different level of theories. We started the geometry optimization exactly from the same coordinates and we performed geometry optimization at different levels of theory. We will directly provide you the resulting optimization outputs, so that you could directly see how the geometry is changing to minimize the energy (i.e. the geometry optimization procedure). 1. Locally (on the local sissa machine), start Gaussview. i.e. Type: gaussview 2. go to the /scratch/qm/_school/benzene_dimer/minimized_geometries Here you will find the output files and for your curiosity the input files we have used for each optimization. You will find one directory for each method (b3lyp, B3lyp-d3, B2plyp, mp2). In addition you will find also geometry optimizations with the pure DFT (non-hybrid) BLYP functional (blyp) and the Hartree- Fock (HF) method (hf). 3. Visualize the output and follow the geometry changes with Gaussview. What are the main differences that you see in the optimized geometries (with respect to the input ones) of the benzene dimer obtained at the different levels of theory? Once the calculations are finished A. Perform a scan along the intramolecular distance of the benzene dimer - part 2 8. Once the calculations are finished, you can compute the binding energy profiles, as a function of the intermolecular distance using the formula in the Introduction. The electronic energies E dimer (in Hartree units) we need for the B3LYP and B3LYP-d3 methods can be found in the log files in correspondence to the SCF Done string. Analogously, E momer can be found in the monomer log files. For the MP2 method, the SCF Done string will report only the SCF energy. After the SCF, Gaussian computes the correlation energy with the perturbation theory. The second order correlation correction to the SCF energy is printed as E2 =. In the same line, the total MP2 energy (SCF plus E2) is printed as EUMP2. (Optional) The B2PLYP method works in a quite similar way as the MP2 method, so that the SCF Done string will report only SCF energy, the second order correction to the SCF energy is printed as E2(B2PLYP) and in the same line the total B2PLYP energy (SCF plus E2) is printed as E(B2PLYP).

5 The binding energies are usually given in kcal/mol in the most common chemistry literature. In order to convert from Hartree to kcal/mol just multiply by Create an ascii text files, by listing on the first column the relative displacement from the equilibrium structure of the first monomers (i.e. the z coordinate, being z=0 the equilibrium dimer structure) and in the second column the binding energy of the dimer at each point. For each method, you have used add an additional column in the file. You can collect this data on the local SISSA machine. 10. Visualize the output with any graphical program, like xmgrace package: Type on your local window xmgrace nxy filename 11. Looking at the graph try to rationalize the differences also with respect to the geometry optimizations you have visualized before. OPTIONALS: If there is time left or if you feel particularly confident and fast in the procedure ;) 11 [OPTIONAL 1]. You could decide to improve the scan by increasing the density (i.e. making an intermediate steps) making the curve smoother, or by extending the overall scanned distance. 12 [OPTIONAL 2]. You could decide to similarly investigate the parallel-displacement coordinate (according to the input geometry, the y coordinate). This would produce another sets of coordinates and an equivalent series of calculations describing the energy profile (PES) along this other coordinate. References [1] Pavel Hobza, Heinrich L. Selzle, Edward W. Schlag Structure and Properties of Benzene-Containing Molecular Clusters: Nonempirical ab Initio Calculations and Experiments, Chem. Rev., 1994, 94 (7), pp [2] Non-Covalent Interactions : Theory and Experiment, Chapter 3: Potential-Energy and Free-Energy Surfaces Pavel Hobza, Klaus Müller-Dethlefs; print publication date: 18 Nov 2009 [3] S. Grimme, J. Antony, S. Ehrlich and H. Krieg, A consistent and accurate ab initio parameterization of density functional dispersion correction (DFT-D) for the 94 elements H-Pu, J. Chem. Phys., 132 (2010) [4] S. Simon, M. Duran, and J. J. Dannenberg, How does basis set superposition error change the potential surfaces for hydrogen bonded dimers?, J. Chem. Phys., 105 (1996)

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations

IFM Chemistry Computational Chemistry 2010, 7.5 hp LAB2. Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Computer laboratory exercise 1 (LAB2): Quantum chemical calculations Introduction: The objective of the second computer laboratory exercise is to get acquainted with a program for performing quantum chemical

More information

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2)

QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) QUANTUM CHEMISTRY WITH GAUSSIAN : A VERY BRIEF INTRODUCTION (PART 2) TARAS V. POGORELOV AND MIKE HALLOCK SCHOOL OF CHEMICAL SCIENCES, UIUC This tutorial continues introduction to Gaussian [2]. Here we

More information

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued

CHE3935. Lecture 4 Quantum Mechanical Simulation Methods Continued CHE3935 Lecture 4 Quantum Mechanical Simulation Methods Continued 1 OUTLINE Review Introduction to CPMD MD and ensembles The functionals of density functional theory Return to ab initio methods Binding

More information

Introduction to Hartree-Fock calculations in Spartan

Introduction to Hartree-Fock calculations in Spartan EE5 in 2008 Hannes Jónsson Introduction to Hartree-Fock calculations in Spartan In this exercise, you will get to use state of the art software for carrying out calculations of wavefunctions for molecues,

More information

4 Post-Hartree Fock Methods: MPn and Configuration Interaction

4 Post-Hartree Fock Methods: MPn and Configuration Interaction 4 Post-Hartree Fock Methods: MPn and Configuration Interaction In the limit of a complete basis, the Hartree-Fock (HF) energy in the complete basis set limit (ECBS HF ) yields an upper boundary to the

More information

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Homework 3 Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Email to: jqian@caltech.edu Introduction In this assignment, you will be using a commercial periodic

More information

Introduction to Computational Chemistry Exercise 2

Introduction to Computational Chemistry Exercise 2 Introduction to Computational Chemistry Exercise 2 Intermolecular interactions and vibrational motion Lecturer: Antti Lignell Name Introduction In this computer exercise, we model intermolecular interactions

More information

Introduction to Hartree-Fock calculations using ORCA and Chemcraft

Introduction to Hartree-Fock calculations using ORCA and Chemcraft Introduction to Hartree-Fock calculations using ORCA and Chemcraft In this exercise, you will get to use software for carrying out calculations of wavefunctions for molecules, the ORCA program. While ORCA

More information

Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans

Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans Assignment A02: Geometry Definition: File Formats, Redundant Coordinates, PES Scans In Assignments A00 and A01, you familiarized yourself with GaussView and G09W, you learned the basics about input (GJF)

More information

Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule. Vesa Hänninen

Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule. Vesa Hänninen Introduction to computational chemistry Exercise I: Structure and electronic energy of a small molecule Vesa Hänninen 1 Introduction In this exercise the equilibrium structure and the electronic energy

More information

Calculating Bond Enthalpies of the Hydrides

Calculating Bond Enthalpies of the Hydrides Proposed Exercise for the General Chemistry Section of the Teaching with Cache Workbook: Calculating Bond Enthalpies of the Hydrides Contributed by James Foresman, Rachel Fogle, and Jeremy Beck, York College

More information

Tutorial I: IQ MOL and Basic DFT and MP2 Calculations 1 / 30

Tutorial I: IQ MOL and Basic DFT and MP2 Calculations 1 / 30 Tutorial I: IQ MOL and Basic DFT and MP2 Calculations Q-Chem User Workshop, Denver March 21, 2015 1 / 30 2 / 30 Introduction to IQMOL DFT and MP2 Calculations 3 / 30 IQMOL and Q-CHEM IQMOL is an open-source

More information

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C

QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C Chemistry 460 Fall 2017 Dr. Jean M. Standard November 6, 2017 QUANTUM CHEMISTRY PROJECT 3: PARTS B AND C PART B: POTENTIAL CURVE, SPECTROSCOPIC CONSTANTS, AND DISSOCIATION ENERGY OF DIATOMIC HYDROGEN (20

More information

QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE

QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE Chemistry 460 Fall 2017 Dr. Jean M. Standard November 1, 2017 QUANTUM CHEMISTRY PROJECT 3: ATOMIC AND MOLECULAR STRUCTURE OUTLINE In this project, you will carry out quantum mechanical calculations of

More information

Chemistry 4021/8021 Computational Chemistry 3/4 Credits Spring Semester 2013 ( Due 4 / 10 / 12 )

Chemistry 4021/8021 Computational Chemistry 3/4 Credits Spring Semester 2013 ( Due 4 / 10 / 12 ) Chemistry 4021/8021 Computational Chemistry 3/4 Credits Spring Semester 2013 ( Due 4 / 10 / 12 ) This problem set will take longer than the last one in the sense that you will almost certainly need to

More information

计算物理作业二. Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit.

计算物理作业二. Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit. 计算物理作业二 Excercise 1: Illustration of the convergence of the dissociation energy for H 2 toward HF limit. In this exercise, basis indicates one of the following basis sets: STO-3G, cc-pvdz, cc-pvtz, cc-pvqz

More information

Performance of Hartree-Fock and Correlated Methods

Performance of Hartree-Fock and Correlated Methods Chemistry 460 Fall 2017 Dr. Jean M. Standard December 4, 2017 Performance of Hartree-Fock and Correlated Methods Hartree-Fock Methods Hartree-Fock methods generally yield optimized geomtries and molecular

More information

Fragmentation methods

Fragmentation methods Fragmentation methods Scaling of QM Methods HF, DFT scale as N 4 MP2 scales as N 5 CC methods scale as N 7 What if we could freeze the value of N regardless of the size of the system? Then each method

More information

NMR and IR spectra & vibrational analysis

NMR and IR spectra & vibrational analysis Lab 5: NMR and IR spectra & vibrational analysis A brief theoretical background 1 Some of the available chemical quantum methods for calculating NMR chemical shifts are based on the Hartree-Fock self-consistent

More information

Chem 253. Tutorial for Materials Studio

Chem 253. Tutorial for Materials Studio Chem 253 Tutorial for Materials Studio This tutorial is designed to introduce Materials Studio 7.0, which is a program used for modeling and simulating materials for predicting and rationalizing structure

More information

Exercise 1: Structure and dipole moment of a small molecule

Exercise 1: Structure and dipole moment of a small molecule Introduction to computational chemistry Exercise 1: Structure and dipole moment of a small molecule Vesa Hänninen 1 Introduction In this exercise the equilibrium structure and the dipole moment of a small

More information

Example: H 2 O (the car file)

Example: H 2 O (the car file) Example: H 2 O (the car file) As a practical example of DFT methods we calculate the energy and electronic properties of the water molecule. In order to carry out the DFT calculation you will need a set

More information

Transition states and reaction paths

Transition states and reaction paths Transition states and reaction paths Lab 4 Theoretical background Transition state A transition structure is the molecular configuration that separates reactants and products. In a system with a single

More information

Gustavus Adolphus College. Lab #5: Computational Chemistry

Gustavus Adolphus College. Lab #5: Computational Chemistry CHE 372 Gustavus Adolphus College Lab #5: Computational Chemistry Introduction In this investigation we will apply the techniques of computational chemistry to several of the molecular systems that we

More information

Jaguar DFT Optimizations and Transition State Searches

Jaguar DFT Optimizations and Transition State Searches Jaguar DFT Optimizations and Transition State Searches Density Functional Theory (DFT) is a quantum mechanical (QM) method that gives results superior to Hartree Fock (HF) in less computational time. A

More information

Supporting Information: Predicting the Ionic Product of Water

Supporting Information: Predicting the Ionic Product of Water Supporting Information: Predicting the Ionic Product of Water Eva Perlt 1,+, Michael von Domaros 1,+, Barbara Kirchner 1, Ralf Ludwig 2, and Frank Weinhold 3,* 1 Mulliken Center for Theoretical Chemistry,

More information

Conformational energy analysis

Conformational energy analysis Lab 3 Conformational energy analysis Objective This computational project deals with molecular conformations the spatial arrangement of atoms of molecules. Conformations are determined by energy, so the

More information

XYZ file format Protein Data Bank (pdb) file format Z - matrix

XYZ file format Protein Data Bank (pdb) file format Z - matrix Chemistry block (exercise 1) In this exercise, students will be introduced how to preform simple quantum chemical calculations. Input files for Gaussian09. Output file structure. Geometry optimization,

More information

John Keller Department of Chemistry & Biochemistry University of Alaska Fairbanks

John Keller Department of Chemistry & Biochemistry University of Alaska Fairbanks 10/15/2016 1 WebMO & Gaussian John Keller Department of Chemistry & Biochemistry University of Alaska Fairbanks Corrections and updates 9-5-2017 SCHEDULE 9-10 Intro and basic operation of WebMO and MOPAC

More information

Chemistry 4560/5560 Molecular Modeling Fall 2014

Chemistry 4560/5560 Molecular Modeling Fall 2014 Final Exam Name:. User s guide: 1. Read questions carefully and make sure you understand them before answering (if not, ask). 2. Answer only the question that is asked, not a different question. 3. Unless

More information

This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry.

This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry. 1 Computational Chemistry (Quantum Chemistry) Primer This is a very succinct primer intended as supplementary material for an undergraduate course in physical chemistry. TABLE OF CONTENTS Methods...1 Basis

More information

Materials that you may find helpful when working through this exercise

Materials that you may find helpful when working through this exercise Detailed steps illustrating how to use VASP on the Suns in Fitz 177 For use in lab: 11/10/2009 (Original file by Dr. Rachel Getman, 11/18/2007. Editted for use by Dorrell McCalman 11/09/2009.) Note on

More information

Project 3: Molecular Orbital Calculations of Diatomic Molecules. This project is worth 30 points and is due on Wednesday, May 2, 2018.

Project 3: Molecular Orbital Calculations of Diatomic Molecules. This project is worth 30 points and is due on Wednesday, May 2, 2018. Chemistry 362 Spring 2018 Dr. Jean M. Standard April 20, 2018 Project 3: Molecular Orbital Calculations of Diatomic Molecules In this project, you will investigate the molecular orbitals and molecular

More information

Theoretical UV/VIS Spectroscopy

Theoretical UV/VIS Spectroscopy Theoretical UV/VIS Spectroscopy Why is a Ruby Red When Chromium Oxide is Green? How Does a Ruby Laser Work? Goals of this Exercise: - Calculation of the energy of electronically excited states - Understanding

More information

Lecture 4: methods and terminology, part II

Lecture 4: methods and terminology, part II So theory guys have got it made in rooms free of pollution. Instead of problems with the reflux, they have only solutions... In other words, experimentalists will likely die of cancer From working hard,

More information

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields Department of Chemistry and Biochemistry, Concordia University! page 1 of 6 CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields INTRODUCTION The goal of this tutorial

More information

Non-equilibrium Green s Function Calculations with TranSIESTA. a Tutorial

Non-equilibrium Green s Function Calculations with TranSIESTA. a Tutorial Non-equilibrium Green s Function Calculations with TranSIESTA a Tutorial Svante Hedström*, Subhajyoti Chaudhuri, Christian F. A. Negre, Wendu Ding, Adam J. Matula, and Victor S. Batista Yale University,

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

Introduction to Ab Initio Quantum Chemical Computation

Introduction to Ab Initio Quantum Chemical Computation c:\374-17\computation\computation17.doc for 9mar17 Prof. Patrik Callis 8mar17 Introduction to Ab Initio Quantum Chemical Computation Purpose: 1. To become acquainted with basic concepts of ab initio quantum

More information

Conformational space and energetics of biomolecules: Physical concepts and performance of DFT based methods

Conformational space and energetics of biomolecules: Physical concepts and performance of DFT based methods Conformational space and energetics of biomolecules: Physical concepts and performance of DFT based methods Alexandre Tkatchenko, Carsten Baldauf, Matti Ropo Practical Session III / Weekend Project Haber

More information

Computational Chemistry Using the University of Alaska WebMO Site

Computational Chemistry Using the University of Alaska WebMO Site 2/7/2017 1 Computational Chemistry Using the University of Alaska WebMO Site John Keller Department of Chemistry & Biochemistry University of Alaska Fairbanks Intro and operation of WebMO and MOPAC Basic

More information

Computational Material Science Part II-1: introduction. Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica

Computational Material Science Part II-1: introduction. Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica Computational Material Science Part II-1: introduction Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica Outline Introduction of Computational Material Science (CMS) Density Functional Theory

More information

Advanced usage of MOLCAS. Ex. 1. Usage of Symmetry in Molcas

Advanced usage of MOLCAS. Ex. 1. Usage of Symmetry in Molcas Advanced usage of MOLCAS Ex 1. Symmetry in Molcas (20 min). Ex 2. Transition state optimization (30 min). Ex 3. Ways to run RASSCF program (30 min). Ex 4. Optional. Using EXPBAS module (20 min) Ex 5. Optional.

More information

Jack Smith. Center for Environmental, Geotechnical and Applied Science. Marshall University

Jack Smith. Center for Environmental, Geotechnical and Applied Science. Marshall University Jack Smith Center for Environmental, Geotechnical and Applied Science Marshall University -- Division of Science and Research WV Higher Education Policy Commission WVU HPC Summer Institute June 20, 2014

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

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

Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2004 ( Due 4 / 5 / 04 )

Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2004 ( Due 4 / 5 / 04 ) Chemistry 5021/8021 Computational Chemistry 3/4 Credits Spring Semester 2004 ( Due 4 / 5 / 04 ) This problem set will take longer than the last one in the sense that you may need to submit some jobs, leave,

More information

Supplementary Information for Electronic signature of the instantaneous asymmetry in the first coordination shell in liquid water

Supplementary Information for Electronic signature of the instantaneous asymmetry in the first coordination shell in liquid water Supplementary Information for Electronic signature of the instantaneous asymmetry in the first coordination shell in liquid water Thomas D. Kühne 1, 2 and Rustam Z. Khaliullin 1, 1 Institute of Physical

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

Ethene. Introduction. The ethene molecule is planar (i.e. all the six atoms lie in the same plane) and has a high degree of symmetry:

Ethene. Introduction. The ethene molecule is planar (i.e. all the six atoms lie in the same plane) and has a high degree of symmetry: FY1006 Innføring i kvantefysikk og TFY4215 Kjemisk fysikk og kvantemekanikk Spring 2012 Chemical Physics Exercise 1 To be delivered by Friday 27.04.12 Introduction Ethene. Ethylene, C 2 H 4, or ethene,

More information

Chapter: 22. Visualization: Making INPUT File and Processing of Output Results

Chapter: 22. Visualization: Making INPUT File and Processing of Output Results Chapter: 22 Visualization: Making INPUT File and Processing of Output Results Keywords: visualization, input and output structure, molecular orbital, electron density. In the previous chapters, we have

More information

Calculating NMR Chemical Shifts for beta-ionone O

Calculating NMR Chemical Shifts for beta-ionone O Calculating NMR Chemical Shifts for beta-ionone O Molecular orbital calculations can be used to get good estimates for chemical shifts. In this exercise we will calculate the chemical shifts for beta-ionone.

More information

Study of Ozone in Tribhuvan University, Kathmandu, Nepal. Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal

Study of Ozone in Tribhuvan University, Kathmandu, Nepal. Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal Study of Ozone in Tribhuvan University, Kathmandu, Nepal Prof. S. Gurung Central Department of Physics, Tribhuvan University, Kathmandu, Nepal 1 Country of the Mt Everest 2 View of the Mt Everest 3 4 5

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

Chemistry 334 Part 2: Computational Quantum Chemistry

Chemistry 334 Part 2: Computational Quantum Chemistry Chemistry 334 Part 2: Computational Quantum Chemistry 1. Definition Louis Scudiero, Ben Shepler and Kirk Peterson Washington State University January 2006 Computational chemistry is an area of theoretical

More information

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier

Ab initio calculations for potential energy surfaces. D. Talbi GRAAL- Montpellier Ab initio calculations for potential energy surfaces D. Talbi GRAAL- Montpellier A theoretical study of a reaction is a two step process I-Electronic calculations : techniques of quantum chemistry potential

More information

Electron Correlation Methods

Electron Correlation Methods Electron Correlation Methods HF method: electron-electron interaction is replaced by an average interaction E HF c = E 0 E HF E 0 exact ground state energy E HF HF energy for a given basis set HF E c

More information

2~:J~ -ryej- r- 2 Jr. A - f3. sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6.

2~:J~ -ryej- r- 2 Jr. A - f3. sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6. .~, ~ I, sr(djk nv~tor rn~ +~ rvjs (::-CJ) ::;-1-.'--~ -. rhd. ('-.Ji.L.~ )- r'-d)c, -r/~ JJr - 2~d ~2-Jr fn'6.)1e'" 21t-ol Je C'...-------- lj-vi, J? Jr Jr \Ji 2~:J~ -ryej- r- 2 Jr A - f3 c _,~,= ~,.,w._..._.

More information

Lec20 Fri 3mar17

Lec20 Fri 3mar17 564-17 Lec20 Fri 3mar17 [PDF]GAUSSIAN 09W TUTORIAL www.molcalx.com.cn/wp-content/uploads/2015/01/gaussian09w_tutorial.pdf by A Tomberg - Cited by 8 - Related articles GAUSSIAN 09W TUTORIAL. AN INTRODUCTION

More information

Gaussian: Basic Tutorial

Gaussian: Basic Tutorial Input file: # hf sto-g pop=full Water - Single Point Energy 0 H.0 H.0 H 04.5 Route Section Start with # Contains the keywords Gaussian: Basic Tutorial Route Section Title Section Charge-Multiplicity Molecule

More information

Technical Note Calculations of Orbital Overlap Range Function EDR( r ; d) and Overlap Distance D(r )using Multiwfn

Technical Note Calculations of Orbital Overlap Range Function EDR( r ; d) and Overlap Distance D(r )using Multiwfn Technical Note Calculations of Orbital Overlap Range Function EDR( r ; d) and Overlap Distance D(r )using Multiwfn Abstract The orbital overlap range function EDR( r; d) (J. Chem. Phys. 2014, 141, 144104)

More information

Before we start: Important setup of your Computer

Before we start: Important setup of your Computer Before we start: Important setup of your Computer change directory: cd /afs/ictp/public/shared/smr2475./setup-config.sh logout login again 1 st Tutorial: The Basics of DFT Lydia Nemec and Oliver T. Hofmann

More information

An Introduction to Quantum Chemistry and Potential Energy Surfaces. Benjamin G. Levine

An Introduction to Quantum Chemistry and Potential Energy Surfaces. Benjamin G. Levine An Introduction to Quantum Chemistry and Potential Energy Surfaces Benjamin G. Levine This Week s Lecture Potential energy surfaces What are they? What are they good for? How do we use them to solve chemical

More information

Modeling the UV-Vis Absorption of a Series of Dyes CH342L: Spectroscopy February 15, 2016

Modeling the UV-Vis Absorption of a Series of Dyes CH342L: Spectroscopy February 15, 2016 Modeling the UV-Vis Absorption of a Series of Dyes CH342L: Spectroscopy February 15, 2016 We ll correlate the absorbance maximum of a series of dyes with structural changes between them 1. Chemicals absorb

More information

Anion-π and π-π cooperative interactions

Anion-π and π-π cooperative interactions Chapter 5 Anion-π and π-π cooperative interactions 5.1 Introduction The design of selective receptors of anionic species is a very active area of research within supramolecular chemistry due to the potential

More information

Build_model v User Guide

Build_model v User Guide Build_model v.2.0.1 User Guide MolTech Build_model User Guide 2008-2011 Molecular Technologies Ltd. www.moltech.ru Please send your comments and suggestions to contact@moltech.ru. Table of Contents Input

More information

MENA 9520 FME Modelling Tutorial 5 ( )

MENA 9520 FME Modelling Tutorial 5 ( ) MENA 9520 FME Modelling Tutorial 5 (25.02.2011) Task 5: Understanding type of bonding using charge-density plots Exercise 5.1: Visualizing charge density in Si: 1. mkdir charge 2. Copy a converged CTRL

More information

AN AB INITIO STUDY OF INTERMOLECULAR INTERACTIONS OF GLYCINE, ALANINE AND VALINE DIPEPTIDE-FORMALDEHYDE DIMERS

AN AB INITIO STUDY OF INTERMOLECULAR INTERACTIONS OF GLYCINE, ALANINE AND VALINE DIPEPTIDE-FORMALDEHYDE DIMERS Journal of Undergraduate Chemistry Research, 2004, 1, 15 AN AB INITIO STUDY OF INTERMOLECULAR INTERACTIONS OF GLYCINE, ALANINE AND VALINE DIPEPTIDE-FORMALDEHYDE DIMERS J.R. Foley* and R.D. Parra Chemistry

More information

Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher

Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher 429 Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher This appendix contains methods for using Gaussian 09 121 and PGopher 120 to simulate vibrational and electronic bands of molecules.

More information

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University

AN INTRODUCTION TO QUANTUM CHEMISTRY. Mark S. Gordon Iowa State University AN INTRODUCTION TO QUANTUM CHEMISTRY Mark S. Gordon Iowa State University 1 OUTLINE Theoretical Background in Quantum Chemistry Overview of GAMESS Program Applications 2 QUANTUM CHEMISTRY In principle,

More information

Figure 1: Transition State, Saddle Point, Reaction Pathway

Figure 1: Transition State, Saddle Point, Reaction Pathway Computational Chemistry Workshops West Ridge Research Building-UAF Campus 9:00am-4:00pm, Room 009 Electronic Structure - July 19-21, 2016 Molecular Dynamics - July 26-28, 2016 Potential Energy Surfaces

More information

Computational chemistry with GAMESS: a very brief overview with examples

Computational chemistry with GAMESS: a very brief overview with examples Computational chemistry with GAMESS: a very brief overview with examples PHY-6120 Molecular Physics (Spring 2015), UConn Phys. Dept. Feb 17 th 2015 H = ħ2 2μ i Intro: V(R) for diatomic molecules + k Z

More information

QuantumWise. QuantumWise is now part of Synopsys

QuantumWise. QuantumWise is now part of Synopsys Table of Contents Table of Contents NiSi2 Si interface Create the NiSi2/Si device The screening region Increase the length of the central region Set-up the calculation for the undoped device Dope the device

More information

Intermolecular Forces in Density Functional Theory

Intermolecular Forces in Density Functional Theory Intermolecular Forces in Density Functional Theory Problems of DFT Peter Pulay at WATOC2005: There are 3 problems with DFT 1. Accuracy does not converge 2. Spin states of open shell systems often incorrect

More information

Hartree, Hartree-Fock and post-hf methods

Hartree, Hartree-Fock and post-hf methods Hartree, Hartree-Fock and post-hf methods MSE697 fall 2015 Nicolas Onofrio School of Materials Engineering DLR 428 Purdue University nonofrio@purdue.edu 1 The curse of dimensionality Let s consider a multi

More information

A Computer Study of Molecular Electronic Structure

A Computer Study of Molecular Electronic Structure A Computer Study of Molecular Electronic Structure The following exercises are designed to give you a brief introduction to some of the types of information that are now readily accessible from electronic

More information

Katheryn Penrod York College of Pennsylvania Department of Physical Science CHM482 Independent Study Advisor Dr. James Foresman Spring 2014

Katheryn Penrod York College of Pennsylvania Department of Physical Science CHM482 Independent Study Advisor Dr. James Foresman Spring 2014 Katheryn Penrod York College of Pennsylvania Department of Physical Science CHM482 Independent Study Advisor Dr. James Foresman Spring 2014 Functionalization of SWCNTs with Stone-Wales and vacancy defects:

More information

Patrick Lestrange and James B. Foresman, York College of PA C 9 C 10 C 11 C 12 O 13 H 14

Patrick Lestrange and James B. Foresman, York College of PA C 9 C 10 C 11 C 12 O 13 H 14 Physical Chemistry I Laboratory: Conformational Analysis of N-Boc-3-pyrrolidinol Patrick Lestrange and James B. Foresman, York College of PA C 2 C 10 C 9 O 5 C 1 C 4 C 11 C 12 N 8 C 6 C 3 O 13 O 7 H 14

More information

Electric Fields and Equipotentials

Electric Fields and Equipotentials OBJECTIVE Electric Fields and Equipotentials To study and describe the two-dimensional electric field. To map the location of the equipotential surfaces around charged electrodes. To study the relationship

More information

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell)

Chemistry 14CL. Worksheet for the Molecular Modeling Workshop. (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Chemistry 14CL Worksheet for the Molecular Modeling Workshop (Revised FULL Version 2012 J.W. Pang) (Modified A. A. Russell) Structure of the Molecular Modeling Assignment The molecular modeling assignment

More information

Project 2. Chemistry of Transient Species in Planetary Atmospheres: Exploring the Potential Energy Surfaces of CH 2 S

Project 2. Chemistry of Transient Species in Planetary Atmospheres: Exploring the Potential Energy Surfaces of CH 2 S Chemistry 362 Spring 2018 Dr. Jean M. Standard March 21, 2018 Project 2. Chemistry of Transient Species in Planetary Atmospheres: Exploring the Potential Energy Surfaces of CH 2 S In this project, you

More information

A GUI FOR EVOLVE ZAMS

A GUI FOR EVOLVE ZAMS A GUI FOR EVOLVE ZAMS D. R. Schlegel Computer Science Department Here the early work on a new user interface for the Evolve ZAMS stellar evolution code is presented. The initial goal of this project is

More information

QMC dissociation energy of the water dimer: Time step errors and backflow calculations

QMC dissociation energy of the water dimer: Time step errors and backflow calculations QMC dissociation energy of the water dimer: Time step errors and backflow calculations Idoia G. de Gurtubay and Richard J. Needs TCM group. Cavendish Laboratory University of Cambridge Idoia G. de Gurtubay.

More information

Assignment 1: Molecular Mechanics (PART 1 25 points)

Assignment 1: Molecular Mechanics (PART 1 25 points) Chemistry 380.37 Fall 2015 Dr. Jean M. Standard August 19, 2015 Assignment 1: Molecular Mechanics (PART 1 25 points) In this assignment, you will perform some molecular mechanics calculations using the

More information

List of Figures Page Figure No. Figure Caption No. Figure 1.1.

List of Figures Page Figure No. Figure Caption No. Figure 1.1. List of Figures Figure No. Figure Caption Page No. Figure 1.1. Cation- interactions and their modulations. 4 Figure 1.2. Three conformations of benzene dimer, S is not a minimum on the potential energy

More information

Chemistry 883 Computational Quantum Chemistry

Chemistry 883 Computational Quantum Chemistry Chemistry 883 Computational Quantum Chemistry Instructor Contact Information Professor Benjamin G. Levine levine@chemistry.msu.edu 215 Chemistry Building 517-353-1113 Office Hours Tuesday 9:00-11:00 am

More information

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION Calculations predict a stable molecular crystal of N 8 : Barak Hirshberg a, R. Benny Gerber a,b, and Anna I. Krylov c a Institute of Chemistry and The Fritz Haber Center for Molecular Dynamics, The Hebrew

More information

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields

CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields Department of Chemistry and Biochemistry, Concordia University page 1 of 6 CHEM 498Q / CHEM 630Q: Molecular Modeling of Proteins TUTORIAL #3a: Empirical force fields INTRODUCTION The goal of this tutorial

More information

Interaction energy of DNA base pairs and amino acid pairs: DFT, DFTB and WFT calculations

Interaction energy of DNA base pairs and amino acid pairs: DFT, DFTB and WFT calculations Interaction energy of DNA base pairs and amino acid pairs: DFT, DFTB and WFT calculations Tomáš Kubař, Petr Jurečka, Jirka Černý, Honza Řezáč, Michal Otyepka, Haydée Valdés and Pavel Hobza* Institute of

More information

IGMPlot 1 version 1.0

IGMPlot 1 version 1.0 IGMPlot 1 version 1.0 Documentation A CPU implementation of the NCI/IGM 1,2 approach using pro-molecular density for detecting and plotting interaction from electron density IGM reference by Emmanuel Pluot,

More information

Standards-Based Quantification in DTSA-II Part II

Standards-Based Quantification in DTSA-II Part II Standards-Based Quantification in DTSA-II Part II Nicholas W.M. Ritchie National Institute of Standards and Technology, Gaithersburg, MD 20899-8371 nicholas.ritchie@nist.gov Introduction This article is

More information

Assignment 1: Molecular Mechanics (PART 2 25 points)

Assignment 1: Molecular Mechanics (PART 2 25 points) Chemistry 380.37 Fall 2015 Dr. Jean M. Standard September 2, 2015 Assignment 1: Molecular Mechanics (PART 2 25 points) In this assignment, you will perform some additional molecular mechanics calculations

More information

Computational Chemistry I

Computational Chemistry I Computational Chemistry I Text book Cramer: Essentials of Quantum Chemistry, Wiley (2 ed.) Chapter 3. Post Hartree-Fock methods (Cramer: chapter 7) There are many ways to improve the HF method. Most of

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

Ranking of HIV-protease inhibitors using AutoDock

Ranking of HIV-protease inhibitors using AutoDock Ranking of HIV-protease inhibitors using AutoDock 1. Task Calculate possible binding modes and estimate the binding free energies for 1 3 inhibitors of HIV-protease. You will learn: Some of the theory

More information

Q-Chem Workshop. Doubletree Hotel 2085 S. Harbor Boulevard Anaheim, CA March 26, Schedule

Q-Chem Workshop. Doubletree Hotel 2085 S. Harbor Boulevard Anaheim, CA March 26, Schedule Q-Chem Workshop Doubletree Hotel 2085 S. Harbor Boulevard Anaheim, CA 92802 March 26, 2011 1 8:30 Schedule Welcome remarks, Prof. Peter Gill, Australian National Univ and President of Q-Chem 8:45-9:15

More information

Non-covalent force fields computed ab initio

Non-covalent force fields computed ab initio Non-covalent force fields computed ab initio Supermolecule calculations Symmetry-adapted perturbation theory (SAPT) Supermolecule calculations Requirements: E = E AB E A E B. Include electron correlation,

More information

JASS Modeling and visualization of molecular dynamic processes

JASS Modeling and visualization of molecular dynamic processes JASS 2009 Konstantin Shefov Modeling and visualization of molecular dynamic processes St Petersburg State University, Physics faculty, Department of Computational Physics Supervisor PhD Stepanova Margarita

More information

5 Electron Densities, Electrostatic Potentials, and Reactivity Indices (Spartan)

5 Electron Densities, Electrostatic Potentials, and Reactivity Indices (Spartan) 5 Electron Densities, Electrostatic Potentials, and Reactivity Indices (Spartan) Exercise 1 Visualizing Different Bond Types Build the H 2 molecule. Save as dihydrogen.spartan in an appropriate folder.

More information

The Potential Energy Surface

The Potential Energy Surface The Potential Energy Surface In this section we will explore the information that can be obtained by solving the Schrödinger equation for a molecule, or series of molecules. Of course, the accuracy of

More information