March 21, 2008 Christopher Bruns

Slides:



Advertisements
Similar presentations
Scientific & technical presentation Structure Visualization with MarvinSpace Oct 2006.
Advertisements

1 Molecular basis of life (1). 2 Chemical basis of molecular interactions Polar and nonpolar molecules Water Universal solvent O-H bonds are polarized.
Lecture 3: Cellular building Blocks - Proteins.
Protein Primer. Outline n Protein representations n Structure of Proteins Structure of Proteins –Primary: amino acid sequence –Secondary:  -helices &
Physics of Protein Folding. Why is the protein folding problem important? Understanding the function Drug design Types of experiments: X-ray crystallography.
Levels of protein structure organization
Inverse Kinematics for Molecular World Sadia Malik April 18, 2002 CS 395T U.T. Austin.
Computational Structure Prediction Kevin Drew BCH364C/391L Systems Biology/Bioinformatics 2/12/15.
RNA Folding Simulation by Giff Ransom RNA Folding Simulation.
Review of Biological Chemistry. Biologically Important Elements.
2-3 Carbon Compounds.
Conformational Sampling
2-3 Carbon Compounds. Carbon Compounds Organic chemistry – the study of compounds that contain bonds between carbon atoms.
 Four levels of protein structure  Linear  Sub-Structure  3D Structure  Complex Structure.
CZ5225 Methods in Computational Biology Lecture 4-5: Protein Structure and Structural Modeling Prof. Chen Yu Zong Tel:
Lecture 11: Potential Energy Functions Dr. Ronald M. Levy Originally contributed by Lauren Wickstrom (2011) Statistical Thermodynamics.
Chapter 22, Macromolecules and aggregates Ideality and reality Simplicity of small systems and complexity of real systems Entropy and order Dealing with.
BL5203 Molecular Recognition & Interaction Section D: Molecular Modeling. Chen Yu Zong Department of Computational Science National University of Singapore.
Polymer Molecule made of many monomers bonded together
Conformational Entropy Entropy is an essential component in ΔG and must be considered in order to model many chemical processes, including protein folding,
10/3/2003 Molecular and Cellular Modeling 10/3/2003 Introduction Objective: to construct a comprehensive simulation software system for the computational.
Molecular Mechanics Studies involving covalent interactions (enzyme reaction): quantum mechanics; extremely slow Studies involving noncovalent interactions.
Covalent interactions non-covalent interactions + = structural stability of (bio)polymers in the operative molecular environment 1 Energy, entropy and.
Introduction to Protein Structure Prediction BMI/CS 576 Colin Dewey Fall 2008.
NIH Resource for Biomolecular Modeling and Bioinformatics Beckman Institute, UIUC Molecular Dynamics Method 2 Justin Gullingsrud.
LSM3241: Bioinformatics and Biocomputing Lecture 6: Fundamentals of Molecular Modeling Prof. Chen Yu Zong Tel:
Hydro-pathy/phobicity/philicity One of the most commonly used properties is the suitability of an amino acid for an aqueous environment Hydropathy & Hydrophobicity.
4.A.1 Biomolecules The subcomponents of biological molecules and their sequence determine the properties of that molecule. Read chapter 5 and complete.
Chemistry XXI Unit 3 How do we predict properties? M1. Analyzing Molecular Structure Predicting properties based on molecular structure. M4. Exploring.
FlexWeb Nassim Sohaee. FlexWeb 2 Proteins The ability of proteins to change their conformation is important to their function as biological machines.
SimTK 1.0 Workshop Downloads Jack Middleton March 20, 2008.
NUCLEIC ACIDS. FUNCTION The main functions of nucleic acids are: –information storage (DNA) – protein synthesis (RNA) –energy transfers (ATP and NAD).
Biochemistry An Introduction to the Chemistry of Life for Biology Students.
Sequence: PFAM Used example: Database of protein domain families. It is based on manually curated alignments.
Unit 4.A 1 – Biomolecules.
Levels of Organization
Computational Structure Prediction
The Chemistry of the Cell
Carbon Compounds.
Chapter 2 Molecular Mechanics
Molecular Geometries & Intermolecular Forces
Levels of Organization
Protein Structure Prediction and Protein Homology modeling
Organic Molecules.
The Chemical Building Blocks of Life
…electrons are transferred
The Chemistry of Life Carbon Compounds.
Computational Analysis
Levels of Organization
Biological Catalysts - Enzymes
Levels of Organization
Biological Molecules -Biological molecules consist primarily of carbon, oxygen, hydrogen, and nitrogen. -These elements share valence electrons to form.
Intro to Molecular Dynamics (MD) Simulation using CHARMM
[ ] [ ] + - EDEXCEL KEY CONCEPTS 2 Types of substances Ionic bonding
CZ5225 Methods in Computational Biology Lecture 7: Protein Structure and Structural Modeling Prof. Chen Yu Zong Tel:
Levels of Organization
Chemistry of Life.
Levels of Organization
Levels of Organization
Levels of Organization
Levels of Organization
Levels of Organization
Volume 99, Issue 1, Pages (July 2010)
…electrons are transferred
Protein structure prediction
- Carbon Compounds 2:3.
Levels of Organization
Presentation transcript:

March 21, 2008 Christopher Bruns Molmodel Workshop March 21, 2008 Christopher Bruns

Schedule 8:30-10:00 Molmodel examples 10:00-10:15 Break 10:15-11:30 More Molmodel examples 11:30 Lunch 12:00 Your projects

What is Molmodel? Domain-specific modeling layer on Simbody Part of SimTK core libraries You should have Programmer’s Guide

Principal SimTK Core Libraries SimTK Molmodel molecular modeling SimTK Simbody order(n) multibody dynamics SimTK Lapack linear algebra SimTK Common Vector, Matrix classes and other data structures SimTK Math numerical methods and linear algebra

Molecular Physical Units Length: nanometers (10-9 meters) Time: picoseconds (10-12 seconds) Mass: atomic mass units (1/(Avogado’sConstant) grams)

Argon Inert “noble” gas Has no chemistry van der Waals forces only

Molecular Force Field What is a molecular force field? A specification of all forces affecting a dynamic simulation. For conventional molecular simulation this includes non-bonded electrostatic forces and van der Waals forces, and bonded stretch, bend, torsion, and improper torsion parameters

Biotype Bridge between structural model and force field implementation Concept borrowed from TINKER molecular dynamics package

Argon Exercises Compile and run TwoArgons example program Add a third argon atom. What happens when atoms start too close together? Too far apart? Increase the attractive force between atoms ten-fold

Ethane Two carbons, six hydrogens One dihedral degree of freedom 3 kcal/mol energy barrier to rotation

Internal coordinates Instead of explicit Cartesian X, Y, Z coordinates for an atom Given three other atom positions, one distance, one bond angle, and one dihedral angle 1 distance ? 1 3 dihedral angle bond angle 2 2 3

Molecule internal coordinates Bond lengths, bond angles, dihedral angles Mandatory for Compound construction Optional for Compound simulation

Ethane Exercises Compile and run TwoEthanes example program Add a third ethane molecule

Macromolecules, residues, and atoms RNA, DNA, and protein are large molecules called macromolecules Macromolecules consist of chains of residues } Macromolecule Atoms Residues

Top level API for constructing proteins #include “SimTKmolmodel.h” Protein(“ACDEFGHIKLMNPQRSTVWY”);

Simple protein Construct protein from sequence All atom parameters are built into AMBER99 force field Note end caps

Protein Exercises Compile and run SimpleProtein example program Try a different sequence Add a second protein

Simple RNA RNA from sequence Writing PDB files

RNA Exercises Compile and run SimpleRNA example program Try a different sequence Change the frequency of PDB writing

PDB: The Protein Data Bank http://www.rcsb.org/pdb/ Repository of DNA, RNA, and protein atomic structures Contains experimental results, not perfect models Entries identified by 4 character ID, e.g. “1MRP”, “1GRZ” Use “advanced search” at PDB web site to find structures.

Search box

4-character ID

PDB File format Text format – humans can read it too Most of the information is atomic coordinates PDB files usually contain multiple molecules, including water molecules … ATOM 1751 N GLY C 250 32.286 1.882 43.206 1.00 22.00 ATOM 1752 CA GLY C 250 32.365 1.086 41.969 1.00 21.39 ATOM 1753 C GLY C 250 31.538 1.735 40.864 1.00 20.79 ATOM 1754 O GLY C 250 30.621 2.527 41.152 1.00 21.58

LoadPdb Exercises Download 1AKG from Protein Data Bank http://www.rcsb.org/pdb Simulate 1AKG using Example

Coarse-grained representations in biology Natural lump sizes: atoms residues base pairs duplexes, alpha helices, beta strands macromolecules molecular assemblies organelles cells tissues organs limbs organisms societies ecosystems biospheres intergalactic federations (picometer to micron scale) (micron to mega-light-year scale)

Coarse-grained simulation of atom-based molecular models Full atom force field coarse-grained motion permits longer integration time steps Increasing coarseness full Cartesian torsion only (internal coordinate) full rigid

Molecule Mobility/Partitioning What is molecule partitioning? defining the movable degrees of freedom that will be used in a molecule simulation Examples of partitioning strategies Internal coordinates (fixed bond lengths and fixed bond angles) Full Cartesian (conventional molecular dynamics) Rigid molecules

Protein Internal Coordinates

Nucleic Acid Internal Coordinates

RigidProtein Exercises Simulate rigid protein Create second protein Convert to full Cartesian model Which way is faster?

Custom Molecule Construction BondCenters, Atoms, Bonds, Compounds Inboard bond center The first few atoms Ring closing bonds

Molecule Construction nomenclature 1: Atoms(3) 2: BondCenters(9) 3: Bonds(2) 4: Compound(1)

Submitting Bug Reports