CPMD Tutorial Atosim/RFCT 2009/10

Size: px
Start display at page:

Download "CPMD Tutorial Atosim/RFCT 2009/10"

Transcription

1 These exercices were inspired by the CPMD Tutorial of Axel Kohlmeyer axel.kohlmeyer/cpmd-tutor/index.html and by other tutorials. Here is a summary of what we will do: I Introduction to CPMD First, copy the input files to your directory: 1 mkdir CPMD cd CPMD cp -r ~userchimie/atosim_cpmd/inputs/*. source./cpmd.sh Each time you open a new window, you will have to type: cd CPMD source./cpmd.sh 1. Let s have a look at the CPMD code using H 2 (a) cd H2 (b) We will first optimize the wavefunction using H2_optwfn.inp, given below (you don t have to type it, it is already in the directory!): &INFO isolated hydrogen molecule. single point calculation. &CPMD OPTIMIZE WAVEFUNCTION CONVERGENCE ORBITALS 1.0d-7 &SYSTEM SYMMETRY 1 ANGSTROM CELL CUTOFF 70.0 &DFT FUNCTIONAL LDA 1 Each line is one instruction, so the following lines should be entered one after each other. 1

2 &ATOMS *H_MT_LDA LMAX=S Type cpmd.x H2_optwfn.inp > H2_optwfn.out and wait for a few seconds. (c) Look at the output file using your favorite editor vi or emacs. We will discuss it togeter. 2. We will now look at some molecular dynamics (MD)! (a) First, we will optimize the geometry of the H 2 molecule using: cpmd.x H2_optgeom.inp > H2_optgeom.out & While the calculation is running, have a look at the input file! (b) You can use molden to have a look at the file GEOMETRY.xyz to see the optimized geometry for H 2. (c) Copy the RESTART.1 file to save it: cp RESTART.1 RESTART.geomopt (d) Let s go for dynamics: cpmd.x H2_MD1.inp > H2_MD1.out & (e) While the calculation is running, have a look at the input file. &INFO isolated hydrogen molecule. simple molecular dynamics deltat=4au &CPMD MOLECULAR DYNAMICS CP RESTART WAVEFUNCTION COORDINATES LATEST TRAJECTORY XYZ MAXSTEP 100 TIMESTEP 4.0 &SYSTEM SYMMETRY 1 ANGSTROM CELL CUTOFF 2

3 70.0 &DFT FUNCTIONAL LDA &ATOMS *H_MT_LDA LMAX=S New keywords: TRAJECTORY XYZ, TIMESTEP. (f) Use molden to have a look at the trajectory file TRAJEC.xyz. To see the evolution, clisk on the Movie button. (g) What s happening? (h) Delete files that are not needed anymore: rm ENERGIES TRAJECTORY TRAJEC.xyz (i) Copy the restart file: cp RESTART.geomopt RESTART.1 (j) Use now cpmd.x H2_MD2.inp > H2_MD2.out & (k) Use molden to have a look at the trajectory file TRAJEC.xyz. Are things ok now? (l) Let s have a look at the file ENERGIES using gnuplot. The columns are in the folowing order: NFI A counter EKINC Kinetic energy of the electrons TEMPP The instantaneous temperature EKS Kohn-Sham energy (electronic energy) ECLASSIC Equivalent of the total energy in a classical MD run EHAM Total energy, should be conserved. ECLASSIC=EHAM-EKINC DIS Mean squared displacement of the atoms from the initial coordinates TCPU CPU time needed for this step. In gnuplot, type: 2 plot "ENERGIES" u 1:2 t "EKINC" w l plot "ENERGIES" u 1:3 t "TEMPERATURE" w l plot "ENERGIES" u 1:4 t "EKS" w l plot "ENERGIES" u 1:5 t "ECLASSIC" w l plot "ENERGIES" u 1:6 t "EHAM:conserved?" w l What are your conclusions? 3. We will now test the adiabaticity hypothesis by launching different calculations with different TIMESTEP and EMASS values. We can change the timestep between 2 and 20 a.u. and the fictitious electronic mass between 200 and The last caracter is an l not a one. 3

4 (a) Copy the restart file: cp RESTART.geomopt RESTART.1 before each calculations to always start for the same wavefunction and geometry. These calculations will be split between all of you. You will edit the H2_MD3.inp file to change the values of these two parameters. Somebody should also launch a BO simulation using H2_BOMD.inp. Be careful that the total time of the simulation should be the same. That is TimeStep*MaxStep should always be equal to 5000 atomic time units. Conclusions? II More realistic systems In this part, we wil consider two systems that are a bit more realistic: water, amonia and bulk silicon. 1 Water There are two directories, depending on how the periodic boundaries are treated: for H2O, there is no decoupling, ie a molecule can see its images, in H2O_isolated, we use a decoupling scheme. Choose one of them and compare to your neighbour. Repeat what we have done before: 1. Geometry optimization: H2O_optgeom.inp. Save the restart file: cp RESTART.1 RESTART.geomopt. Here, we ask to print some geometric parameters. Compare between the isolated calculation and the periodic one. 2. Short MD: H2O_MD1.inp with TimeStep=4, EMass=400 or H2O_MD2.inp with TimeStep=16, EMass=1200. We can also have a look at the IR spectrum, but this will needs a longer MD run. Launch H2O_MD_IR.inp. Do not change the RESTART file, or erase some files. As this will take some time, launch it as a background task while you are looking at the next calculations. During the MD, the evolution of the DIPOLE moment has been printed in the file DIPOLE. We can thus look at the IR spectrum because it is the Fourier Transform of the autocorrelation function of the dipole moment. For this, we will use the program fourier.x. Follow the instruction. 2 Amonia Here, we will focus on the flip-flop of the NH 3 molecule at 300K. For this, we will launch a NVT simulation using a Nosé-Hoover thermostat. Change to the directory NH3: cd../nh3 1. Optimize the geometry: NH3_optgeom.inp 2. Equilibrate the system at 300K: NH3_equil_300.inp or at 700K NH3_equil_700.inp. Have a look at the input file while the simulation is running! 3. Launch the simulation using a thermostat at the right temperature (you might have to change it in the input file): NH3_MD.inp Use molden to look at the molecule along the simulation with the TRAJEC.xyz file. Is the molecule freely flipping at 300K? at 700K? 4

5 3 Bulk silicon We will use this solid system to have a look at the radial distribution function. Change to the directory Si8: cd../si8 1. Optimize the wavefunction: Si8_optwfn.inp 2. Equilibrate the system at 1500K: Si8_equil.inp 3. Launch the simulation using a thermostat: Si8_equil.inp Use molden to look at the molecule along the simulation with the TRAJEC.xyz file and to compute the radial distribution function. III Long simulations 1 Free energy profile We finish this set of exercices by the calculation of the free energy profile for the rotation of one methyl group of ethane around the single CC bond. All files are in FreeEnergy. Many ways can be used to compute this: Brute force: launch a very very very very... very long simulation, and may be you will see the angle moving out of the initial minimum. I practice it does not work, even though we know that this rotation is almost free at room temperature. The sample input file is called Ethane_BruteForce.inp. You have to modify it to: 1. Optimize the wave function 2. Launch a very long dynamic Thermodynamic integration: we will launch many constrained simulation in which the reaction coordinate will be the torsion angle, θ, between the two methyl groups: H 1 theta H 6 H 5 C 7 C 8 H 3 H 2 H 4 A good way to do so is to launch simulation for angles equal to 0, 20, 40, 60, 80, 100 and 120. For each simulation, we will then compute the free energy derivative, and then integrate it. A sample file is given in Ethane_TI_60.inp. You can use molden to generate different geometries. You can use the Ethane.xyz file if needed. In molden, geometry can be modified using the Zmat editor menu. For each simulation, you will need to: 1. Create a geometry with the given value of the dihedral angle, 2. optimize the wave function, 3. launch a long dynamic (at least steps), 5

6 4. compute the free energy derivative using the CONSTRAINT file. Umbrella sampling. We will proceed in two steps. First, using CPMD, we will use the torsion angle as a constraint to compute the potential energy profile for the rotation of the methyl group. This will give us an idea of the barrier to overcome, and thus some hints about the biaising potential. See the thermodynamic integration procedure to compute the energy here. For each value of the dihedral angle, you will need to: 1. Create a geometry with the given value of the dihedral angle, 2. Optimize the wave function, 3. Optimize the geometry (with the dihedral constrained). Add this potential using CPMD restraints, and launch a long simulation. A sample input file is Ethane_Umbrella_60.inp. An easy way is to use only one restraint centered on θ =60. How does it differ from the Brute force option? Metadynamic. This is a bit too long for us. Try it later if you have some time... 6

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 CPMD 1

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

More information

Basic tutorial to CPMD calculations

Basic tutorial to CPMD calculations Car and Parinnello Molecular Dynamics http://www.cpmd.org/ Basic tutorial to CPMD calculations Sébastien LE ROUX sebastien.leroux@ipcms.unistra.fr INSTITUT DE PHYSIQUE ET DE CHIMIE DES MATÉRIAUX DE STRASBOURG,

More information

Calculating Vibrational Spectra from Molecular Dynamics

Calculating Vibrational Spectra from Molecular Dynamics Calculating Vibrational Spectra from Molecular Dynamics A Simulating a Trajectory with Wannier Centers To calculate IR spectra from Molecular Dynamics, it is necessary to have dipole information for the

More information

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

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

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

More information

Hands-on : Model Potential Molecular Dynamics

Hands-on : Model Potential Molecular Dynamics Hands-on : Model Potential Molecular Dynamics OUTLINE 0. DL_POLY code introduction 0.a Input files 1. THF solvent molecule 1.a Geometry optimization 1.b NVE/NVT dynamics 2. Liquid THF 2.a Equilibration

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

Lab 1: Handout GULP: an Empirical energy code

Lab 1: Handout GULP: an Empirical energy code Lab 1: Handout GULP: an Empirical energy code We will be using the GULP code as our energy code. GULP is a program for performing a variety of types of simulations on 3D periodic solids, gas phase clusters,

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

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

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

1 Introduction. command intended for command prompt

1 Introduction. command intended for command prompt Guest Lecture, Smith College, CS 334, BioInformatics 21 October 2008 GROMACS, Position Restrained MD, Protein Catalytic Activity Filip Jagodzinski 1 Introduction GROMACS (GROningen MAchine for Chemistry

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

Introductory WebMO Exercises

Introductory WebMO Exercises Introductory WebMO Exercises These directions assume no prior knowledge of e WebMO interface and provide detailed, click by click instructions on building molecules and setting up calculations. Use your

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

DFT and beyond: Hands-on Tutorial Workshop Tutorial 1: Basics of Electronic Structure Theory

DFT and beyond: Hands-on Tutorial Workshop Tutorial 1: Basics of Electronic Structure Theory DFT and beyond: Hands-on Tutorial Workshop 2011 Tutorial 1: Basics of Electronic Structure Theory V. Atalla, O. T. Hofmann, S. V. Levchenko Theory Department, Fritz-Haber-Institut der MPG Berlin July 13,

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

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

Silica surface - Materials Studio tutorial. CREATING SiO 2 SURFACE

Silica surface - Materials Studio tutorial. CREATING SiO 2 SURFACE Silica surface - Materials Studio tutorial CREATING SiO 2 SURFACE Our goal surface of SiO2 6.948 Ǻ Import structure The XRD experiment gives us such parameters as: lattice parameters, symmetry group and

More information

General Chemistry Lab Molecular Modeling

General Chemistry Lab Molecular Modeling PURPOSE The objectives of this experiment are PROCEDURE General Chemistry Lab Molecular Modeling To learn how to use molecular modeling software, a commonly used tool in chemical research and industry.

More information

Patrick: An Introduction to Medicinal Chemistry 5e MOLECULAR MODELLING EXERCISES CHAPTER 17

Patrick: An Introduction to Medicinal Chemistry 5e MOLECULAR MODELLING EXERCISES CHAPTER 17 MOLECULAR MODELLING EXERCISES CHAPTER 17 Exercise 17.6 Conformational analysis of n-butane Introduction Figure 1 Butane Me Me In this exercise, we will consider the possible stable conformations of butane

More information

Learning to Use Scigress Wagner, Eugene P. (revised May 15, 2018)

Learning to Use Scigress Wagner, Eugene P. (revised May 15, 2018) Learning to Use Scigress Wagner, Eugene P. (revised May 15, 2018) Abstract Students are introduced to basic features of Scigress by building molecules and performing calculations on them using semi-empirical

More information

Basics of Electronic-Structure Theory

Basics of Electronic-Structure Theory A guideline through the tutorial 23.06.2009 For each exercise in this tutorial, a separate directory should be created in your home directory in which the input files are generated and the calculation

More information

Literature values: ΔH f, gas = % error Source: ΔH f, solid = % error. For comparison, your experimental value was ΔH f = phase:

Literature values: ΔH f, gas = % error Source: ΔH f, solid = % error. For comparison, your experimental value was ΔH f = phase: 1 Molecular Calculations Lab: Some guideline given at the bottom of page 3. 1. Use the semi-empirical AM1 method to calculate ΔH f for the compound you used in the heat of combustion experiment. Be sure

More information

1 Newton s 2nd and 3rd Laws

1 Newton s 2nd and 3rd Laws Physics 13 - Winter 2007 Lab 2 Instructions 1 Newton s 2nd and 3rd Laws 1. Work through the tutorial called Newton s Second and Third Laws on pages 31-34 in the UW Tutorials in Introductory Physics workbook.

More information

ABC of DFT: Hands-on session 4 Molecular vibrations

ABC of DFT: Hands-on session 4 Molecular vibrations ABC of DFT: Hands-on session 4 Molecular vibrations Tutor: Alexej Bagrets Wann? 29.11.2012, 11:30-13:00 Wo? KIT Campus Süd, Flachbau Physik, Geb. 30.22, Computerpool, Raum FE-6 1 ABC of DFT, Hands-on session

More information

Molecular Modeling and Conformational Analysis with PC Spartan

Molecular Modeling and Conformational Analysis with PC Spartan Molecular Modeling and Conformational Analysis with PC Spartan Introduction Molecular modeling can be done in a variety of ways, from using simple hand-held models to doing sophisticated calculations on

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

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

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

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

1 Introduction to Computational Chemistry (Spartan)

1 Introduction to Computational Chemistry (Spartan) 1 Introduction to Computational Chemistry (Spartan) Start Spartan by clicking Start / Programs / Spartan Then click File / New Exercise 1 Study of H-X-H Bond Angles (Suitable for general chemistry) Structure

More information

CP/MM Tutorial GRS, WS 2010/2011 Emiliano Ippoliti:

CP/MM Tutorial GRS, WS 2010/2011 Emiliano Ippoliti: CP/MM Tutorial GRS, WS 2010/2011 Emiliano Ippoliti: e.ippoliti@grs-sim.de We want to study the effect of the solvent (water) and the temperature on the dipole moment of an acetone molecule. To accomplish

More information

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014 Ab initio molecular dynamics Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy Bangalore, 04 September 2014 What is MD? 1) Liquid 4) Dye/TiO2/electrolyte 2) Liquids 3) Solvated protein 5) Solid to liquid

More information

3. An Introduction to Molecular Mechanics

3. An Introduction to Molecular Mechanics 3. An Introduction to Molecular Mechanics Introduction When you use Chem3D to draw molecules, the program assigns bond lengths and bond angles based on experimental data. The program does not contain real

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

Exercises for Windows

Exercises for Windows Exercises for Windows CAChe User Interface for Windows Select tool Application window Document window (workspace) Style bar Tool palette Select entire molecule Select Similar Group Select Atom tool Rotate

More information

Motion II. Goals and Introduction

Motion II. Goals and Introduction Motion II Goals and Introduction As you have probably already seen in lecture or homework, and if you ve performed the experiment Motion I, it is important to develop a strong understanding of how to model

More information

GMS 8.0 Tutorial MT3DMS Advanced Transport MT3DMS dispersion, sorption, and dual domain options

GMS 8.0 Tutorial MT3DMS Advanced Transport MT3DMS dispersion, sorption, and dual domain options v. 8.0 GMS 8.0 Tutorial MT3DMS dispersion, sorption, and dual domain options Objectives Learn about the dispersion, sorption, and dual domain options in MT3DMS Prerequisite Tutorials None Required Components

More information

Ab initio molecular dynamics: Basic Theory and Advanced Met

Ab initio molecular dynamics: Basic Theory and Advanced Met Ab initio molecular dynamics: Basic Theory and Advanced Methods Uni Mainz October 30, 2016 Bio-inspired catalyst for hydrogen production Ab-initio MD simulations are used to learn how the active site

More information

Hands-On Tutorial on Ab Initio Molecular Simulations Berlin, July 12 21, 2011

Hands-On Tutorial on Ab Initio Molecular Simulations Berlin, July 12 21, 2011 Hands-On Tutorial on Ab Initio Molecular Simulations Berlin, July 12 21, 2011 Tutorial I: Basics of Electronic-Structure Theory Manuscript for Exercise Problems Prepared by Viktor Atalla, Oliver Hofmann,

More information

Introduc)on to IQmol: Part I.!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov

Introduc)on to IQmol: Part I.!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov Introduc)on to IQmol: Part I!!! Shirin Faraji, Ilya Kaliman, and Anna Krylov! 1 Resources! Written by Dr. Andrew Gilbert Keep yourself up to date with IQmol website: http://iqmol.org! IQmol Youtube channel:

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

Geometry Optimisation

Geometry Optimisation Geometry Optimisation Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, UK http://www.cmt.york.ac.uk/cmd http://www.castep.org Motivation Overview of Talk Background

More information

Tutorial: Structural Analysis of a Protein-Protein Complex

Tutorial: Structural Analysis of a Protein-Protein Complex Molecular Modeling Section (MMS) Department of Pharmaceutical and Pharmacological Sciences University of Padova Via Marzolo 5-35131 Padova (IT) @contact: stefano.moro@unipd.it Tutorial: Structural Analysis

More information

Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel

Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel Chem 310, Organic Chemistry Lab Molecular Modeling Using Macromodel This is a molecular modeling experiment, and should be written up in your lab notebook just as if it were a normal "wet-chemistry" experiment.

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

Computing IR / Raman / VCD / ROA Spectra with CP2k and TRAVIS

Computing IR / Raman / VCD / ROA Spectra with CP2k and TRAVIS Computing IR / Raman / VCD / ROA Spectra with CP2k and TRAVIS Martin Brehm Martin Luther Universität Halle Wittenberg Martin_Brehm@gmx.de 0. Introduction In this exercise, we will compute the full set

More information

Hyeyoung Shin a, Tod A. Pascal ab, William A. Goddard III abc*, and Hyungjun Kim a* Korea

Hyeyoung Shin a, Tod A. Pascal ab, William A. Goddard III abc*, and Hyungjun Kim a* Korea The Scaled Effective Solvent Method for Predicting the Equilibrium Ensemble of Structures with Analysis of Thermodynamic Properties of Amorphous Polyethylene Glycol-Water Mixtures Hyeyoung Shin a, Tod

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

Hints on Using the Orca Program

Hints on Using the Orca Program 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 Hints on Using the Orca Program

More information

Name. Chem Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2

Name. Chem Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2 Name Chem 322 - Organic Chemistry II Laboratory Exercise Molecular Modeling Part 2 Click on Titan in the Start menu. When it boots, click on the right corner to make the window full-screen. icon in the

More information

S N 2 reaction. Br- + ClCH 3 BrCH 3 + Cl-

S N 2 reaction. Br- + ClCH 3 BrCH 3 + Cl- FY1006 Innføring i kvantefysikk og TFY4215 Kjemisk fysikk og kvantemekanikk Spring 2012 Chemical Physics Exercise 2 To be delivered by Friday 27.04.12 S N 2 reaction. Introduction Many chemical reactions

More information

Computational Chemistry Lab Module: Conformational Analysis of Alkanes

Computational Chemistry Lab Module: Conformational Analysis of Alkanes Introduction Computational Chemistry Lab Module: Conformational Analysis of Alkanes In this experiment, we will use CAChe software package to model the conformations of butane, 2-methylbutane, and substituted

More information

3. An Introduction to Molecular Mechanics

3. An Introduction to Molecular Mechanics 3. An Introduction to Molecular Mechanics Introduction When you use Chem3D to draw molecules, the program assigns bond lengths and bond angles based on experimental data. The program does not contain real

More information

Homework 2: Structure and Defects in Crystalline and Amorphous Materials

Homework 2: Structure and Defects in Crystalline and Amorphous Materials Homework 2: Structure and Defects in Crystalline and Amorphous Materials Muhammad Ashraful Alam Network of Computational Nanotechnology Discovery Park, Purdue University. In Lectures 4-6, we have discussed

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

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

Version 1.2 October 2017 CSD v5.39

Version 1.2 October 2017 CSD v5.39 Mogul Geometry Check Table of Contents Introduction... 2 Example 1. Using Mogul to assess intramolecular geometry... 3 Example 2. Using Mogul to explain activity data... 5 Conclusions... 8 Further Exercises...

More information

Modeling a Composite Slot Cross-Section for Torsional Analysis

Modeling a Composite Slot Cross-Section for Torsional Analysis Modeling a Composite Slot Cross-Section for Torsional Analysis The cross-section in question is shown below (see also p. 432 in the textbook). Due to double symmetry, only one-quarter of the cross-section

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

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

Table of Contents. Table of Contents Spin-orbit splitting of semiconductor band structures

Table of Contents. Table of Contents Spin-orbit splitting of semiconductor band structures Table of Contents Table of Contents Spin-orbit splitting of semiconductor band structures Relavistic effects in Kohn-Sham DFT Silicon band splitting with ATK-DFT LSDA initial guess for the ground state

More information

3D Molecule Viewer of MOGADOC (JavaScript)

3D Molecule Viewer of MOGADOC (JavaScript) 3D Molecule Viewer of MOGADOC (JavaScript) Movement of the Molecule Rotation of the molecule: Use left mouse button to drag. Translation of the molecule: Use right mouse button to drag. Resize the molecule:

More information

Physical Chemistry Final Take Home Fall 2003

Physical Chemistry Final Take Home Fall 2003 Physical Chemistry Final Take Home Fall 2003 Do one of the following questions. These projects are worth 30 points (i.e. equivalent to about two problems on the final). Each of the computational problems

More information

Dock Ligands from a 2D Molecule Sketch

Dock Ligands from a 2D Molecule Sketch Dock Ligands from a 2D Molecule Sketch March 31, 2016 Sample to Insight CLC bio, a QIAGEN Company Silkeborgvej 2 Prismet 8000 Aarhus C Denmark Telephone: +45 70 22 32 44 www.clcbio.com support-clcbio@qiagen.com

More information

APBS electrostatics in VMD - Software. APBS! >!Examples! >!Visualization! >! Contents

APBS electrostatics in VMD - Software. APBS! >!Examples! >!Visualization! >! Contents Software Search this site Home Announcements An update on mailing lists APBS 1.2.0 released APBS 1.2.1 released APBS 1.3 released New APBS 1.3 Windows Installer PDB2PQR 1.7.1 released PDB2PQR 1.8 released

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

Remember that C is a constant and ë and n are variables. This equation now fits the template of a straight line:

Remember that C is a constant and ë and n are variables. This equation now fits the template of a straight line: CONVERTING NON-LINEAR GRAPHS INTO LINEAR GRAPHS Linear graphs have several important attributes. First, it is easy to recognize a graph that is linear. It is much more difficult to identify if a curved

More information

Hands-on Summer School: Electronic Structure Theory for Materials and (Bio)molecules Los Angeles, July 21 - August 1, 2014

Hands-on Summer School: Electronic Structure Theory for Materials and (Bio)molecules Los Angeles, July 21 - August 1, 2014 Hands-on Summer School: Electronic Structure Theory for Materials and (Bio)molecules Los Angeles, July 21 - August 1, 2014 Tutorial I: Basics of Electronic-Structure Theory Manuscript for Exercise Problems

More information

Ab initio molecular dynamics

Ab initio molecular dynamics Ab initio molecular dynamics Molecular dynamics Why? allows realistic simulation of equilibrium and transport properties in Nature ensemble averages can be used for statistical mechanics time evolution

More information

Conformational Analysis of n-butane

Conformational Analysis of n-butane Conformational Analysis of n-butane In this exercise you will calculate the Molecular Mechanics (MM) single point energy of butane in various conformations with respect to internal rotation around the

More information

Basic introduction of NWChem software

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

More information

Free Energy Change and Activation Barrier for a Menshutkin Reaction Including Effects of the Solvent

Free Energy Change and Activation Barrier for a Menshutkin Reaction Including Effects of the Solvent Proposed Exercise for the Physical Chemistry Section of the Teaching with Cache Workbook: Free Energy Change and Activation Barrier for a Menshutkin Reaction Including Effects of the Solvent Contributed

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

Lab 1: Handout GULP: an Empirical energy code

Lab 1: Handout GULP: an Empirical energy code 3.320/SMA 5.107/ Atomistic Modeling of Materials Spring 2003 1 Lab 1: Handout GULP: an Empirical energy code We will be using the GULP code as our energy code. GULP is a program for performing a variety

More information

2008 Biowerkzeug Ltd.

2008 Biowerkzeug Ltd. 2008 Biowerkzeug Ltd. 1 Contents Summary...3 1 Simulation...4 1.1 Setup...4 1.2 Output...4 2 Settings...5 3 Analysis...9 3.1 Setup...9 3.2 Input options...9 3.3 Descriptions...10 Please note that we cannot

More information

Project 4/5 - Molecular dynamics part II: advanced study of Lennard-Jones fluids, deadline December 1st (noon)

Project 4/5 - Molecular dynamics part II: advanced study of Lennard-Jones fluids, deadline December 1st (noon) Format for delivery of report and programs The format of the project is that of a printed file or hand-written report. The programs should also be included with the report. Write only your candidate number

More information

Classical Molecular Dynamics

Classical Molecular Dynamics Classical Molecular Dynamics Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, U.K. http://www-users.york.ac.uk/~mijp1 Overview of lecture n Motivation n Types of

More information

Physical Chemistry Analyzing a Crystal Structure and the Diffraction Pattern Virginia B. Pett The College of Wooster

Physical Chemistry Analyzing a Crystal Structure and the Diffraction Pattern Virginia B. Pett The College of Wooster Physical Chemistry Analyzing a Crystal Structure and the Diffraction Pattern Virginia B. Pett The College of Wooster L. W. Haynes and his Senior Independent Study students conducted the 2 + 2 photo addition

More information

ABC of DFT: Hands-on session 1 Introduction into calculations on molecules

ABC of DFT: Hands-on session 1 Introduction into calculations on molecules ABC of DFT: Hands-on session 1 Introduction into calculations on molecules Tutor: Alexej Bagrets Wann? 09.11.2012, 11:30-13:00 Wo? KIT Campus Nord, Flachbau Physik, Geb. 30.22, Computerpool, Raum FE-6

More information

Chemical reaction networks and diffusion

Chemical reaction networks and diffusion FYTN05 Fall 2012 Computer Assignment 2 Chemical reaction networks and diffusion Supervisor: Erica Manesso (Office: K217, Phone: +46 46 22 29232, E-mail: erica.manesso@thep.lu.se) Deadline: October 23,

More information

5 Classical Molecular Dynamics (MD) Simulations with Tinker

5 Classical Molecular Dynamics (MD) Simulations with Tinker 5 Classical Molecular Dynamics (MD) Simulations with Tinker In this set of exercises, you will be briey introduced to the concept of classical force elds and molecular dynamics via propagation of atomic

More information

Winmostar tutorial LAMMPS Melting point V X-Ability Co,. Ltd. 2017/8/17

Winmostar tutorial LAMMPS Melting point V X-Ability Co,. Ltd. 2017/8/17 Winmostar tutorial LAMMPS Melting point V7.025 X-Ability Co,. Ltd. question@winmostar.com Contents Configure I. Build solid phase II. Equilibration of solid phase III. Equilibration of liquid phase IV.

More information

CO 2 molecule. Morse Potential One of the potentials used to simulate chemical bond is a Morse potential of the following form: O C O

CO 2 molecule. Morse Potential One of the potentials used to simulate chemical bond is a Morse potential of the following form: O C O CO 2 molecule The aim of this project is a numerical analysis of adsorption spectra of CO2 molecule simulated by a double Morse potential function. In the project you should achieve following tasks: 1.

More information

Lab 4: Gauss Gun Conservation of Energy

Lab 4: Gauss Gun Conservation of Energy Lab 4: Gauss Gun Conservation of Energy Before coming to Lab Read the lab handout Complete the pre-lab assignment and hand in at the beginning of your lab section. The pre-lab is written into this weeks

More information

1 An Experimental and Computational Investigation of the Dehydration of 2-Butanol

1 An Experimental and Computational Investigation of the Dehydration of 2-Butanol 1 An Experimental and Computational Investigation of the Dehydration of 2-Butanol Summary. 2-Butanol will be dehydrated to a mixture of 1-butene and cis- and trans-2-butene using the method described in

More information

Overlay Analysis II: Using Zonal and Extract Tools to Transfer Raster Values in ArcMap

Overlay Analysis II: Using Zonal and Extract Tools to Transfer Raster Values in ArcMap Overlay Analysis II: Using Zonal and Extract Tools to Transfer Raster Values in ArcMap Created by Patrick Florance and Jonathan Gale, Edited by Catherine Ressijac on March 26, 2018 If you have raster data

More information

Bipolar Transistor WS 2011

Bipolar Transistor WS 2011 Institut für Integrierte Systeme Integrated Systems Laboratory Bipolar Transistor WS 2011 1 Introduction In this exercise we want to simulate the IV characteristics of a bipolar transistor and draw the

More information

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes

v Prerequisite Tutorials GSSHA WMS Basics Watershed Delineation using DEMs and 2D Grid Generation Time minutes v. 10.1 WMS 10.1 Tutorial GSSHA WMS Basics Creating Feature Objects and Mapping Attributes to the 2D Grid Populate hydrologic parameters in a GSSHA model using land use and soil data Objectives This tutorial

More information

Ab Ini'o Molecular Dynamics (MD) Simula?ons

Ab Ini'o Molecular Dynamics (MD) Simula?ons Ab Ini'o Molecular Dynamics (MD) Simula?ons Rick Remsing ICMS, CCDM, Temple University, Philadelphia, PA What are Molecular Dynamics (MD) Simulations? Technique to compute statistical and transport properties

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

Supporting Information for. Dynamics Study"

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

More information

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

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

More information

Getting started with BatchReactor Example : Simulation of the Chlorotoluene chlorination

Getting started with BatchReactor Example : Simulation of the Chlorotoluene chlorination Getting started with BatchReactor Example : Simulation of the Chlorotoluene chlorination 2011 ProSim S.A. All rights reserved. Introduction This document presents the different steps to follow in order

More information

Winmostar tutorial Gromacs Interfacial Tension V X-Ability Co., Ltd. 2018/01/15

Winmostar tutorial Gromacs Interfacial Tension V X-Ability Co., Ltd. 2018/01/15 Winmostar tutorial Gromacs Interfacial Tension V8.007 X-Ability Co., Ltd. question@winmostar.com Summary In this tutorial, we will calculate density distribution and interfacial tension between liquid-liquid

More information

Instructions for Using Spartan 14

Instructions for Using Spartan 14 Instructions for Using Spartan 14 Log in to the computer with your Colby ID and password. Click on the Spartan 14 icon in the dock at the bottom of your screen. I. Building Molecules Spartan has one main

More information

Introduction to Spark

Introduction to Spark 1 As you become familiar or continue to explore the Cresset technology and software applications, we encourage you to look through the user manual. This is accessible from the Help menu. However, don t

More information

Lab 70 in TFFM08. Curie & Ising

Lab 70 in TFFM08. Curie & Ising IFM The Department of Physics, Chemistry and Biology Lab 70 in TFFM08 Curie & Ising NAME PERS. -NUMBER DATE APPROVED Rev Aug 09 Agne 1 Introduction Magnetic materials are all around us, and understanding

More information