PH 548 Atomistic Simulation Techniques

Size: px
Start display at page:

Download "PH 548 Atomistic Simulation Techniques"

Transcription

1 PH 548 Atomistic Simulation Techniques Lectures: Lab: Tuesday 12-1 PM Thursday 12-1 PM Monday 2-5 PM P. K. Padmanabhan

2 PH548:

3 Two Excellent Books

4 How to do it?

5 1 2 F 12 F 23 3 F i = F ij j i F 1 = F 12 + F 13 F 13 F 2 = F 21 + F 23 F = U ij Three Atoms ij F 3 = F 31 + F 32 Newton s II nd Law: a = F / i i m i

6 Progress in time x(t) x(t+ t) y(t) y(t+ t) z(t) z(t+ t) t ~ 1-5 fs (10-15 sec) Advance positions & velocities of each atom: Taylor Expansion: too crude to use it as such!!

7 1 3 2 F 12 F 23 F 13 t+δt 1 st MD Step Atoms move forward in time! 1. Calculate 2. Update 3. Update t ~ 1-5 fs (10-15 sec) Continue this procedure for several lakhs of Steps. Or as much as you can afford! The main O/P of MD is the trajectory. 3 1 t+2δt 2 nd MD Step 2

8 Verlet Scheme: A good Integrator Newton s equations are time reversible, Summing the two equations, Now we have advanced our atoms to time t+ t!! Velocity of the atoms:

9 The missing ingredient Forces? Force is the gradient of potential: Gravitational Potential: Gm m 1 r 2 U = too weak, Neglect it!! The predominant inter-atomic forces are Coulombic in origin! 1 q q 1 = 4πε r U 2 0 However, this pure monopole interaction need not be present!

10 Interatomic forces for simple systems 1. Lennard-Jones Potential: (non-bonded interactions) 2. Born-Mayer (Tosi-Fumi) Potential: Instantaneous dipoles Gives an accurate description of inert gases (Ar, Xe, Kr etc.) Faithful in describing pure ionic solids (NaCl, KCl, NaBr etc.)

11 The Lennard-Jones Potential for Ar: Å (k B ) Pauli s repulsion F = U ij Should be known apriori. ij r(nm) dispersion interaction F F x ij x ij U = x 12σ = 4ε ( 14 r i U = r 12 i r x i 6σ 8 r 6 )( x i x j )

12 Applications?

13 Ion Channel s In NASICON s Supriya Roy Na 3 Zr 2 Si 2 PO 12 Supriya Roy and PKP to be published.

14 Structure of Liquids! Carbonates in Solution

15 Understanding Experimental Spectrum Prof. Marx, Theothem, Ruhr-Universitaet, Bochum, Germany

16 Advanced Simulation Techniques: Simulating Chemical Reaction Dissociation of H 2 CO 3 in gas-phase H 2 CO 3 =H 2 O + CO 2

17 Materials science Cond. Matter Physics Chem. Phys./ Phys.Chem Atomic/Mol. Phys. Classical Mechanics Statistical Mechanics Solid State Phys.

18 Lab-Session: 1 (Monday, 11 th Aug., 2-4 pm) Assignments: 1a: Generation of FCC lattice Make 4x4x4 unit cells of the FCC lattice of Argon. Unit cell parameters 5.26 A (angstrom). 1b: Calculation of total potential energy Argon atoms interact through Lennard-Jones potential, with ε = k B (k B = J K -1 ), and σ = 3.4 Å. Read the positions of the Ar atoms from the output of a) and calculate the total potential energy of the system.

19

20 Lab session -I!Generation of coordinates of FCC lattice (4x4x4 unit cells) program fcc implicit none integer::i,j,k, n =4! No of unit cells real::a=5.26 open(unit=1,file="fcc.dat") do i = 0, n - 1 do j = 0, n - 1 do k = 0, n - 1 write(1,*) i*a + 0.0, j*a + 0.0, k*a write(1,*) i*a + a/2, j*a + a/2, k*a write(1,*) i*a + 0.0, j*a + a/2, k*a + a/2 write(1,*) i*a + a/2, j*a + 0.0, k*a + a/2 end do end do end do end program fcc

21 !Potential Energy of fcc lattice (4x4x4 unit cells ) allocate(x(no_atom),y(no_atom),z(no_atom)) sigma6 = sigma**6; sigma12 = sigma6**2; eps4 = 4* eps; pot_en =0.0 do i=1,no_atom-1 do j=i+1,no_atom dx = x(i) - x(j) ; dy = y(i) - y(j); dz= z(i)-z(j); r2=dx**2+dy**2+dz**2 r6= r2*r2*r2 r12= r6 * r6 fact= eps4*(sigma12/r12 - sigma6/r6) pot_en = pot_en + fact end do end do print*,"potential energy=",pot_en

22 Interatomic forces for simple systems 1. Lennard-Jones Potential: (non-bonded interactions) 2. Born-Mayer (Tosi-Fumi) Potential: Instantaneous dipoles Gives an accurate description of inert gases (Ar, Xe, Kr etc.) Faithful in describing pure ionic solids (NaCl, KCl, NaBr etc.)

23 NaCl

24 NaCl

25 MD simulations on NaCl Melting Transition of NaCl Molten NaCl Nucleation and growth from melt/water Dissolution in water Influence on water h-bonding

26 Interatomic potentials Alkali Halides

27

28 Salts of alkaline earth metals, CaF2 F - MSD Ca 2+ CaF2 time σ = 2 Nq D / V k B T PRB, 43, 3180,1991.

29 Salts of alkaline earth metals, CaF2

30 CaF2/BaF2 - interface

31 AgI Vashishta-Rahman potential

32 β-agi (Wurtzite) α-agi (bcc)

33 Ion Channel s In NASICON s Supriya Roy Na 3 Zr 2 Si 2 PO 12 Supriya Roy and PKP to be published.

34 MD simulation of molecular systems O2, CO2, H2O, NH3, CH4, C2H6, C6H6, proteins

35 Diatomic Molecule U= U intra + U inter U intra = )2 Harmonic U inter = + 4ε ( σ σ )

36 U intra Morse potential

37 Carbon dioxide U intra = ) 2 + θ θ ) 2 U inter = + 4ε ( σ σ ) C q= e O q= e σ =2.800 (A) ε= (kj/mol) σ =3.028 (A) ε= (kj/mol) = (A) k bs = kj/m/a θ = 180 k bb = kj/m Cygan et. al., J. Phys. Chem C, 116, (2012).

38

39

40 Dihedral Angle potentials

41 WHATT ERR?

42 Simple Point Charge (SPC) - model Berendsen, Postma, Gunsteren and Hermans, in Pullman (ed.), Intermolecular Forces (Reidel, Dordrecht, 1981) p331. A rigid model U inter = + 4ε o ( σ o σ o ) σ Å ε kj mol -1 l 1 Å q 1 (e) q 2 (e) θ

43 Lorentz-Berthelot rule σ ij = σ i + σ j ) ε ij ε i ε j U C-Ow = + 4ε ( σ, σ, ) C q c = e σ c = (A) ε c = (kj/mol) O q Ow = e σ Ow = (A) ε Ow = (kj/mol)

44 Flexible SPC -model U intra = ) 2 + U inter = + 4ε ( σ σ ) U intra : k HH = kj/mol/a 2 ; r HH = (A); D OH = kj/mol; ρ = (A -1 ) r e = 1 (A) U inter : O: q= e σ =3.166 (A) ε= 0.65 (kj/mol) H: q= 0.41 e σ =0.0 (A) ε= 0.0 (kj/mol) K TOUKAN AND A.RAHMAN,PHYS. REV. B Vol. 31(2) 2643 (1985)

45 4 & 5 site models (TIP4P & TIP5P) σ Å ε kj mol -1 l 1 Å l 2 Å q 1 (e) q 2 (e) θ φ TIP4P TIP5P

46 Model Dipole moment e Dielectric constant self-diffusion, 10-5 cm 2 /s Average configurational energy, kj mol -1 Density maximu m, C SPC TIP3P TIP4P TIP5P Expansion coefficient, 10-4 C -1

47

48

49 Ewald Summation

50

51

52 -Frenkel & Smith

Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions. Let's get together.

Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions. Let's get together. Lecture C2 Microscopic to Macroscopic, Part 2: Intermolecular Interactions Let's get together. Most gases are NOT ideal except at very low pressures: Z=1 for ideal gases Intermolecular interactions come

More information

Chapter 3. Crystal Binding

Chapter 3. Crystal Binding Chapter 3. Crystal Binding Energy of a crystal and crystal binding Cohesive energy of Molecular crystals Ionic crystals Metallic crystals Elasticity What causes matter to exist in three different forms?

More information

CE 530 Molecular Simulation

CE 530 Molecular Simulation 1 CE 530 Molecular Simulation Lecture 14 Molecular Models David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu 2 Review Monte Carlo ensemble averaging, no dynamics easy

More information

Chapter 2 Experimental sources of intermolecular potentials

Chapter 2 Experimental sources of intermolecular potentials Chapter 2 Experimental sources of intermolecular potentials 2.1 Overview thermodynamical properties: heat of vaporization (Trouton s rule) crystal structures ionic crystals rare gas solids physico-chemical

More information

Water models in classical simulations

Water models in classical simulations Water models in classical simulations Maria Fyta Institut für Computerphysik, Universität Stuttgart Stuttgart, Germany Water transparent, odorless, tasteless and ubiquitous really simple: two H atoms attached

More information

Chapter 11 Intermolecular Forces, Liquids, and Solids

Chapter 11 Intermolecular Forces, Liquids, and Solids Chapter 11 Intermolecular Forces, Liquids, and Solids Dissolution of an ionic compound States of Matter The fundamental difference between states of matter is the distance between particles. States of

More information

The change in free energy on transferring an ion from a medium of low dielectric constantε1 to one of high dielectric constant ε2:

The change in free energy on transferring an ion from a medium of low dielectric constantε1 to one of high dielectric constant ε2: The Born Energy of an Ion The free energy density of an electric field E arising from a charge is ½(ε 0 ε E 2 ) per unit volume Integrating the energy density of an ion over all of space = Born energy:

More information

Development of a Water Cluster Evaporation Model using Molecular Dynamics

Development of a Water Cluster Evaporation Model using Molecular Dynamics Development of a Water Cluster Evaporation Model using Molecular Dynamics Arnaud Borner, Zheng Li, Deborah A. Levin. Department of Aerospace Engineering, The Pennsylvania State University, University Park,

More information

From Atoms to Materials: Predictive Theory and Simulations

From Atoms to Materials: Predictive Theory and Simulations From Atoms to Materials: Predictive Theory and Simulations Week 3 Lecture 4 Potentials for metals and semiconductors Ale Strachan strachan@purdue.edu School of Materials Engineering & Birck anotechnology

More information

2011, Robert Ayton. All rights reserved.

2011, Robert Ayton. All rights reserved. Liquids, Solids, and Intermolecular Forces Outline 1. Phase Diagrams and Triple Point Diagrams 2. Intermolecular Forces Review 1. Phase Diagrams and Triple Point Diagrams Phase Diagram of Water Triple

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Simulation Michael Bader SCCS Summer Term 2015 Molecular Dynamics Simulation, Summer Term 2015 1 Continuum Mechanics for Fluid Mechanics? Molecular Dynamics the

More information

Chap 10 Part 4Ta.notebook December 08, 2017

Chap 10 Part 4Ta.notebook December 08, 2017 Chapter 10 Section 1 Intermolecular Forces the forces between molecules or between ions and molecules in the liquid or solid state Stronger Intermolecular forces cause higher melting points and boiling

More information

Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model. John Dood Hope College

Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model. John Dood Hope College Developing Monovalent Ion Parameters for the Optimal Point Charge (OPC) Water Model John Dood Hope College What are MD simulations? Model and predict the structure and dynamics of large macromolecules.

More information

Appendix 2A Indices of Planes and Directions in Hexagonal Crystals

Appendix 2A Indices of Planes and Directions in Hexagonal Crystals Appendix 2 Appendix 2A Indices of Planes and Directions in Hexagonal Crystals Figure 2A.1a shows a hexagonal unit cell defined by two equal unit cell lattice parameters a 1 and a 2 in the basal plane,

More information

MC Molecular Structures, Dipole Moments, Geometry, IMF Name: Date:

MC Molecular Structures, Dipole Moments, Geometry, IMF Name: Date: MC Molecular Structures, Dipole Moments, Geometry, IMF Name: Date: 2008 22. Which of the following is a nonpolar molecule that contains polar bonds? (A) F 2 (B) CHF 3 (C) CO 2 (D) HCl (E) NH 3 28. Which

More information

Lecture 11: Potential Energy Functions

Lecture 11: Potential Energy Functions Lecture 11: Potential Energy Functions Dr. Ronald M. Levy ronlevy@temple.edu Originally contributed by Lauren Wickstrom (2011) Microscopic/Macroscopic Connection The connection between microscopic interactions

More information

Chapter 11 Review Packet

Chapter 11 Review Packet Chapter 11 Review Packet Name Multiple Choice Portion: 1. Which of the following terms is not a quantitative description of a solution? a. molarity b. molality c. mole fraction d. supersaturation 2. Which

More information

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar.

Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. Why Proteins Fold? (Parts of this presentation are based on work of Ashok Kolaskar) CS490B: Introduction to Bioinformatics Mar. 25, 2002 Molecular Dynamics: Introduction At physiological conditions, the

More information

CH1810 Lecture #1 Solutions of Ionic Compounds

CH1810 Lecture #1 Solutions of Ionic Compounds CH1810 Lecture #1 Solutions of Ionic Compounds Solutions Homogeneous mixtures are called solutions. The component of the solution that changes state is called the solute. The component that keeps its state

More information

Molecular mechanics. classical description of molecules. Marcus Elstner and Tomáš Kubař. April 29, 2016

Molecular mechanics. classical description of molecules. Marcus Elstner and Tomáš Kubař. April 29, 2016 classical description of molecules April 29, 2016 Chemical bond Conceptual and chemical basis quantum effect solution of the SR numerically expensive (only small molecules can be treated) approximations

More information

Interatomic Potentials. The electronic-structure problem

Interatomic Potentials. The electronic-structure problem Interatomic Potentials Before we can start a simulation, we need the model! Interaction between atoms and molecules is determined by quantum mechanics: Schrödinger Equation + Born-Oppenheimer approximation

More information

Atomic Structure & Interatomic Bonding

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

More information

Imperfect Gases. NC State University

Imperfect Gases. NC State University Chemistry 431 Lecture 3 Imperfect Gases NC State University The Compression Factor One way to represent the relationship between ideal and real gases is to plot the deviation from ideality as the gas is

More information

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland

Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland Example questions for Molecular modelling (Level 4) Dr. Adrian Mulholland 1) Question. Two methods which are widely used for the optimization of molecular geometies are the Steepest descents and Newton-Raphson

More information

Ch. 8 Chemical Bonding: General Concepts. Brady & Senese, 5th Ed

Ch. 8 Chemical Bonding: General Concepts. Brady & Senese, 5th Ed Ch. 8 Chemical Bonding: General Concepts Brady & Senese, 5th Ed Index 8.1. Electron transfer leads to the formation of ionic compounds 8.2. Lewis symbols help keep track of valence electrons 8.3. Covalent

More information

Chapter 11. Intermolecular Forces and Liquids & Solids

Chapter 11. Intermolecular Forces and Liquids & Solids Chapter 11 Intermolecular Forces and Liquids & Solids The Kinetic Molecular Theory of Liquids & Solids Gases vs. Liquids & Solids difference is distance between molecules Liquids Molecules close together;

More information

Lecture 6 - Bonding in Crystals

Lecture 6 - Bonding in Crystals Lecture 6 onding in Crystals inding in Crystals (Kittel Ch. 3) inding of atoms to form crystals A crystal is a repeated array of atoms Why do they form? What are characteristic bonding mechanisms? How

More information

E12 UNDERSTANDING CRYSTAL STRUCTURES

E12 UNDERSTANDING CRYSTAL STRUCTURES E1 UNDERSTANDING CRYSTAL STRUCTURES 1 Introduction In this experiment, the structures of many elements and compounds are rationalized using simple packing models. The pre-work revises and extends the material

More information

Lattice energy of ionic solids

Lattice energy of ionic solids 1 Lattice energy of ionic solids Interatomic Forces Solids are aggregates of atoms, ions or molecules. The bonding between these particles may be understood in terms of forces that play between them. Attractive

More information

CHEMISTRY The Molecular Nature of Matter and Change

CHEMISTRY The Molecular Nature of Matter and Change CHEMISTRY The Molecular Nature of Matter and Change Third Edition Chapter 12 Copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or display. Chapter 11 INTERMOLECULAR FORCES

More information

10. Calculate the mass percent nitrogen in (NH 4 ) 2 CO 3 (molar mass = g/mol). a % c % e % b % d % f. 96.

10. Calculate the mass percent nitrogen in (NH 4 ) 2 CO 3 (molar mass = g/mol). a % c % e % b % d % f. 96. Chem 1721/1821: Final Exam Review Multiple Choice Problems 1. What is the molar mass of barium perchlorate, Ba(ClO 4 ) 2? a. 189.90 g/mol c. 272.24 g/mol e. 336.20 g/mol b. 240.24 g/mol d. 304.24 g/mol

More information

Investigations of Freezing Pure Water

Investigations of Freezing Pure Water Investigations of Freezing Pure Water David Meldgin Constanze Kalcher May 2, 2013 Abstract We use a the molecular simulation package LAAMPS to simulate the freezing of water. We analyze the SPC and TIP3P

More information

CHAPTER 2: BONDING AND PROPERTIES

CHAPTER 2: BONDING AND PROPERTIES CHAPTER 2: BONDING AND PROPERTIES ISSUES TO ADDRESS... What promotes bonding? What types of bonds are there? What properties are inferred from bonding? Chapter 2-1 Atomic Structure (Freshman Chem.) atom

More information

CHEM 172 EXAMINATION 1. January 15, 2009

CHEM 172 EXAMINATION 1. January 15, 2009 CHEM 17 EXAMINATION 1 January 15, 009 Dr. Kimberly M. Broekemeier NAME: Circle lecture time: 9:00 11:00 Constants: c = 3.00 X 10 8 m/s h = 6.63 X 10-34 J x s J = kg x m /s Rydberg Constant = 1.096776 x

More information

Introduction to molecular dynamics

Introduction to molecular dynamics 1 Introduction to molecular dynamics Yves Lansac Université François Rabelais, Tours, France Visiting MSE, GIST for the summer Molecular Simulation 2 Molecular simulation is a computational experiment.

More information

What factors affect whether something is a solid, liquid or gas? What actually happens (breaks) when you melt various types of solids?

What factors affect whether something is a solid, liquid or gas? What actually happens (breaks) when you melt various types of solids? States of Mattter What factors affect whether something is a solid, liquid or gas? What actually happens (breaks) when you melt various types of solids? What external factors affect whether something is

More information

Chem 1100 Pre-Test 3. Multiple Choice Identify the choice that best completes the statement or answers the question.

Chem 1100 Pre-Test 3. Multiple Choice Identify the choice that best completes the statement or answers the question. Chem 1100 Pre-Test 3 Multiple Choice Identify the choice that best completes the statement or answers the question. 1. An open-tube manometer is used to measure the pressure in a flask. The atmospheric

More information

Materials 218/UCSB: Class III Cohesion in solids van der Waals, ionic, covalent, metallic

Materials 218/UCSB: Class III Cohesion in solids van der Waals, ionic, covalent, metallic Materials 218/UCSB: Class III Cohesion in solids van der Waals, ionic, covalent, metallic Ram Seshadri (seshadri@mrl.ucsb.edu) Introduction There are four forces in nature. The strong and the weak interactions

More information

Ch. 8 Chemical Bonding: General Concepts. Brady & Senese, 5th Ed

Ch. 8 Chemical Bonding: General Concepts. Brady & Senese, 5th Ed Ch. 8 Chemical Bonding: General Concepts Brady & Senese, 5th Ed Index 8.1. Electron transfer leads to the formation of ionic compounds 8.2. Lewis symbols help keep track of valence electrons 8.3. Covalent

More information

GHW#3. Chapter 3. Louisiana Tech University, Chemistry 481. POGIL(Process Oriented Guided Inquiry Learning) Exercise on Chapter 3.

GHW#3. Chapter 3. Louisiana Tech University, Chemistry 481. POGIL(Process Oriented Guided Inquiry Learning) Exercise on Chapter 3. GHW#3. Chapter 3. Louisiana Tech University, Chemistry 481. POGIL(Process Oriented Guided Inquiry Learning) Exercise on Chapter 3. Energetics of Ionic Bonding. Why? What are the properties of ionic compounds?

More information

Subject of the Lecture:

Subject of the Lecture: Subject of the Lecture: Conceptual basis for the development of force fields. Implementation/validation Water - a worked example Extensions - combining molecular mechanics and quantum mechanics (QM/MM)

More information

Chapter 12. Insert picture from First page of chapter. Intermolecular Forces and the Physical Properties of Liquids and Solids

Chapter 12. Insert picture from First page of chapter. Intermolecular Forces and the Physical Properties of Liquids and Solids Chapter 12 Insert picture from First page of chapter Intermolecular Forces and the Physical Properties of Liquids and Solids Copyright McGraw-Hill 2009 1 12.1 Intermolecular Forces Intermolecular forces

More information

General Chemistry II CHM202 Unit 1 Practice Test

General Chemistry II CHM202 Unit 1 Practice Test General Chemistry II CHM202 Unit 1 Practice Test 1. Ion dipole forces always require a. an ion and a water molecule. d. an ion and a polar molecule. b. a cation and a water molecule. e. a polar and a nonpolar

More information

lectures accompanying the book: Solid State Physics: An Introduction, by Philip ofmann (2nd edition 2015, ISBN-10: 3527412824, ISBN-13: 978-3527412822, Wiley-VC Berlin. www.philiphofmann.net 1 Bonds between

More information

The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals.

The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals. Physical Metallurgy The broad topic of physical metallurgy provides a basis that links the structure of materials with their properties, focusing primarily on metals. Crystal Binding In our discussions

More information

Houston Community College System. Chemistry EXAM # 3A Sample

Houston Community College System. Chemistry EXAM # 3A Sample Houston Community College System Chemistry 1411 EXAM # A Sample 1 CHEM 1411 EXAM # (Chapters 8, 9,10,and 11) Name: Score: Directions- please answer the following multiple-choice questions next to each

More information

Unusual Entropy of Adsorbed Methane on Zeolite Templated Carbon. Supporting Information. Part 2: Statistical Mechanical Model

Unusual Entropy of Adsorbed Methane on Zeolite Templated Carbon. Supporting Information. Part 2: Statistical Mechanical Model Unusual Entropy of Adsorbed Methane on Zeolite Templated Carbon Supporting Information Part 2: Statistical Mechanical Model Nicholas P. Stadie*, Maxwell Murialdo, Channing C. Ahn, and Brent Fultz W. M.

More information

Chapter 2: Atomic structure and interatomic bonding. Chapter 2: Atomic structure and interatomic bonding

Chapter 2: Atomic structure and interatomic bonding. Chapter 2: Atomic structure and interatomic bonding Chapter 2: Atomic structure and interatomic bonding Fundamental concepts Electrons in atoms Periodic table Bonding forces and energies Chapter 2: Atomic structure and interatomic bonding Fundamental concepts

More information

Biomolecular modeling I

Biomolecular modeling I 2015, December 15 Biomolecular simulation Elementary body atom Each atom x, y, z coordinates A protein is a set of coordinates. (Gromacs, A. P. Heiner) Usually one molecule/complex of interest (e.g. protein,

More information

FINAL EXAM REVIEW CHM IB DR. DIXON

FINAL EXAM REVIEW CHM IB DR. DIXON DISCLAIMER: SOME OF THIS MATERIAL WAS TAKEN FROM OTHER MATERIALS CREATED BY OTHER SI LEADERS. THERE IS A POSSIBILITY THAT THIS REVIEW CONTAINS ERRORS. PLEASE REFER TO YOUR TEXTBOOK, CLASS SLIDES OR YOUR

More information

IB Topics 5 & 15 Multiple Choice Practice

IB Topics 5 & 15 Multiple Choice Practice IB Topics 5 & 15 Multiple Choice Practice 1. Which statement is correct for this reaction? Fe 2O 3 (s) + 3CO (g) 2Fe (s) + 3CO 2 (g) ΔH = 26.6 kj 13.3 kj are released for every mole of Fe produced. 26.6

More information

Chapter 10. Dipole Moments. Intermolecular Forces (IMF) Polar Bonds and Polar Molecules. Polar or Nonpolar Molecules?

Chapter 10. Dipole Moments. Intermolecular Forces (IMF) Polar Bonds and Polar Molecules. Polar or Nonpolar Molecules? Polar Bonds and Polar Molecules Chapter 10 Liquids, Solids, and Phase Changes Draw Lewis Structures for CCl 4 and CH 3 Cl. What s the same? What s different? 1 Polar Covalent Bonds and Dipole Moments Bonds

More information

1.4 Crystal structure

1.4 Crystal structure 1.4 Crystal structure (a) crystalline vs. (b) amorphous configurations short and long range order only short range order Abbildungen: S. Hunklinger, Festkörperphysik, Oldenbourg Verlag represenatives of

More information

Chem. 112 spring 2012 Exam 1 7:30am/Odago Wednesday March 7, 2012

Chem. 112 spring 2012 Exam 1 7:30am/Odago Wednesday March 7, 2012 Chem. 112 spring 2012 Exam 1 7:0am/Odago Wednesday March 7, 2012 Attempt all the questions and fill in your answers correctly on the scantron provided 1. A particular gas exerts a pressure of 4.6 atm.

More information

5.2 Energy. N Goalby chemrevise.org Lattice Enthalpy. Definitions of enthalpy changes

5.2 Energy. N Goalby chemrevise.org Lattice Enthalpy. Definitions of enthalpy changes 5.2 Energy 5.2.1 Lattice Enthalpy Definitions of enthalpy changes Enthalpy change of formation The standard enthalpy change of formation of a compound is the energy transferred when 1 mole of the compound

More information

Atoms, Molecules and Solids (selected topics)

Atoms, Molecules and Solids (selected topics) Atoms, Molecules and Solids (selected topics) Part I: Electronic configurations and transitions Transitions between atomic states (Hydrogen atom) Transition probabilities are different depending on the

More information

8. Relax and do well.

8. Relax and do well. CHEM 15 Exam II John II. Gelder March 4, 1999 Name TA's Name Lab Section INSTRUCTIONS: 1. This examination consists of a total of 7 different pages. The last two pages includes a periodic table, a solubility

More information

Bonding and the Determination of Melting Points and Boiling Points

Bonding and the Determination of Melting Points and Boiling Points Bonding and the Determination of Melting Points and Boiling Points Melting Point/Freezing Point: The temperature at which a liquid becomes a solid and a solid becomes a liquid. 0 C is the freezing point

More information

a) 1.3 x 10 3 atm b) 2.44 atm c) 8.35 atm d) 4.21 x 10-3 atm e) 86.5 atm

a) 1.3 x 10 3 atm b) 2.44 atm c) 8.35 atm d) 4.21 x 10-3 atm e) 86.5 atm 1. (6 pts) A sample of gas with a volume of 750 ml exerts a pressure of 756 mm Hg at 30.0 0 C. What pressure (atm) will the sample exert when it is compressed to 250 ml and cooled to -25.0 0 C? a) 1.3

More information

Chem 1A Dr. White Fall 2015 Exam 3 Practice Problems

Chem 1A Dr. White Fall 2015 Exam 3 Practice Problems Exam 3 Practice Problems 1. The face centered cubic cell of copper has an edge length of 0.362 nm. Calculate the density of copper (g/cm 3 ). 2. Consider the following ionic substances and arrange them

More information

Supporting Information for: Physics Behind the Water Transport through. Nanoporous Graphene and Boron Nitride

Supporting Information for: Physics Behind the Water Transport through. Nanoporous Graphene and Boron Nitride Supporting Information for: Physics Behind the Water Transport through Nanoporous Graphene and Boron Nitride Ludovic Garnier, Anthony Szymczyk, Patrice Malfreyt, and Aziz Ghoufi, Institut de Physique de

More information

Ionic Bonding. Example: Atomic Radius: Na (r = 0.192nm) Cl (r = 0.099nm) Ionic Radius : Na (r = 0.095nm) Cl (r = 0.181nm)

Ionic Bonding. Example: Atomic Radius: Na (r = 0.192nm) Cl (r = 0.099nm) Ionic Radius : Na (r = 0.095nm) Cl (r = 0.181nm) Ionic Bonding Ion: an atom or molecule that gains or loses electrons (acquires an electrical charge). Atoms form cations (+charge), when they lose electrons, or anions (- charge), when they gain electrons.

More information

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules

Bioengineering 215. An Introduction to Molecular Dynamics for Biomolecules Bioengineering 215 An Introduction to Molecular Dynamics for Biomolecules David Parker May 18, 2007 ntroduction A principal tool to study biological molecules is molecular dynamics simulations (MD). MD

More information

Chem 112 Dr. Kevin Moore

Chem 112 Dr. Kevin Moore Chem 112 Dr. Kevin Moore Gas Liquid Solid Polar Covalent Bond Partial Separation of Charge Electronegativity: H 2.1 Cl 3.0 H Cl δ + δ - Dipole Moment measure of the net polarity in a molecule Q Q magnitude

More information

This semester. Books

This semester. Books Models mostly proteins from detailed to more abstract models Some simulation methods This semester Books None necessary for my group and Prof Rarey Molecular Modelling: Principles and Applications Leach,

More information

Ch. 9 NOTES ~ Chemical Bonding NOTE: Vocabulary terms are in boldface and underlined. Supporting details are in italics.

Ch. 9 NOTES ~ Chemical Bonding NOTE: Vocabulary terms are in boldface and underlined. Supporting details are in italics. Ch. 9 NOTES ~ Chemical Bonding NOTE: Vocabulary terms are in boldface and underlined. Supporting details are in italics. I. Review: Comparison of ionic and molecular compounds Molecular compounds Ionic

More information

Na + Cl ion pair association in water-dmso mixtures: Effect of ion pair model potentials

Na + Cl ion pair association in water-dmso mixtures: Effect of ion pair model potentials J. Chem. Sci. Vol. 128, No. 6, June 2016, pp. 1003 1010. c Indian Academy of Sciences. DOI 10.1007/s12039-016-1093-1 Na + Cl ion pair association in water-dmso mixtures: Effect of ion pair model potentials

More information

General Physical Chemistry II

General Physical Chemistry II General Physical Chemistry II Lecture 13 Aleksey Kocherzhenko October 16, 2014" Last time " The Hückel method" Ø Used to study π systems of conjugated molecules" Ø π orbitals are treated separately from

More information

The exam time is 1hr45 minutes. Try to finish this practice exam in the same time.

The exam time is 1hr45 minutes. Try to finish this practice exam in the same time. Practice exam for final exam, Chem 1210, Dr. Wu Note: The exam time is 1hr45 minutes. Try to finish this practice exam in the same time. 1. Which of the following gases will exhibit the least ideal behavior?

More information

BROOKLYN COLLEGE Department of Chemistry. Chemistry 1 Second Lecture Exam Nov. 27, Name Page 1 of 5

BROOKLYN COLLEGE Department of Chemistry. Chemistry 1 Second Lecture Exam Nov. 27, Name Page 1 of 5 BROOKLYN COLLEGE Department of Chemistry Chemistry 1 Second Lecture Exam Nov. 27, 2002 Name Page 1 of 5 Circle the name of your lab instructor Kobrak, Zhou, Girotto, Hussey, Du Before you begin the exam,

More information

Chem 1100 Pre-Test 3. Multiple Choice Identify the choice that best completes the statement or answers the question.

Chem 1100 Pre-Test 3. Multiple Choice Identify the choice that best completes the statement or answers the question. Chem 1100 Pre-Test 3 Multiple Choice Identify the choice that best completes the statement or answers the question. 1. Determine the oxidation number of the underlined element in K 2CO 3. a. 1 b. 2 c.

More information

Complicated, short range. þq 1 Q 2 /4p3 0 r (Coulomb energy) Q 2 u 2 /6(4p3 0 ) 2 ktr 4. u 2 1 u2 2 =3ð4p3 0Þ 2 ktr 6 ðkeesom energyþ

Complicated, short range. þq 1 Q 2 /4p3 0 r (Coulomb energy) Q 2 u 2 /6(4p3 0 ) 2 ktr 4. u 2 1 u2 2 =3ð4p3 0Þ 2 ktr 6 ðkeesom energyþ Bonding ¼ Type of interaction Interaction energy w(r) Covalent, metallic Complicated, short range Charge charge þq 1 Q 2 /4p3 0 r (Coulomb energy) Charge dipole Qu cos q/4p3 0 r 2 Q 2 u 2 /6(4p3 0 ) 2

More information

Intermolecular Forces

Intermolecular Forces Intermolecular Forces Molecular Compounds The simplest molecule is H 2 : Increased electron density draws nuclei together The pair of shared electrons constitutes a covalent bond. Intermolecular Forces

More information

ก ก ก Intermolecular Forces: Liquids, Solids, and Phase Changes

ก ก ก Intermolecular Forces: Liquids, Solids, and Phase Changes ก ก ก Intermolecular Forces: Liquids, Solids, and Phase Changes ก ก ก ก Mc-Graw Hill 1 Intermolecular Forces: Liquids, Solids, and Phase Changes 12.1 An Overview of Physical States and Phase Changes 12.2

More information

Molecule Matters van der Waals Molecules

Molecule Matters van der Waals Molecules Molecule Matters van der Waals Molecules 3. Rg HF Complexes are Debye Molecules! E Arunan In this article, Debye s contributions to understanding van der Waals attractive forces, specifically, dipole induced

More information

Using Molecular Dynamics to Compute Properties CHEM 430

Using Molecular Dynamics to Compute Properties CHEM 430 Using Molecular Dynamics to Compute Properties CHEM 43 Heat Capacity and Energy Fluctuations Running an MD Simulation Equilibration Phase Before data-collection and results can be analyzed the system

More information

A MOLECULAR DYNAMICS SIMULATION OF WATER DROPLET IN CONTACT WITH A PLATINUM SURFACE

A MOLECULAR DYNAMICS SIMULATION OF WATER DROPLET IN CONTACT WITH A PLATINUM SURFACE The 6th ASME-JSME Thermal Engineering Joint Conference March 16-2, 23 TED-AJ3-183 A MOLECULAR DYNAMICS SIMULATION OF WATER DROPLET IN CONTACT WITH A PLATINUM SURFACE Tatsuto KIMURA Department of Mechanical

More information

1.8 Thermodynamics. N Goalby chemrevise.org. Definitions of enthalpy changes

1.8 Thermodynamics. N Goalby chemrevise.org. Definitions of enthalpy changes 1.8 Thermodynamics Definitions of enthalpy changes Enthalpy change of formation The standard enthalpy change of formation of a compound is the energy transferred when 1 mole of the compound is formed from

More information

Bonding forces and energies Primary interatomic bonds Secondary bonding Molecules

Bonding forces and energies Primary interatomic bonds Secondary bonding Molecules Chapter 2. Atomic structure and interatomic bonding 2.1. Atomic structure 2.1.1.Fundamental concepts 2.1.2. Electrons in atoms 2.1.3. The periodic table 2.2. Atomic bonding in solids 2.2.1. Bonding forces

More information

Name Date Class MOLECULAR COMPOUNDS. Distinguish molecular compounds from ionic compounds Identify the information a molecular formula provides

Name Date Class MOLECULAR COMPOUNDS. Distinguish molecular compounds from ionic compounds Identify the information a molecular formula provides 8.1 MOLECULAR COMPOUNDS Section Review Objectives Distinguish molecular compounds from ionic compounds Identify the information a molecular formula provides Vocabulary covalent bond molecule diatomic molecule

More information

Chapter 7. Ionic & Covalent Bonds

Chapter 7. Ionic & Covalent Bonds Chapter 7 Ionic & Covalent Bonds Ionic Compounds Covalent Compounds 7.1 EN difference and bond character >1.7 = ionic 0.4 1.7 = polar covalent 1.7 Electrons not shared at

More information

All-atom Molecular Mechanics. Trent E. Balius AMS 535 / CHE /27/2010

All-atom Molecular Mechanics. Trent E. Balius AMS 535 / CHE /27/2010 All-atom Molecular Mechanics Trent E. Balius AMS 535 / CHE 535 09/27/2010 Outline Molecular models Molecular mechanics Force Fields Potential energy function functional form parameters and parameterization

More information

Chemistry 101 Chapter 9 CHEMICAL BONDING. Chemical bonds are strong attractive force that exists between the atoms of a substance

Chemistry 101 Chapter 9 CHEMICAL BONDING. Chemical bonds are strong attractive force that exists between the atoms of a substance CHEMICAL BONDING Chemical bonds are strong attractive force that exists between the atoms of a substance Chemical Bonds are commonly classified into 3 types: 1. IONIC BONDING Ionic bonds usually form between

More information

Liquids, Solids, and Phase Changes

Liquids, Solids, and Phase Changes C h a p t e r 10 Liquids, Solids, and Phase Changes KMT of Liquids and Solids 01 Gases have little or no interactions. Liquids and solids have significant interactions. Liquids and solids have well-defined

More information

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

1. Increasing the pressure above a liquid will cause the boiling point of the liquid to:

1. Increasing the pressure above a liquid will cause the boiling point of the liquid to: JASPERSE CHEM 210 PRACTICE TEST 1 VERSION 2 Ch. 11 Liquids, Solids, and Materials Ch. 10 Gases Ch. 15 The Chemistry of Solutes and Solutions Ch. 13 Chemical Kinetics 1 Constants and/or Formulas Formulas

More information

CHEM 121a Exam 4 Fall 1998

CHEM 121a Exam 4 Fall 1998 Name SSN CHEM 121a Exam 4 Fall 1998 This exam consists of 8 true-false questions (each worth 2 pts), 20 multiple choice questions (each worth 3 pts), and 3 short problems (each worth 8 pts). There are

More information

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구

Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 Intermolecular Forces and Monte-Carlo Integration 열역학특수연구 2003.3.28 Source of the lecture note. J.M.Prausnitz and others, Molecular Thermodynamics of Fluid Phase Equiliria Atkins, Physical Chemistry Lecture

More information

Ionic Bonding. Chem

Ionic Bonding. Chem Whereas the term covalent implies sharing of electrons between atoms, the term ionic indicates that electrons are taken from one atom by another. The nature of ionic bonding is very different than that

More information

Chapter 2: Atomic structure and interatomic bonding

Chapter 2: Atomic structure and interatomic bonding Chapter 2: Atomic structure and interatomic bonding Fundamental concepts Electrons in atoms Periodic table Bonding forces and energies Chapter 2 - Chapter 2: Atomic structure and interatomic bonding Fundamental

More information

Atoms, electrons and Solids

Atoms, electrons and Solids Atoms, electrons and Solids Shell model of an atom negative electron orbiting a positive nucleus QM tells that to minimize total energy the electrons fill up shells. Each orbit in a shell has a specific

More information

Multiple Choice. Multiple Choice

Multiple Choice. Multiple Choice 1. At what temperature in degree Celcius is the value in degree Fahrenheit twice of that in degree Celcius? A) 160 o C B) -24.6 o C C) 6.4 o C D) 22.2 o C E) 32 o C 2. The correct name for NaOCl is, A)

More information

Chapter 9 Ionic and Covalent Bonding

Chapter 9 Ionic and Covalent Bonding Chem 1045 Prof George W.J. Kenney, Jr General Chemistry by Ebbing and Gammon, 8th Edition Last Update: 06-April-2009 Chapter 9 Ionic and Covalent Bonding These Notes are to SUPPLIMENT the Text, They do

More information

PROPERTIES OF SOLIDS SCH4U1

PROPERTIES OF SOLIDS SCH4U1 PROPERTIES OF SOLIDS SCH4U1 Intra vs. Intermolecular Bonds The properties of a substance are influenced by the force of attraction within and between the molecules. Intra vs. Intermolecular Bonds Intramolecular

More information

Chapter 9 MODELS OF CHEMICAL BONDING

Chapter 9 MODELS OF CHEMICAL BONDING Chapter 9 MODELS OF CHEMICAL BONDING 1 H H A + B H H A B A comparison of metals and nonmetals 2 9.1 Atomic Properties & Chemical Bonds Chemical bond: A force that holds atoms together in a molecule or

More information

Solutions and Ions. Pure Substances

Solutions and Ions. Pure Substances Class #4 Solutions and Ions CHEM 107 L.S. Brown Texas A&M University Pure Substances Pure substance: described completely by a single chemical formula Fixed composition 1 Mixtures Combination of 2 or more

More information

Chem Midterm 3 April 23, 2009

Chem Midterm 3 April 23, 2009 Chem. 101 - Midterm 3 April 3, 009 Name All work must be shown on the exam for partial credit. Points will be taken off for incorrect or no units and for the incorrect number of significant figures. Only

More information

Chapter 7. Chemical Bonding I: Basic Concepts

Chapter 7. Chemical Bonding I: Basic Concepts Chapter 7. Chemical Bonding I: Basic Concepts Chemical bond: is an attractive force that holds 2 atoms together and forms as a result of interactions between electrons found in combining atoms We rarely

More information

Molecular dynamics simulation of Aquaporin-1. 4 nm

Molecular dynamics simulation of Aquaporin-1. 4 nm Molecular dynamics simulation of Aquaporin-1 4 nm Molecular Dynamics Simulations Schrödinger equation i~@ t (r, R) =H (r, R) Born-Oppenheimer approximation H e e(r; R) =E e (R) e(r; R) Nucleic motion described

More information

Intermolecular Forces

Intermolecular Forces Intermolecular Forces H covalent bond (stronger) Cl H Cl intermolecular attraction (weaker) The attractions between molecules are not nearly as strong as the covalent bonds that hold atoms together. They

More information