COSMO module interface of COLUMBUS

Size: px
Start display at page:

Download "COSMO module interface of COLUMBUS"

Transcription

1 COSMO module interface of COLUMBUS The implementation follows the scheme given in the appendix. Include File cosinc.h Maximum dimensions for direct allocation of smaller arrays. A description of the parameters is given by the comments in the file. Files Beside the cosmo specific files a filehandle for the COLUMBUS output (warnings, errors, etc.) icolum has to be passed to the cosmo module. Open statements of cosmo specific files: cosmo input file open(icosin,file= cosmo.inp,form='formatted', err=...) The next three files are used to store matrix elements of the interaction with the outer cavity and the not inverted A matrix. Because we need them only once we store them in a file and read them before performing the outlying charge corrections. At the end of this read procedure all three files can be deleted. open(icosa2,file='a2mat.tmp',form='unformatted', status='unknown',err=...) open(icosa3,file='a3mat.tmp',form='unformatted', status='unknown',err=...) open(icosa,file='amat',form='unformatted', status='unknown',err=...) The next two files are used to store the cavity surface and some derivative information. These files persist, because sude might be used by a gradient program. open(icosco,file='cosurf',status='unknown',err=...) open(icossu,file='sude',status='unknown',err=...) The information of the cosmo calculation is summarized in the cosmo file, which can be read by the COSMOtherm and the gradient program: open(icosout,file=out.cosmo, form='formatted', status='unknown',err=...) For the gradient calculation (case=7) the following files have to be opened: open(icosout,file='out.cosmo', form='formatted', status='unknown',err=...) open(icosin,file='cosmo.inp', form='formatted', status='unknown',err=...) open(icossu,file='sude',status='unknown',err=...) Input description cosmo.inp The lines are free format, but should not exceed 80 columns. The is used to introduce a comment. Blanc lines are not allowed.

2 The input file consists of the radii and the parameter definition. The radii can be defined in two ways: 1) radius all <nuc. charge> <radius> defines a radius (Å) for all atoms with the given nuc. charge e.g. radius all will define the radius 1.3 Å for all hydrogen atoms. 2) radius < of atom> <radius> e.g. radius defines a radius of 2.0 Å for atom number eleven. Because settings which are not needed for the calculation will be neglected, the whole set of common radii can be given as a standard input. The example cosmo.inp file contains all optimized radii. For other elements we use the v. der Waals radii multiplied by Parameters can be defined as follows: <parameter name> = <value> You can find a list in the example cosmo.inp. If no parameters are given the default values are used. For standard calculations only the radii have to be given. Example input file: all radii in Angstroem optimized radii radius all H radius all C radius all O radius all N radius all F radius all Cl radius all Br radius all I radius all S radii R_bondi * 1.17 radius all Si radius all P radius all Se default values for parameter nppa = 1082 number of basis grid points per atom nspa = 92 number of segments per (non H) atom the number of seg. per H will be calculated by the program disex = 10.0 for distances smaller than disex*mean atomic diameter the A-matrix element will be calculated using the basis grid points of the segments. routf = 0.85 factor for outer sphere construction rsolv = 1.3 add. radius for SAS construction (Angstroem) cavity = 1 1 -> closed; 0-> open open: intersection of spheres will not be filled with segments phsran = 0.0 phase offset for coordinate randomization in consts.f ampran = amplitude factor for coordinate randomization in consts.f refraction index for excited state calculation choose a reasonable value for the solvent refraction_index = 1.2 if epsilon is not set here, it will be treated as

3 infinit -> f(eps)=1. For non default settings, give epsilon as follows epsilon = 80.0 if an item is defined twice, the last item is used! common block common /cosmovar/ icosin, icosa2, icosa3, icosa, icosco, icossu, icosout, icolum common /cos/ eps, fepsi, disex, disex2, rsolv, routf, nspa, nsph, nppa, area, refind, fn2, lcavity, srad(maxat), tm(3,3,maxat), nn(3,maxat), volume, phsran, ampran Signature of the cosmo routine cosmo(case, xyz, mtype, natoms, sym, cosurf, nps, npspher, phi, qcos, e, elast, a1mat, a2mat, a3mat, dcos) Dimensions: These are the exact dimensions: xyz(3,natoms), real*8 (first dimension for x,y,z coordinates) mtype(natoms), integer cosurf(3,nps+npspher), real*8 (first dimension for x,y,z coordinates) phi(nps), real*8 qcos(nps), real*8 a1mat(nps*(nps+1)/2), real*8 a2mat(npspher,nps), real*8 a3mat(npspher*(npspher+1)/2), real*8 dcos(3,natoms), real*8 Because nps (number of segments of the cavity) is not known before the cavity construction, we use maxnps for the arrays, which have to be allocated before the cavity construction. cosurf(3,2*maxnps) a1mat(maxnps*(maxnps+1)/2) Parameter description: case: integer, determines the case xyz: array of atomic coordinates mtype: array of atom charges without dummies in the same order than xyz. natoms: integer: number of atoms sym: interger or character specifying symmetry cosurf: COSMO surface (coordinates of segments/charges) containing the coordinates for the "normal" cavity used in case = 2 and the outer cavity used in case = 4.

4 nps, npspher: integer: numbers of segments, needed for the potential calculations for step 3/5 and 4/6. phi: array of potential at the given coordinates. qcos: array of charges e: ectric energy elast: last SCF energy (for final output) dcos: A-matrix contribution of the cart. gradient Variables only included for allocation: a1mat: A matrix, has to be kept during the whole procedure a2mat: Interaction of segments on the cavity with segments on the outer cavity. Only used with case=4/6 a3mat: A matrix for segments on the outer cavity. Only used with case=4/6 Functionality -> cosmo: updated by COLUMBUS <- cosmo: updated by the cosmo routine case = 1 -> cosmo: mtype und natoms <- cosmo: Initialization: The routine will read the input file (icosin). The parameters are kept inside the cosmo routine using SAVE, so COLUMBUS just has to call the cosmo(1,...) routine. case = 2 -> cosmo: xyz, mtype, natoms, a1mat (memory), cosurf, isym <- cosmo: cosurf, nps, npspher As in the first passage the cosmo internals will be saved by SAVE. Additionally some files are written: icosa2: file for A2 matrix (interaction of segments on the cavity with segments on the outer cavity) icosa3: file for A3 matrix (A matrix for segments on the outer cavity) icosa: file for the original, non inverted A matrix icosa2,icosa3, and icosa can be deleted after step case=4 icosco: file containing information about the surface (for debug) icossu: file containing information about surface derivatives (for gradient program) The cosurf array, which contains the coordinates of the cavity segments/charges and the two parameters defining the number of segments are given by cosmo. case = 3 -> cosmo: phi, nps <- cosmo: qcos, e The array of the potentials for the cavity segments has to be

5 given by COLUMBUS (Potential for nps points starting with cosurf(1,1) ). cosmo will return the corresponding screening charges qcos and the ectric energy e. Please note: The charges have to be multiplied by f(ε) (fepsi) before they are used to calculate the solvent modified one-electron integrals. Substract e from the energy calculated with the scaled screening charges to gain elast, the energy of the SCF step. * ( q = f (ε )q Sceening charges outside the module, passed by the interface or written to out.cosmo are always unscaled (q*). Because qcos is also used in case=4, the values in the array should not be changed) case = 4 -> cosmo: xyz, mtype, natoms, cosurf, nps, npspher, qcos, phi (outer cavity), elast, e, a1mat(memory), a2mat (memory), a3mat (memory) <- cosmo: Phi now contains the potential on the outer cavity. ( The potential has to be calculated for npspher points starting at cosurf(1,nps+1)) cosmo performs the outlying charge correction and writes the output file out.cosmo containing the coordinates, energies, charges... Please note: qcos contains the unscaled screening charges q*. case = 5 -> cosmo: phi( ), nps <- cosmo: qcos( ), e case=3 equivalent for excited states. phi( ) is defined as the difference between the ground state potential phi(p0) (from the ground state cosmo file) and the current potential. The module calculates e with respect to the potential difference ( E ( ) ), using the scaling factor f(n 2 ). The refraction index has to be defined in the cosmo.inp file (see example). Analogous to case=3 the screening charges qcos( ) have to be multiplied by f(n 2 ) (fn2). The total charges for the calculation of the solvent-modified one-electron integrals are given by: qcos(p0)*fepsi + qcos( )*fn2 qcos(p0) denotes the corrected (outlying charge correction) screening charges, which can be read from the ground state cosmo file (section $segment_information). Note: As in case=3 The energy has to be reduced by the ectric energy: corr E = ECI E ( P 0 ) E ( ) E CI is the Energy including the screening charges in the one elec. part of the operator. case = 6 -> cosmo: xyz, mtype, natoms, cosurf, nps, npspher, qcos, phi (outer cavity), elast, e, a1mat(memory), a2mat (memory), a3mat (memory) <- cosmo: phi = Φ ( ) on the outer cavity qcos = q ( ) corr elast = E E E ( P 0 ) E ( ) = CI (E CI is the Energy including the ext. pot. in the one elec. part of the operator.)

6 corr e = E ( P 0 ) E ( ) E corr ( P 0 ) + can be read from the out.cosmo file of the ground state calculation (Dielectric energy corr. [a.u.]). case=4 equivalent for excited states. The module calculates the correction for E ( ). Due to the definition of elast and e the out.cosmo files will give the corrected energies for the excited state (the fixed ground state potential inclusive). The charges in the out.cosmo file are corrected (outlying charge correction) qcos( ) values. case=6 should be used in combination with case=5 only. Thus, the cosmo file for the excited sates consists of the total corrected energies E = E E corr CI E corr = E + OC( ) ( P 0 ) E ( ) but the potential and the charges are the corrected q( ) and Φ( ) values. case = 7 -> cosmo: xyz, sym, mtype, qcos(memory), cosurf(memory) (The files that are used by the gradient routine are defined above) <- cosmo: dcos, qcos, cosurf case=7 calculates the gradient contribution arising from the cavity as defined below. qcos and cosurf are filled with data from the out.cosmo file. These data can be used to perform the derivative of the potential. nps and fepsi are also updated with case=7. The program reads the files sude and out.cosmo from the energy calculation. These files contain all information needed, so case=7 can be use as stand alone. An initialization with case=1 is not needed. The full gradient of the additional cosmo energy is given as: * q = f (ε )q For scaled screening charges X E 1 cos = q Aq + q Φ mo 2 f ( ε ) (G1) For unscaled screening charges 1 * * * X Ecos mo = f ( ε) q Aq + q Φ (G2) 2 1 * * case=7 calculates the first term of the sum: q Aq 2 Additional to the formulas mentioned in J. Chem. Soc. Perkin Trans. 2 (1993) a surface derivative term can be included. This term takes the change of the cavity surface into account. Because of the small contribution of the surface derivative term, we neglect it for symmetries higher than C1. The total cosmo gradient contribution (G2) can be calculated as follows: 1 * * 1) get the q Aq part by using the cosmo module with case=7 2 * X 2) calculate q Φ 3) add the two terms and multiply the sum by fepsi (fepsi from common /cos/)

7 Units: All parameters are used in a.u. inside the module. Symmetry: In the case of symmetry, cosurf, e, phi, qcos, nps, are npspher are defined for the irred.. xyz, mtype, natoms, and elast are needed for whole system. case=2 provides the reduced cosurf, nps, and npspher. These values are used to calculate the potential on the remaining surface. In case =3/5 the screening charges qcos and the ectric energy e is calculated for the irred. These values are given to case=4 together with the total energy elast for the whole system. The cosmofile contains information for the whole molecule like in the C1 symmetry case. Like the cosmo.out, the dcos array in case=7 contains the symmetric cart. gradients for all atoms. Because COLUMBUS is the first program using cosmo routines with symmetry we don t have experience using symmetry along with our grid construction scheme. Results calculated using different symmetries are not exactly the same, but should be in a range of the accuracy of the continuum model. One should avoid to calculate small molecules with high symmetries. Especially cosmo energies of charged molecules should be more sensitive to the choice of the symmetry. It is recommended to perform test calculations for the molecules and symmetries of interest. A comparison of the cosmo energies calculated with C1 and higher symmetries (single point HF) shows the influence of the symmetry used. For excited states the same symmetry is used for the ground state and the excited state of interest. Thus the same cavity surface (grid) is used for both calculations. Literature: COSMO Theory 1) A. Klamt, G. Schüürmann, J. Chem. Soc. Perkin Trans. 1993, 1, ) A. Klamt, Encyclopedia of Computational Chemistry, p.604, Wiley Excited States 3) A. Klamt, J. Phys. Chem 1996, 100, Synopsis of the TURBOMOLE Implementation 4) A. Schäfer, A. Klamt, D. Sattel, J. C. W. Lohrenz, F. Eckert, Phys. Chem. Phys. 2000, 2, Appendix List of most important variables Variable a1mat(nps*(nps+1)/2) a1matmax(maxnps*(maxnps+1)/2) ampran ar(2*maxnps) area cosurf(3*2*maxnps) dcos(3*maxat) dirsm(3*nspa) dirsmh(3*nsph) dirtm(3*nppa) dirvec(3*nppa) disex Description array for the lower triangular of the A-matrix temporary array for the A-matrix amplitude factor for coordinate randomization in consts.f area of segment surface area of the cavity COSMO surface (position of segments): cosurf(3 (xyz),2*maxnps (segments)) segments 1 - nps -> surface of cavity segments nps+1 - nps+npspher -> surface of outer sphere (outlying charge corr.) array of cart. gradient (A-matrix cont.) direction vector for atomic basis grid (non H atoms) direction vector for hydrogen atom basis grid direction vectors after atomic transformation direction vectors before atomic transformation for distances smaller than disex*mean atomic

8 diameter the A-matrix element will be calculated using the basis grid points of the segments. disex2: (disex*mean atomic diameter)**2 eps ε fepsi factor f(ε) fepsi=(eps-1.d0)/(eps+0.5d0) fn2 scaling factor for excited sate calc. f(n 2 ) iatsp(2*maxnps) number of atom the segment belongs to lcavity use closed (1) or open (0) cavity maxat maximal number of atoms maxnppa max. number of nppa maxnps maximum number of nps maxnspa maximum number of nspa maxnsph max. number of nsph maxrepl max. number of replicates (symmetry) mtype(maxat) element type of atoms (integer) nar(2*maxnps) number of basic grid points per segment natoms number of atoms nn(3,maxat) the three next neighbors of atom i nps number of segments of the cavity npsd npsd= nps + npspher npspher number of segmnets of the outersphere (outlying charge correction) nspa number of segments per atom for non hydrogen atoms nsph number of segments per hydrogen atom nppa: nppa total number of basis grid points (default: 1082) phi(nps) potential on the segments phsran phase offset for coordinate randomization in consts.f qcos(nps) screening charge on the segments refind refraction index (for excited states) routf factor for outer sphere construction. The radii on the outer sphere are defined as: ri=ri+routf*rsolv. The outer sphere is used for the outlying charge corrections. rsolv add. radius for SAS construction. smtype(maxat) element type of atoms (lower case symbols) srad(maxat) set of radii of all atoms (after initialization the radii include rsolv: ri+rsolv!!!) tm(3,3,maxat) atomic transformation matrix for the basis grid points tm(3,3, atom) see consts.f volume volume of cavity xsp(3*2*maxnps) array for segment centers (to build cosurf)

9 Scheme: COSMO in SCF case=1 Initialization: -read parameter or set defaults case=2. basis grid construction, cavity and A matrix construction COLUMBUS Determine electrostatic potential Phi on surface grid case=3 Calculate COSMO charges qcos = - A**(-1) * Phi Calculate ectric energy: E = 0.5 * fepsi * qcos * Phi COLUMBUS Add the entire electrostatic potential of the screening charges as an external potential to the one-electron part of the Fock matrix. Substact half of the solute continuum interaction energy (e) from the received SCF energy. no conv. yes case=4 Make outlying charge correction and final printout.

INPUT DESCRIPTION FOR SQM version 2.0

INPUT DESCRIPTION FOR SQM version 2.0 INPUT DESCRIPTION FOR SQM version 2.0 INTRODUCTION SQM is an add-on module for the PQS program which scales force constants to produce a Scaled Quantum Mechanical (SQM) Force Field. This can correct for

More information

Accounting for Solvation in Quantum Chemistry. Comp chem spring school 2014 CSC, Finland

Accounting for Solvation in Quantum Chemistry. Comp chem spring school 2014 CSC, Finland Accounting for Solvation in Quantum Chemistry Comp chem spring school 2014 CSC, Finland In solution or in a vacuum? Solvent description is important when: Polar solvent: electrostatic stabilization Solvent

More information

COSMO-RS Theory. The Basics

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

More information

INPUT DESCRIPTION FOR SQM version 1.0

INPUT DESCRIPTION FOR SQM version 1.0 INPUT DESCRIPTION FOR SQM version 1.0 INTRODUCTION SQM is an add-on module for the PQS program which scales force constants to produce a Scaled Quantum Mechanical (SQM) Force Field. This can correct for

More information

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

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

More information

Description of the MULFIT program February 1998 by G. G. Ferenczy, C. A. Reynolds and P. J. Winn modified by A. J.

Description of the MULFIT program February 1998 by G. G. Ferenczy, C. A. Reynolds and P. J. Winn modified by A. J. Description of the MULFIT program February 1998 by G. G. Ferenczy, C. A. Reynolds and P. J. Winn modified by A. J. Stone, 2006 2009 1 Introduction This program is the realisation of a method for calculating

More information

EVALUATING COSMO-RS FOR VAPOR LIQUID EQUILIBRIUM AND TURBOMOLE FOR IDEAL GAS PROPERTIES. A Thesis. Presented to

EVALUATING COSMO-RS FOR VAPOR LIQUID EQUILIBRIUM AND TURBOMOLE FOR IDEAL GAS PROPERTIES. A Thesis. Presented to EVALUATING COSMO-RS FOR VAPOR LIQUID EQUILIBRIUM AND TURBOMOLE FOR IDEAL GAS PROPERTIES A Thesis Presented to The Graduate Faculty of the University of Akron In Partial Fulfillment of the Requirements

More information

Modeling in Solution. Important Observations. Energy Concepts

Modeling in Solution. Important Observations. Energy Concepts Modeling in Solution 1 Important Observations Various electrostatic effects for a solvated molecule are often less important than for an isolated gaseous molecule when the molecule is dissolved in a solvent

More information

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION S1 # Supplementary Material (ESI) for Dalton Transaction # This journal is The Royal Society of Chemistry 2007 SUPPLEMENTARY INFORMATION Stable Lewis acid chelate of a bis(imido) tungsten compound and

More information

C:\Users\Leonardo\Desktop\README_ELMO_NOTES.txt Montag, 7. Juli :48

C:\Users\Leonardo\Desktop\README_ELMO_NOTES.txt Montag, 7. Juli :48 *********** * Input * *********** Besides the normal GAMESS-UK input directives, to perform an ELMO calculation one needs to specify the elmo keyword and to provide additional instructions that are contained

More information

DISTILLATION SIMULATION WITH COSMO-RS

DISTILLATION SIMULATION WITH COSMO-RS DISILLAION SIMULAION WIH COSMO-RS R. aylor*, **, H.A. Kooiman***, A. Klamt****, and F. Eckert**** * Department of Chemical Engineering, Clarkson University, Potsdam, NY 3699-5705, USA ** Department of

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

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

Supporting Information to: Theoretical analysis of the solvent effects on the magnetic exchange coupling in bis-nitroxides

Supporting Information to: Theoretical analysis of the solvent effects on the magnetic exchange coupling in bis-nitroxides Supporting Information to: Theoretical analysis of the solvent effects on the magnetic exchange coupling in bis-nitroxides Esther Coulaud, Denis Hagebaum-Reigner, Didier Siri, Paul Tordo and Nicolas Ferré

More information

PLATON/SQUEEZE. Ton Spek. Bijvoet Center Utrecht University, The Netherlands. PLATON Workshop

PLATON/SQUEEZE. Ton Spek. Bijvoet Center Utrecht University, The Netherlands. PLATON Workshop PLATON/SQUEEZE Ton Spek Bijvoet Center Utrecht University, The Netherlands. PLATON Workshop Chicago, 24-July-2010 The Disordered Solvent Problem Molecules of interest often co-crystallize (only) with the

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

Property Prediction in Reactive Solutions

Property Prediction in Reactive Solutions Property Prediction in Reactive Solutions Karin Wichmann*,1 1 COSMOlogic GmbH & Co. KG, Leverkusen, Germany In reactive solutions, reaction educts and products are coexistent and their concentrations are

More information

Computation of non-bonded interactions: Part 1

Computation of non-bonded interactions: Part 1 Computation of non-bonded interactions: Part 1 Computation of non-local (non-bonded) interactions in the potential function E p non-local scales with the number of atoms as N. For the large molecular systems

More information

Boundary Element Method Calculations of LDOS and Decay Rates

Boundary Element Method Calculations of LDOS and Decay Rates Appendix A Boundary Element Method Calculations of LDOS and Decay Rates A.1 Decay Rates in Atomic Units This appendix provides a brief tutorial for BEM calculations of the total and radiative decay rates,

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

Ionic Bonding - Electrostatic Interactions and Polarization

Ionic Bonding - Electrostatic Interactions and Polarization Ionic Bonding - Electrostatic Interactions and Polarization Chemistry 754 Solid State Chemistry Dr. Patrick Woodward Lecture #13 Born-Haber Cycle for NaCl It is energetically unfavorable for Na metal and

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

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web CHAPTER -4 COMPUTATIONAL TOOL Ph.D. Thesis: J. Maibam CHAPTER: 4 4.1 The WIEN2k code In this work, all the calculations presented are performed using the WIEN2k software package (Blaha et al., 2001). The

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

AP Physics C. Electric Potential and Capacitance. Free Response Problems

AP Physics C. Electric Potential and Capacitance. Free Response Problems AP Physics C Electric Potential and Capacitance Free Response Problems 1. Two stationary point charges + are located on the y-axis at a distance L from the origin, as shown above. A third charge +q is

More information

2 Review: Modeling Molecules with Spherical Balls

2 Review: Modeling Molecules with Spherical Balls CS273: Algorithms for Structure Handout # 12 and Motion in Biology Stanford University Thursday, 6 May 2003 Lecture #12: 6 May 2004 Topics: Geometric Models of Molecules II Scribe: Itamar Rosenn 1 Introduction

More information

Self-consistent Field

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

More information

Application of electrostatic Solvent Models to the Electronic Spectrum of Mesityl Oxide

Application of electrostatic Solvent Models to the Electronic Spectrum of Mesityl Oxide Journal of Basrah Researches ((Sciences Volume 38. Number 1. ((2012 vailable online at: www.basra-science journal.org 2695 1817 ISSN pplication of electrostatic Solvent Models to the Electronic Spectrum

More information

Polarizable Continuum Model Implementation in the Octopus code

Polarizable Continuum Model Implementation in the Octopus code Polarizable Continuum Model Implementation in the Octopus code Alain Delgado, Carlo Andrea Rozzi, Stefano Corni S3 Center, CNR Institute of Nanoscience, Modena, Italy. Outline 1- The basics of the Polarizable

More information

Physics (

Physics ( Question 2.12: A charge of 8 mc is located at the origin. Calculate the work done in taking a small charge of 2 10 9 C from a point P (0, 0, 3 cm) to a point Q (0, 4 cm, 0), via a point R (0, 6 cm, 9 cm).

More information

Bonding in Solids. What is the chemical bonding? Bond types: Ionic (NaCl vs. TiC?) Covalent Van der Waals Metallic

Bonding in Solids. What is the chemical bonding? Bond types: Ionic (NaCl vs. TiC?) Covalent Van der Waals Metallic Bonding in Solids What is the chemical bonding? Bond types: Ionic (NaCl vs. TiC?) Covalent Van der Waals Metallic 1 Ions and Ionic Radii LiCl 2 Ions (a) Ions are essentially spherical. (b) Ions may be

More information

Study of Iron Dimers Reveals Angular Dependence of Valence- to- Core X- ray Emission Spectra

Study of Iron Dimers Reveals Angular Dependence of Valence- to- Core X- ray Emission Spectra Supporting Information for: Study of Iron Dimers Reveals Angular Dependence of Valence- to- Core X- ray Emission Spectra Christopher J. Pollock, a Kyle M. Lancaster, b Kenneth D. Finkelstein, c Serena

More information

Supporting Information

Supporting Information Supporting Information Copyright Wiley-VCH Verlag GmbH & Co. KGaA, 69451 Weinheim, 2013 Photochemistry of N-Methylformamide: Matrix Isolation and Nonadiabatic Dynamics Rachel Crespo-Otero, [a] Artur Mardyukov,

More information

Definition 2.3. We define addition and multiplication of matrices as follows.

Definition 2.3. We define addition and multiplication of matrices as follows. 14 Chapter 2 Matrices In this chapter, we review matrix algebra from Linear Algebra I, consider row and column operations on matrices, and define the rank of a matrix. Along the way prove that the row

More information

Appendix A. LabView programs. The block diagram of the main Rydberg experiment LabVIEW program is shown in figure A.1.

Appendix A. LabView programs. The block diagram of the main Rydberg experiment LabVIEW program is shown in figure A.1. Appendix A LabView programs The block diagram of the main Rydberg experiment LabVIEW program is shown in figure A.1. Figure A.1: The block diagram of the main Rydberg experiment LabVIEW program. In the

More information

Department of Chemistry. The Intersection of Computational Chemistry and Experiment

Department of Chemistry. The Intersection of Computational Chemistry and Experiment Department of Chemistry The Intersection of Computational Chemistry and Experiment Structure, Vibrational and Electronic Spectra of Organic Molecules Angelo R. Rossi Department of Chemistry The University

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

k θ (θ θ 0 ) 2 angles r i j r i j

k θ (θ θ 0 ) 2 angles r i j r i j 1 Force fields 1.1 Introduction The term force field is slightly misleading, since it refers to the parameters of the potential used to calculate the forces (via gradient) in molecular dynamics simulations.

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

PHYSICS WORKSHEET CLASS : XII

PHYSICS WORKSHEET CLASS : XII PHYSICS WORKSHEET CLASS : XII Chapter 2 Topic: Electrostatic potential and Capacitance LEVEL 1 1. Define electric potential. Derive the expression for the electric potential at any point due to a point

More information

Lecture outline: Chapter 7 Periodic properties

Lecture outline: Chapter 7 Periodic properties Lecture outline: Chapter 7 Periodic properties 1. Electrostatic effects 2. Atomic size 3. Ionization energy 4. Electron affinity it 5. Summarize some periodic properties 1 Some important terms Electron

More information

Supporting Information for. Electric field analyses on monolayer semiconductors: An. example of InSe

Supporting Information for. Electric field analyses on monolayer semiconductors: An. example of InSe Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2018 Supporting Information for Electric field analyses on monolayer semiconductors:

More information

1 Bulk Simulations in a HCP lattice

1 Bulk Simulations in a HCP lattice 1 Bulk Simulations in a HCP lattice 1.1 Introduction This project is a continuation of two previous projects that studied the mechanism of melting in a FCC and BCC lattice. The current project studies

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

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

Chapter 4. Electrostatic Fields in Matter

Chapter 4. Electrostatic Fields in Matter Chapter 4. Electrostatic Fields in Matter 4.1. Polarization 4.2. The Field of a Polarized Object 4.3. The Electric Displacement 4.4. Linear Dielectrics 4.5. Energy in dielectric systems 4.6. Forces on

More information

Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015,

Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015, Biochemistry,530:,, Introduc5on,to,Structural,Biology, Autumn,Quarter,2015, Course,Informa5on, BIOC%530% GraduateAlevel,discussion,of,the,structure,,func5on,,and,chemistry,of,proteins,and, nucleic,acids,,control,of,enzyma5c,reac5ons.,please,see,the,course,syllabus,and,

More information

MODIFIED PROXIMITY CRITERIA FOR THE ANALYSIS OF THE SOLVATION OF A POLYFUNCTIONAL SOLUTE.

MODIFIED PROXIMITY CRITERIA FOR THE ANALYSIS OF THE SOLVATION OF A POLYFUNCTIONAL SOLUTE. Molecular Simulation 1988, Vol. 1 pp.327-332 c 1988 Gordon and Breach Science Publishers S.A. MODIFIED PROXIMITY CRITERIA FOR THE ANALYSIS OF THE SOLVATION OF A POLYFUNCTIONAL SOLUTE. MIHALY MEZEI Department

More information

Bohr Model of Hydrogen Atom

Bohr Model of Hydrogen Atom Bohr Model of Hydrogen Atom electrons move in circular orbits around nucleus orbits can only be of certain radii each radius corresponds to different energy ( only certain energies are allowed) n - defines

More information

F = Q big = c) The electric potential in a certain region of space can be described by the equation: 16y2 (1 + z 2 ) V (x, y, z) = 10x

F = Q big = c) The electric potential in a certain region of space can be described by the equation: 16y2 (1 + z 2 ) V (x, y, z) = 10x 1) Short Answer (4 points each)(show YOUR WORK) a) A 3.0 nc (positive) charge and a 1.0 nc (negative) charge are located 0.80 m apart from each other. What is the force on the 3.0 nc (positive) charge

More information

Atoms & Their Interactions

Atoms & Their Interactions Lecture 2 Atoms & Their Interactions Si: the heart of electronic materials Intel, 300mm Si wafer, 200 μm thick and 48-core CPU ( cloud computing on a chip ) Twin Creeks Technologies, San Jose, Si wafer,

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

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

74 these states cannot be reliably obtained from experiments. In addition, the barriers between the local minima can also not be obtained reliably fro

74 these states cannot be reliably obtained from experiments. In addition, the barriers between the local minima can also not be obtained reliably fro 73 Chapter 5 Development of Adiabatic Force Field for Polyvinyl Chloride (PVC) and Chlorinated PVC (CPVC) 5.1 Introduction Chlorinated polyvinyl chloride has become an important specialty polymer due to

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

Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay. Poisson s and Laplace s Equations

Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay. Poisson s and Laplace s Equations Poisson s and Laplace s Equations Lecture 13: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay We will spend some time in looking at the mathematical foundations of electrostatics.

More information

Lecture 15 Perfect Conductors, Boundary Conditions, Method of Images

Lecture 15 Perfect Conductors, Boundary Conditions, Method of Images Lecture 15 Perfect Conductors, Boundary Conditions, Method of Images Sections: 5.4, 5.5 Homework: See homework file Perfect Conductors 1 metals such as Cu, Ag, Al are closely approximated by the concept

More information

Dielectrics - III. Lecture 22: Electromagnetic Theory. Professor D. K. Ghosh, Physics Department, I.I.T., Bombay

Dielectrics - III. Lecture 22: Electromagnetic Theory. Professor D. K. Ghosh, Physics Department, I.I.T., Bombay Dielectrics - III Lecture 22: Electromagnetic Theory Professor D. K. Ghosh, Physics Department, I.I.T., Bombay We continue with our discussion of dielectric medium. Example : Dielectric Sphere in a uniform

More information

Calculation of Reduction/Oxidation Potentials with COSMOtherm

Calculation of Reduction/Oxidation Potentials with COSMOtherm Calculation of Reduction/Oxidation Potentials with COSMOtherm Christoph Loschen, COSMOlogic GmbH & Co.KG Abstract: Accurate reduction and oxidation potentials can be obtained by COSMOtherm(X) by computation

More information

Lecture 14 - Capacitors

Lecture 14 - Capacitors Lecture 14 - Capacitors A Puzzle... Gravity Screen Insulators are often thought of as "electrical screens," since they block out all external electric fields. For example, if neutral objects are kept inside

More information

Supporting Information

Supporting Information Supporting Information Copyright Wiley-VCH Verlag GmbH & Co. KGaA, 69451 Weinheim, 2013 Expansion of Access Tunnels and Active-Site Cavities Influence Activity of Haloalkane Dehalogenases in Organic Cosolvents

More information

Publication II Wiley Periodicals. Reprinted by permission of John Wiley & Sons.

Publication II Wiley Periodicals. Reprinted by permission of John Wiley & Sons. Publication II Ilkka Laakso and Tero Uusitupa. 2008. Alternative approach for modeling material interfaces in FDTD. Microwave and Optical Technology Letters, volume 50, number 5, pages 1211-1214. 2008

More information

Finite Element Analysis of Molecular Rydberg States

Finite Element Analysis of Molecular Rydberg States Excerpt from the Proceedings of the COMSOL Conference 2009 Boston Finite Element Analysis of Molecular Rydberg States M. G. Levy, R. M. Stratt, and P. M. Weber* Brown University Department of Chemistry

More information

Using the Periodic Table

Using the Periodic Table MATH SKILLS TRANSPARENCY WORKSHEET Using the Periodic Table 6 Use with Chapter 6, Section 6.2 1. Identify the number of valence electrons in each of the following elements. a. Ne e. O b. K f. Cl c. B g.

More information

Solutions to Assignment #4 Getting Started with HyperChem

Solutions to Assignment #4 Getting Started with HyperChem Solutions to Assignment #4 Getting Started with HyperChem 1. This first exercise is meant to familiarize you with the different methods for visualizing molecules available in HyperChem. (a) Create a molecule

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

Earth Materials I Crystal Structures

Earth Materials I Crystal Structures Earth Materials I Crystal Structures Isotopes same atomic number, different numbers of neutrons, different atomic mass. Ta ble 1-1. Su mmar y of quantu m num bers Name Symbol Values Principal n 1, 2,

More information

1. I can use Collision Theory to explain the effects of concentration, particle size, temperature, and collision geometry on reaction rates.

1. I can use Collision Theory to explain the effects of concentration, particle size, temperature, and collision geometry on reaction rates. Chemical Changes and Structure Learning Outcomes SECTION 1 Controlling the Rate. Subsection (a) Collision Theory 1. I can use Collision Theory to explain the effects of concentration, particle size, temperature,

More information

Concepts of Chemical Bonding and Molecular Geometry Part 1: Ionic and Covalent Bonds. David A. Katz Pima Community College Tucson, AZ

Concepts of Chemical Bonding and Molecular Geometry Part 1: Ionic and Covalent Bonds. David A. Katz Pima Community College Tucson, AZ Concepts of Chemical Bonding and Molecular Geometry Part 1: Ionic and Covalent Bonds David A. Katz Pima Community College Tucson, AZ Chemical Bonds Three basic types of bonds: Ionic Electrostatic attraction

More information

Multiconfigurational Quantum Chemistry. Björn O. Roos as told by RL Department of Theoretical Chemistry Chemical Center Lund University Sweden

Multiconfigurational Quantum Chemistry. Björn O. Roos as told by RL Department of Theoretical Chemistry Chemical Center Lund University Sweden Multiconfigurational Quantum Chemistry Björn O. Roos as told by RL Department of Theoretical Chemistry Chemical Center Lund University Sweden April 20, 2009 1 The Slater determinant Using the spin-orbitals,

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

Using a Membrane DM to Generate Zernike Modes

Using a Membrane DM to Generate Zernike Modes Using a Membrane DM to Generate Zernike Modes Author: Justin D. Mansell, Ph.D. Active Optical Systems, LLC Revision: 12/23/08 Membrane DMs have been used quite extensively to impose a known phase onto

More information

4. How to prove a problem is NPC

4. How to prove a problem is NPC The reducibility relation T is transitive, i.e, A T B and B T C imply A T C Therefore, to prove that a problem A is NPC: (1) show that A NP (2) choose some known NPC problem B define a polynomial transformation

More information

Supporting Information

Supporting Information Supporting Information Shroff et al. 10.1073/pnas.0900914106 SI Text Details of Mass Spectrometry Measurements. Identification of ions. The identities of ions were confirmed by accurate mass measurements,

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

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

Chapter 5. Effects of Photonic Crystal Band Gap on Rotation and Deformation of Hollow Te Rods in Triangular Lattice

Chapter 5. Effects of Photonic Crystal Band Gap on Rotation and Deformation of Hollow Te Rods in Triangular Lattice Chapter 5 Effects of Photonic Crystal Band Gap on Rotation and Deformation of Hollow Te Rods in Triangular Lattice In chapter 3 and 4, we have demonstrated that the deformed rods, rotational rods and perturbation

More information

V(φ) CH 3 CH 2 CH 2 CH 3. High energy states. Low energy states. Views along the C2-C3 bond

V(φ) CH 3 CH 2 CH 2 CH 3. High energy states. Low energy states. Views along the C2-C3 bond Example V(φ): Rotational conformations of n-butane C 3 C C C 3 Potential energy of a n-butane molecule as a function of the angle φ of bond rotation. V(φ) Potential energy/kj mol -1 0 15 10 5 eclipse gauche

More information

Module17: Intermolecular Force between Surfaces and Particles. Lecture 23: Intermolecular Force between Surfaces and Particles

Module17: Intermolecular Force between Surfaces and Particles. Lecture 23: Intermolecular Force between Surfaces and Particles Module17: Intermolecular Force between Surfaces and Particles Lecture 23: Intermolecular Force between Surfaces and Particles 1 We now try to understand the nature of spontaneous instability in a confined

More information

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION

August 7, 2007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION August 7, 007 NUMERICAL SOLUTION OF LAPLACE'S EQUATION PURPOSE: This experiment illustrates the numerical solution of Laplace's Equation using a relaxation method. The results of the relaxation method

More information

Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Spring Semester Christopher J. Cramer. Lecture 30, April 10, 2006

Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Spring Semester Christopher J. Cramer. Lecture 30, April 10, 2006 Chem 3502/4502 Physical Chemistry II (Quantum Mechanics) 3 Credits Spring Semester 20056 Christopher J. Cramer Lecture 30, April 10, 2006 Solved Homework The guess MO occupied coefficients were Occupied

More information

Symmetry: Translation and Rotation

Symmetry: Translation and Rotation Symmetry: Translation and Rotation The sixth column of the C 2v character table indicates the symmetry species for translation along (T) and rotation about (R) the Cartesian axes. y y y C 2 F v (x) T x

More information

Module 5.2: nag sym lin sys Symmetric Systems of Linear Equations. Contents

Module 5.2: nag sym lin sys Symmetric Systems of Linear Equations. Contents Linear Equations Module Contents Module 5.2: nag sym lin sys Symmetric Systems of Linear Equations nag sym lin sys provides a procedure for solving real or complex, symmetric or Hermitian systems of linear

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

Computational Chemistry. An Introduction to Molecular Dynamic Simulations

Computational Chemistry. An Introduction to Molecular Dynamic Simulations Computational Chemistry An Introduction to Molecular Dynamic Simulations Computational chemistry simulates chemical structures and reactions numerically, based in full or in part on the fundamental laws

More information

Physical Chemistry II Laboratory

Physical Chemistry II Laboratory Kuwata Spring 2003 Physical Chemistry II Laboratory The Rovibrational Spectra of H 35 Cl and H 37 Cl Using FTIR Write-Up Due Date: Thursday, April 17 (You may record spectra and write your reports in teams

More information

HOMEWORK #2 - MA 504

HOMEWORK #2 - MA 504 HOMEWORK #2 - MA 504 PAULINHO TCHATCHATCHA Chapter 1, problem 6. Fix b > 1. (a) If m, n, p, q are integers, n > 0, q > 0, and r = m/n = p/q, prove that (b m ) 1/n = (b p ) 1/q. Hence it makes sense to

More information

CPSC 490 Problem Solving in Computer Science

CPSC 490 Problem Solving in Computer Science CPSC 490 Problem Solving in Computer Science Lecture 6: Recovering Solutions from DP, Bitmask DP, Matrix Exponentiation David Zheng and Daniel Du Based on CPSC490 slides from 2014-2017 2018/01/23 Announcements

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

Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information

Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information Amino Acids and Proteins at ZnO-water Interfaces in Molecular Dynamics Simulations: Electronic Supplementary Information Grzegorz Nawrocki and Marek Cieplak Institute of Physics, Polish Academy of Sciences,

More information

Lecture 8 Multiple Choice Questions :

Lecture 8 Multiple Choice Questions : Lecture 8 Multiple Choice Questions : 1. A point charge -3Q lies at the centre of a conducting shell of radius 2R. The net charge on the outer surface of the shell is -3Q Zero +1.5 Q d. +3Q 2. Two identical

More information

Supporting information for: Ultrafast Transient Absorption Spectroscopy of. the Sunscreen Constituent Ethylhexyl Triazone

Supporting information for: Ultrafast Transient Absorption Spectroscopy of. the Sunscreen Constituent Ethylhexyl Triazone Supporting information for: Ultrafast Transient Absorption Spectroscopy of the Sunscreen Constituent Ethylhexyl Triazone Lewis A. Baker,,, Sarah L. Clark, Scott Habershon,, and Vasilios G. Stavros, Department

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

Capacitance. Chapter 21 Chapter 25. K = C / C o V = V o / K. 1 / Ceq = 1 / C / C 2. Ceq = C 1 + C 2

Capacitance. Chapter 21 Chapter 25. K = C / C o V = V o / K. 1 / Ceq = 1 / C / C 2. Ceq = C 1 + C 2 = Chapter 21 Chapter 25 Capacitance K = C / C o V = V o / K 1 / Ceq = 1 / C 1 + 1 / C 2 Ceq = C 1 + C 2 Copyright 25-2 Capacitance 25.01 Sketch a schematic diagram of a circuit with a parallel-plate capacitor,

More information

Carbon Compounds. Chemical Bonding Part 2

Carbon Compounds. Chemical Bonding Part 2 Carbon Compounds Chemical Bonding Part 2 Introduction to Functional Groups: Alkanes! Alkanes Compounds that contain only carbons and hydrogens, with no double or triple bonds.! Alkyl Groups A part of a

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

Indiana University Physics P331: Theory of Electromagnetism Review Problems #3

Indiana University Physics P331: Theory of Electromagnetism Review Problems #3 Indiana University Physics P331: Theory of Electromagnetism Review Problems #3 Note: The final exam (Friday 1/14 8:00-10:00 AM will be comprehensive, covering lecture and homework material pertaining to

More information

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

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

More information

Counting Dots Kwok-Wai Ng Feb 1, 2007

Counting Dots Kwok-Wai Ng Feb 1, 2007 Counting Dots Kwok-Wai Ng Feb 1, 007 This sounds so easy (indeed it is not difficult), yet so simple that we never think about it carefully. When we are asked to do it, suddenly we do not know what to

More information

Upper Limit in Mendeleev s Periodic Table

Upper Limit in Mendeleev s Periodic Table International Journal of Advanced Research in Physical Science (IJARPS) Volume 4, Issue 3, 2017, PP 14-18 ISSN 2349-7874 (Print) & ISSN 2349-7882 (Online) www.arcjournals.org Upper Limit in Mendeleev s

More information