CS273: Algorithms for Structure Handout # 2 and Motion in Biology Stanford University Thursday, 1 April 2004

Size: px
Start display at page:

Download "CS273: Algorithms for Structure Handout # 2 and Motion in Biology Stanford University Thursday, 1 April 2004"

Transcription

1 CS273: Algorithms for Structure Handout # 2 and Motion in Biology Stanford University Thursday, 1 April 2004 Lecture #2: 1 April 2004 Topics: Kinematics : Concepts and Results Kinematics of Ligands and Proteins Conformational Space and Sampling Molecular Motion Scribe: Gauhar Wadhera 1 Kinematics: The kinematics of a mechanical system specifies topology, degrees of freedom (DOF), velocities, and constraints, without explicit specification of externally applied forces/torques. In the context of molecule linkage models we shall only consider kinematic chains with two components - links and joints. Links are rigid bodies which are connected to each other by joints. We only consider revolute joints with rotation around a single axis. Figure 1 shows an example of such a linkage chain. 1.1 General Concepts and Results: Links, Joints and Degrees of Freedom: A critical concept for studying the kinematics of a system is the notion of degree of freedom. The degrees of freedom of a rigid body is defined as the number of independent movements it has. Figure 2 shows a rigid body in 3-D which can be translated along the three axes or rotated independently about each of them. Thus, it has 6 DOFs in 3-D space. An important concept that goes hand in hand with the degrees of freedom of a system is that of velocity space. The number of DOFs of a system is also the dimensionality of its velocity space General Results for Linkages: Grübler s Formula (1883): Grübler s Formula is used to calculate the number of DOFs as: N DOF = k*(n link -1) - (k-1)*n joint where, k = 3 for planar linkages and 6 for spatial linkages.

2 2 CS273: Handout # 2 Figure 1: Kinematic Chain: L denotes links and J denotes joints. The base is also a link with its coordinates in the world frame. Figure 2: Rigid Body in 3-Dimensional Space. The arrows indicate the 6 degrees of freedom of the body. - Simple Linear Linkage In Figure 1, N link = 4 and N joint = 3. Thus, N DOF = 3*(4-1) - (3-1)*3 = 3. - Simple Linear Linkage with Fixed End Point (a) Original Representation with coordinates of terminal point (b) Additional Link- Joint Interpretation of System Figure 3: Simple Linear Linkage with fixed position of the terminal point In Figure 3(a) the coordinates of the terminal point are fixed. One way to model the constraint is to rigidly attach this point to the base of the linkage as depicted in Figure 3(b). Therefore, N link = 4 and N joint = 4. Thus, N DOF = 3*(4-1) - (3-1)*4 = 1. - Simple Linear Linkage with Fixed Position and Orientation of End Point In Figure 4(a) the position and orientation of the terminal link are fixed. One way to model the constraint is to attach the last link to the linkage base as depicted in Figure 4(b).Therefore, N link = 3 and N joint = 3. Thus, N DOF = 3*(3-1) - (3-1)*3 = 0.

3 CS273: Handout # 2 3 (a) Original Representation with constraints at of terminal point (b) Additional Link- Joint Interpretation of System Figure 4: Simple Linear Linkage with fixed position/orientation of the terminal point 1.2 Forward Kinematics: Forward Kinematics is the problem of determining the positions of the individual links in the world coordinate frame given the rotation values of each joint in the linkage. Figure 5: Simple Linear Chain with 3 links and 2 joints. In Figure 5, given the data about the joint angles and link lengths, we can simple compute the world frame coordinates of (x,y) as: X = d 1 cosθ 1 + d 2 cos (θ 1 + θ 2 ) Y = d 1 sin θ 1 + d 2 sin (θ 1 + θ 2 ) 1.3 Inverse Kinematics: Inverse Kinematics of a serial linkage is the problem of determining the joint angles given the position and/or orientation of the last link. Figure 6 shows a simple example presented in class. In this case a closed form solution exists. In Figure 6 we can easily compute the values of θ 1 and θ 2 using the principles of geometry as:

4 4 CS273: Handout # 2 Figure 6: Inverse Kinematics problem: given (x,y) we need to find θ 1 and θ 2 Figure 7: Two solutions for θ 1 and θ 2 in the configuration given in Figure 6. ( (x θ 1 = cos y 2 d 2 1 d 2 ) 2 ) 2 d 1 d 2 θ 2 = x (d 2 sin θ 2 ) + y (d 1 + d 2 cos θ 2 ) y (d 2 sin θ 2 ) + x (d 1 + d 2 cosθ 2 ) However, a major point to be noted is that two solutions to the above equations exist due to the fact that cos 1 (x) has two values. These solutions are shown in Figure 7. As another example in Figure 8, the linkage with 3 joints and the coordinates for the end point fixed at (x,y), we have infinite solutions Issue: Number of Solutions (a) Original Representation of Inverse Kinematic Problem. (b) Diagram showing several solutions. The null space in this case is 1-D Figure 8: Visualization of the under-constrained system leading to infinte solutions In general, if the number of degrees of freedom is less than the number of constraints then no solutions exist. If the two are equal, there exist a finite number of solutions. In case of more degrees of freedom than constraints, we can have possibly infinite solutions. For example, a serial linkage with 6 joints and a fixed end point we can have upto 16 solutions.

5 CS273: Handout # Analytical IK Techniques: Analytical techniques exist only for systems with upto 6 degrees of freedom in 3D space. The methodoly is as follows: - Reduce the forward kinematic equations in polynomial form by epressing all trigonometric quantitites in terms of t = tanθ/2. - Use domain specific properties in order to simplify the types of configuration possible for the given problem. [1] apply such form of search space pruning in the context of protein structures. - Solve the equations analytically Incremental IK Techniques: The difficulty in solving IK problems analytically is the fact that they are non-linear problems due to the presence of trigonometric terms. Most of the numerical methods use linear approximations of the same. The Jacobian matrix is used in most of the incremental techniques. Let, - θ = n-vector of internal coordinates (usually the values θ i for all the joints). - X = m-vector for the end-point orientation (usually m=6 defining x,y,z,α,β,γ). The relationships can be given as : X = F(θ). dx = J dθ. n f i (θ) dx i = dθ j θ j j = 1 where F is the forward kinematics transform and J is the Jacobian. The Jacobian can be expressed formally as : J = f 1 (θ) θ 1 f 2 (θ) θ 1. f m(θ) θ 1 f 1 (θ) f 1 (θ) θ n f 2 (θ) θ n θ 2... f 2 (θ) θ f m(θ) θ 2... f m(θ) θ n Here, we assume that m is less than or equal to n as otherwise we would not have any solutions.the methods adopted totally depend on the relation between m and n. Jacobian Based Methods: 1. Case : m = n The method can be formulated as follows:

6 6 CS273: Handout # 2 (a) Problem: Given X, find θ such that X = F(θ). (b) Produce an initial guess (X 0, θ 0 ) such that X 0 = F(θ 0 ). (c) Iteration: i. Interpolate linearly between X 0 and X (X 1... X p ). ii. for j = 1 to p do A. θ i = θ i 1 + α J 1 (θ i 1 )(X i - X i 1 ) B. X i = F(θ i ) J is a mxn matrix and with m < n we can assume that the rank of J is at most m. Since the Jacobian is not square in this case we can only find a pseudo inverse following the relatioship J J + = I. We find a pseudo inverse of J and update : θ = J + dx + dθ 0. The computation of J + is done by performing singular value decomposition of J. We get: Figure 9: Result of SVD of J. J = U V T as shown in Figure 9. The p-inverse is then computed as: J + = V + U T where + = diag( 1 σ i ) with σ i = Eigen Values for J Optimization Based Methods: Cyclic Coordinate Descent (CCD) The basic idea of optimization based methods is to take a look at the primary equation θ = f 1 (X) as a minimization problem. Thus, the equation could be transformed into: E(θ) = (P X(θ)) 2. The CCD is based on minimization applied to each joint separately. The steps in one pass are ordered from the most distant segment to the base segment. A number of

7 CS273: Handout # 2 7 passes are made over the manipulator to find the global minimum of the above equation. Since only one joint variable is changing at any time, an analytic solution could be used significantly speeding up the minimization problem. 2 Kinematics of Proteins 2.1 Kinematic Models of Molecules Revisited - Atomistic model: The position of each atom is defined by its coordinates in 3-D space. Constraints on bond lengths/angles are encoded separately. - Linkage model: The kinematics is defined by internal parameters (bond lengths and angles, and torsional angles). Small local changes may have big global effects since even a small change in one torsion angle rotates the entire remaining molecule making it more prone to errors. Another difficulty with the method is that forces are difficult to express with most force models being distance based necessitating coordinate and distance computations. - Simplified Linkage Model: In this model bond lengths and angles are assumed constant and only torsional angles vary. This leaves less parameters to optimize. However, as a result of assuming all other parameters constant we lose the flexibility that exists in actual molecules wrt bond distances and angles. 2.2 Proteins: Basic Structural Features Proteins are polymer chains made up of monomeric units called amino acids. The key bonding component of the protein structure is the peptide bond between two amino acids which sets up the protein chain Amino Acids: Amino acids are the basic structural units of proteins. An alpha-amino acid consists of an amino group, a carboxyl group, a hydrogen atom, and a distinctive R group bonded to a carbon atom, which is called the alpha-carbon. An R group is referred to as a side chain. Figure 10 shows the above defined structure. The 20 amino acids that are found within proteins determine the biological activity of the protein as they contain the necessary information to determine how that protein will fold into a three dimensional structure, and the stability of the resulting structure.

8 8 CS273: Handout # 2 Figure 10: Generic Structure of Amino Acids Peptide Bonds: Even though amino acids that form the actual chain, peptide bonds are an important aspect of protein structure as well since they are the force behind the linking in the protein chain. The peptide bond is slightly shorter than a standard single bond due to partial delocalization of pi electrons from the carbonyl group into orbitals shared with the lone pair electrons of the amide nitrogen which inhibits rotation around the peptide bond; thus, the four atoms bound to the carbonyl carbon and amide nitrogen form a plane (Figure 11). Figure 11: Induced planarity in the peptide bond 2.3 Protein Linkage Model: The salient features of the linkage models of proteins are (given in Figure 12): Figure 12: Linkage Model for Proteins

9 CS273: Handout # The sequence of N-C α -C atoms form the backbone. This is analogous to the links in the simple linear linkage. - Rotatable bonds (torsion angles) along the backbone define the φ ψ torsional degrees of freedom. These bonds perform the role of joints with 1 degree of freedom. - We also have small side-chains corresponding to the amino acids which have a χ degree of freedom about the Cα-Cβ bond Example of Kinematic Chain in Proteins: In Figure 12 with 5 amino acids we have (assuming no role of the χ torsion) 10 links and 10 joints. Applying Grübler s Formula in 3-D we have: N DOF = 6*(n-1) - (6-1)*n = n - 6 = 4 (for n = 10) 3 Conformational Space: A conformation of a molecule or a system in general is a complete specification of the spatial placement of the entire system. In the case of molecules it could be the relative positions of all atoms wrt each other. The conformational space for a system is the set of all possible conformations. 3.1 Typical Representations: Typical Representations of the conformation space include: 1. Coordinate Representation: This representation describes the coordinates of each atom in the molecule and corresponds to the atomistic model of molecules. 2. Torsional Representation: This corresponds to representing each conformation in terms of the torsional angles of the rotatable bonds and assumes the bond lengths and bond angles as constant. 3. Intra-Molecular Distance Matrix: This representation stores the distances between all atoms of the molecule. Despites having a quadratic number of parameters it does capture some very interesting semantics especially in the case of complex folding systems such as proteins. As an example in Figure 13, we can clearly see the effect of folding in proteins. Apart from the diagonal distances to be small, we also have other distant C α atoms clearly indicating the presence of the molecule folding onto itself.

10 10 CS273: Handout # 2 Figure 13: Distances between Cα pairs of a protein with 142 residues. Darker squares represent shorter distances. 3.2 Conformational Space Metrics and the RMSD Measure: A good metric (with all the mathematical properties of a distance metric) should be able to measure how well the atoms in two conformations can be aligned. In this context the RMS Distance/Deviation measure seems to have a lot of relevance. The next few lines describe the basic RMSD measure while the following sections evalute metrics based on RMSD, namely crmsd and drmsd. Given two sets of points in <3 : A = {a1,...,an } and B = {b1,...,bn } The RMSD between A and B is: RMSD(A,B) = (1/n)[ ni=1 kai bi k2 ]1/2 where, kai bi k denotes the Euclidean distance between ai and bi in <3. RMSD(A,B) = 0 iff ai = bi i. P 3.3 crms Distance: Given a Molecule M with n atoms {a1,..., an } and two conformations c and c of M where ai (c) is position of ai when M is at c, we have the crmsd between c and c as the minimized RMSD between the two sets of atom centers: crmsd(c,c ) = mint [(1/n) Pn i=1 kai (c) T (ai (c0 ))k2 ]1/2. The minimization is over all possible rigid-body transforms T. Usually, crmsd is restricted to a subset of atoms, e.g., the Cα atoms on a protein backbone. However, this still remains a non-trivial task since it involves finding the aligning transform.

11 CS273: Handout # drms Distance: Given a Molecule M with n atoms {a 1,..., a n } and Two conformations c and c of M where d ij (c): n x n symmetrical intra-molecular distance matrix in M at c. The drmsd between c and c is : drmsd(c,c ) = [(1/n(n 1)) n i=1 nj=i+1 [d ij (c) d ij (c )] 2 ] 1/2 Usually d ij is restricted to a subset of atoms on order to reduce the load on the algorithm. Even though drmsd does not depend on finding an aligning transform it suffers from having to deal with a quadratic number of parameters. 3.5 Other Topics Covered: Conformational Space Search Mechanisms: In order to be able to simulate stable conformations of molecules (or for that matter any system) we need to develop two notions: 1. Energy Functions: What is a Good Conformation? Energy functions in the conformational space calculate the total amount of energy of the conformation and serve as measures of the quality of any given conformation. Various functions to be covered in later lectures include: - Potential Functions (eg. Electrostatic and Van Der Waal s Potential) - Heuristic Potential Functions (eg. Gō Model) - Explicit/Implicit Silvent Model 2. Conformational Sampling: How do we search in the conformational space? The answer to this question is extremely critical because of the vastness of the conformational space to be search. We need to decide on mechanisms which help us either formally or heuristically in pruning our search space. Certain Sampling Strategies to be discussed later include: - Generation of low-energy conformations - Random Selection and Minimization - Biased Sampling (eg. Ramachandran Plots with bias towards particular torsion angle values) - Monte Carlo Simulations Molecular Motion The lecture also covered briefly the types of molecular motion. These were divided into :

12 12 CS273: Handout # 2 Folding Motion This section briefly discussed the folding motion with two principle motivations: - To understand and build structure prediction models. - To study the folding pathway of the molecules (mostly proteins). The effects of protein folding were discussed by briefly describing the salient features of: (a) Alpha Helix Structure (b) Beta Sheet Structure Figure 14: Secondary Structures of Proteins - The Alpha Helix Structure (Protein Secondary Structure) The alpha helix structure is stabilized by H-bonds between the NH and CO groups which are at a distance of 4 in the main chain. The side chains protrude outwards from the helix and are only responsible for much of the functional bonding of the protein with the environment. - The Beta Sheet Structure (Protein Secondary Structure) These are antiparallel sheets formed from the peptide polymer chain. Adjacent strands run in opposite directions in the actual protein chain with H-bonds formed between the NH and CO groups of the strands. The side chains project out of the strand plane on either sides. - Protein Tertiary Structure The tertiary structure basically evolves from the secondary structure helices and sheets further folding onto each other resulting in complex structures containing varying fractions of helices and sheets. Binding Motion

13 CS273: Handout # 2 13 We shall not be discussing this topic in these lecture notes in detail and shall leave it for the future lectures to cover it in greater detail. The topics covered were: - Ligand-Protein Binding - Protein-Protein Binding References [1] E.A. Coutsias, C. Seok, M.P. Jacobson and K.A. Dill, A Kinematic View of Loop Closure, Jour. of Comutational Chemistry 2004.

Conformational Geometry of Peptides and Proteins:

Conformational Geometry of Peptides and Proteins: Conformational Geometry of Peptides and Proteins: Before discussing secondary structure, it is important to appreciate the conformational plasticity of proteins. Each residue in a polypeptide has three

More information

CAP 5510 Lecture 3 Protein Structures

CAP 5510 Lecture 3 Protein Structures CAP 5510 Lecture 3 Protein Structures Su-Shing Chen Bioinformatics CISE 8/19/2005 Su-Shing Chen, CISE 1 Protein Conformation 8/19/2005 Su-Shing Chen, CISE 2 Protein Conformational Structures Hydrophobicity

More information

Protein Structure. W. M. Grogan, Ph.D. OBJECTIVES

Protein Structure. W. M. Grogan, Ph.D. OBJECTIVES Protein Structure W. M. Grogan, Ph.D. OBJECTIVES 1. Describe the structure and characteristic properties of typical proteins. 2. List and describe the four levels of structure found in proteins. 3. Relate

More information

ON THE INVERSE KINEMATICS OF A FRAGMENT OF PROTEIN BACKBONE

ON THE INVERSE KINEMATICS OF A FRAGMENT OF PROTEIN BACKBONE ON THE INVERSE KINEMATIS OF A FRAGMENT OF PROTEIN BAKBONE Guanfeng Liu, R.J. Milgram, A. Dhanik, and J.. Latombe Department of omputer Science, Stanford University Department of Mathematics, Stanford University

More information

Molecular Modelling. part of Bioinformatik von RNA- und Proteinstrukturen. Sonja Prohaska. Leipzig, SS Computational EvoDevo University Leipzig

Molecular Modelling. part of Bioinformatik von RNA- und Proteinstrukturen. Sonja Prohaska. Leipzig, SS Computational EvoDevo University Leipzig part of Bioinformatik von RNA- und Proteinstrukturen Computational EvoDevo University Leipzig Leipzig, SS 2011 Protein Structure levels or organization Primary structure: sequence of amino acids (from

More information

From Amino Acids to Proteins - in 4 Easy Steps

From Amino Acids to Proteins - in 4 Easy Steps From Amino Acids to Proteins - in 4 Easy Steps Although protein structure appears to be overwhelmingly complex, you can provide your students with a basic understanding of how proteins fold by focusing

More information

Dihedral Angles. Homayoun Valafar. Department of Computer Science and Engineering, USC 02/03/10 CSCE 769

Dihedral Angles. Homayoun Valafar. Department of Computer Science and Engineering, USC 02/03/10 CSCE 769 Dihedral Angles Homayoun Valafar Department of Computer Science and Engineering, USC The precise definition of a dihedral or torsion angle can be found in spatial geometry Angle between to planes Dihedral

More information

Differential Kinematics

Differential Kinematics Differential Kinematics Relations between motion (velocity) in joint space and motion (linear/angular velocity) in task space (e.g., Cartesian space) Instantaneous velocity mappings can be obtained through

More information

Lecture 26: Polymers: DNA Packing and Protein folding 26.1 Problem Set 4 due today. Reading for Lectures 22 24: PKT Chapter 8 [ ].

Lecture 26: Polymers: DNA Packing and Protein folding 26.1 Problem Set 4 due today. Reading for Lectures 22 24: PKT Chapter 8 [ ]. Lecture 26: Polymers: DA Packing and Protein folding 26.1 Problem Set 4 due today. eading for Lectures 22 24: PKT hapter 8 DA Packing for Eukaryotes: The packing problem for the larger eukaryotic genomes

More information

LS1a Fall 2014 Problem Set #2 Due Monday 10/6 at 6 pm in the drop boxes on the Science Center 2 nd Floor

LS1a Fall 2014 Problem Set #2 Due Monday 10/6 at 6 pm in the drop boxes on the Science Center 2 nd Floor LS1a Fall 2014 Problem Set #2 Due Monday 10/6 at 6 pm in the drop boxes on the Science Center 2 nd Floor Note: Adequate space is given for each answer. Questions that require a brief explanation should

More information

BIRKBECK COLLEGE (University of London)

BIRKBECK COLLEGE (University of London) BIRKBECK COLLEGE (University of London) SCHOOL OF BIOLOGICAL SCIENCES M.Sc. EXAMINATION FOR INTERNAL STUDENTS ON: Postgraduate Certificate in Principles of Protein Structure MSc Structural Molecular Biology

More information

Model Mélange. Physical Models of Peptides and Proteins

Model Mélange. Physical Models of Peptides and Proteins Model Mélange Physical Models of Peptides and Proteins In the Model Mélange activity, you will visit four different stations each featuring a variety of different physical models of peptides or proteins.

More information

Assignment 2 Atomic-Level Molecular Modeling

Assignment 2 Atomic-Level Molecular Modeling Assignment 2 Atomic-Level Molecular Modeling CS/BIOE/CME/BIOPHYS/BIOMEDIN 279 Due: November 3, 2016 at 3:00 PM The goal of this assignment is to understand the biological and computational aspects of macromolecular

More information

CHAPTER 29 HW: AMINO ACIDS + PROTEINS

CHAPTER 29 HW: AMINO ACIDS + PROTEINS CAPTER 29 W: AMI ACIDS + PRTEIS For all problems, consult the table of 20 Amino Acids provided in lecture if an amino acid structure is needed; these will be given on exams. Use natural amino acids (L)

More information

Orientational degeneracy in the presence of one alignment tensor.

Orientational degeneracy in the presence of one alignment tensor. Orientational degeneracy in the presence of one alignment tensor. Rotation about the x, y and z axes can be performed in the aligned mode of the program to examine the four degenerate orientations of two

More information

Protein Structure Basics

Protein Structure Basics Protein Structure Basics Presented by Alison Fraser, Christine Lee, Pradhuman Jhala, Corban Rivera Importance of Proteins Muscle structure depends on protein-protein interactions Transport across membranes

More information

Introduction to Comparative Protein Modeling. Chapter 4 Part I

Introduction to Comparative Protein Modeling. Chapter 4 Part I Introduction to Comparative Protein Modeling Chapter 4 Part I 1 Information on Proteins Each modeling study depends on the quality of the known experimental data. Basis of the model Search in the literature

More information

Biomolecules: lecture 9

Biomolecules: lecture 9 Biomolecules: lecture 9 - understanding further why amino acids are the building block for proteins - understanding the chemical properties amino acids bring to proteins - realizing that many proteins

More information

Outline. The ensemble folding kinetics of protein G from an all-atom Monte Carlo simulation. Unfolded Folded. What is protein folding?

Outline. The ensemble folding kinetics of protein G from an all-atom Monte Carlo simulation. Unfolded Folded. What is protein folding? The ensemble folding kinetics of protein G from an all-atom Monte Carlo simulation By Jun Shimada and Eugine Shaknovich Bill Hawse Dr. Bahar Elisa Sandvik and Mehrdad Safavian Outline Background on protein

More information

Biomolecules: lecture 10

Biomolecules: lecture 10 Biomolecules: lecture 10 - understanding in detail how protein 3D structures form - realize that protein molecules are not static wire models but instead dynamic, where in principle every atom moves (yet

More information

BSc and MSc Degree Examinations

BSc and MSc Degree Examinations Examination Candidate Number: Desk Number: BSc and MSc Degree Examinations 2018-9 Department : BIOLOGY Title of Exam: Molecular Biology and Biochemistry Part I Time Allowed: 1 hour and 30 minutes Marking

More information

The Structure and Functions of Proteins

The Structure and Functions of Proteins Wright State University CORE Scholar Computer Science and Engineering Faculty Publications Computer Science and Engineering 2003 The Structure and Functions of Proteins Dan E. Krane Wright State University

More information

Overview. The peptide bond. Page 1

Overview. The peptide bond. Page 1 Overview Secondary structure: the conformation of the peptide backbone The peptide bond, steric implications Steric hindrance and sterically allowed conformations. Ramachandran diagrams Side chain conformations

More information

Physiochemical Properties of Residues

Physiochemical Properties of Residues Physiochemical Properties of Residues Various Sources C N Cα R Slide 1 Conformational Propensities Conformational Propensity is the frequency in which a residue adopts a given conformation (in a polypeptide)

More information

Numerical Methods for Inverse Kinematics

Numerical Methods for Inverse Kinematics Numerical Methods for Inverse Kinematics Niels Joubert, UC Berkeley, CS184 2008-11-25 Inverse Kinematics is used to pose models by specifying endpoints of segments rather than individual joint angles.

More information

titin, has 35,213 amino acid residues (the human version of titin is smaller, with only 34,350 residues in the full length protein).

titin, has 35,213 amino acid residues (the human version of titin is smaller, with only 34,350 residues in the full length protein). Introduction to Protein Structure Proteins are large heteropolymers usually comprised of 50 2500 monomer units, although larger proteins are observed 8. The monomer units of proteins are amino acids. Proteins

More information

Protein folding. α-helix. Lecture 21. An α-helix is a simple helix having on average 10 residues (3 turns of the helix)

Protein folding. α-helix. Lecture 21. An α-helix is a simple helix having on average 10 residues (3 turns of the helix) Computat onal Biology Lecture 21 Protein folding The goal is to determine the three-dimensional structure of a protein based on its amino acid sequence Assumption: amino acid sequence completely and uniquely

More information

Peptides And Proteins

Peptides And Proteins Kevin Burgess, May 3, 2017 1 Peptides And Proteins from chapter(s) in the recommended text A. Introduction B. omenclature And Conventions by amide bonds. on the left, right. 2 -terminal C-terminal triglycine

More information

Dana Alsulaibi. Jaleel G.Sweis. Mamoon Ahram

Dana Alsulaibi. Jaleel G.Sweis. Mamoon Ahram 15 Dana Alsulaibi Jaleel G.Sweis Mamoon Ahram Revision of last lectures: Proteins have four levels of structures. Primary,secondary, tertiary and quaternary. Primary structure is the order of amino acids

More information

Examples of Protein Modeling. Protein Modeling. Primary Structure. Protein Structure Description. Protein Sequence Sources. Importing Sequences to MOE

Examples of Protein Modeling. Protein Modeling. Primary Structure. Protein Structure Description. Protein Sequence Sources. Importing Sequences to MOE Examples of Protein Modeling Protein Modeling Visualization Examination of an experimental structure to gain insight about a research question Dynamics To examine the dynamics of protein structures To

More information

Announcements. Primary (1 ) Structure. Lecture 7 & 8: PROTEIN ARCHITECTURE IV: Tertiary and Quaternary Structure

Announcements. Primary (1 ) Structure. Lecture 7 & 8: PROTEIN ARCHITECTURE IV: Tertiary and Quaternary Structure Announcements TA Office Hours: Brian Eckenroth Monday 3-4 pm Thursday 11 am-12 pm Lecture 7 & 8: PROTEIN ARCHITECTURE IV: Tertiary and Quaternary Structure Margaret Daugherty Fall 2003 Homework II posted

More information

Robotics & Automation. Lecture 06. Serial Kinematic Chain, Forward Kinematics. John T. Wen. September 11, 2008

Robotics & Automation. Lecture 06. Serial Kinematic Chain, Forward Kinematics. John T. Wen. September 11, 2008 Robotics & Automation Lecture 06 Serial Kinematic Chain, Forward Kinematics John T. Wen September 11, 2008 So Far... We have covered rigid body rotational kinematics: representations of SO(3), change of

More information

STRUCTURAL BIOINFORMATICS. Barry Grant University of Michigan

STRUCTURAL BIOINFORMATICS. Barry Grant University of Michigan STRUCTURAL BIOINFORMATICS Barry Grant University of Michigan www.thegrantlab.org bjgrant@umich.edu Bergen, Norway 28-Sep-2015 Objective: Provide an introduction to the practice of structural bioinformatics,

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

1. Amino Acids and Peptides Structures and Properties

1. Amino Acids and Peptides Structures and Properties 1. Amino Acids and Peptides Structures and Properties Chemical nature of amino acids The!-amino acids in peptides and proteins (excluding proline) consist of a carboxylic acid ( COOH) and an amino ( NH

More information

THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION

THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION THE TANGO ALGORITHM: SECONDARY STRUCTURE PROPENSITIES, STATISTICAL MECHANICS APPROXIMATION AND CALIBRATION Calculation of turn and beta intrinsic propensities. A statistical analysis of a protein structure

More information

Secondary and sidechain structures

Secondary and sidechain structures Lecture 2 Secondary and sidechain structures James Chou BCMP201 Spring 2008 Images from Petsko & Ringe, Protein Structure and Function. Branden & Tooze, Introduction to Protein Structure. Richardson, J.

More information

Bio nformatics. Lecture 23. Saad Mneimneh

Bio nformatics. Lecture 23. Saad Mneimneh Bio nformatics Lecture 23 Protein folding The goal is to determine the three-dimensional structure of a protein based on its amino acid sequence Assumption: amino acid sequence completely and uniquely

More information

Bulk behaviour. Alanine. FIG. 1. Chemical structure of the RKLPDA peptide. Numbers on the left mark alpha carbons.

Bulk behaviour. Alanine. FIG. 1. Chemical structure of the RKLPDA peptide. Numbers on the left mark alpha carbons. Bulk behaviour To characterise the conformational behaviour of the peptide, first we looked at the statistics of alpha carbons and the torsion angles. Then they were correlated with positions of positively

More information

Molecular Modeling lecture 2

Molecular Modeling lecture 2 Molecular Modeling 2018 -- lecture 2 Topics 1. Secondary structure 3. Sequence similarity and homology 2. Secondary structure prediction 4. Where do protein structures come from? X-ray crystallography

More information

Computational Biology: Basics & Interesting Problems

Computational Biology: Basics & Interesting Problems Computational Biology: Basics & Interesting Problems Summary Sources of information Biological concepts: structure & terminology Sequencing Gene finding Protein structure prediction Sources of information

More information

Kinematic representation! Iterative methods! Optimization methods

Kinematic representation! Iterative methods! Optimization methods Human Kinematics Kinematic representation! Iterative methods! Optimization methods Kinematics Forward kinematics! given a joint configuration, what is the position of an end point on the structure?! Inverse

More information

Basics of protein structure

Basics of protein structure Today: 1. Projects a. Requirements: i. Critical review of one paper ii. At least one computational result b. Noon, Dec. 3 rd written report and oral presentation are due; submit via email to bphys101@fas.harvard.edu

More information

Packing of Secondary Structures

Packing of Secondary Structures 7.88 Lecture Notes - 4 7.24/7.88J/5.48J The Protein Folding and Human Disease Professor Gossard Retrieving, Viewing Protein Structures from the Protein Data Base Helix helix packing Packing of Secondary

More information

Motif Prediction in Amino Acid Interaction Networks

Motif Prediction in Amino Acid Interaction Networks Motif Prediction in Amino Acid Interaction Networks Omar GACI and Stefan BALEV Abstract In this paper we represent a protein as a graph where the vertices are amino acids and the edges are interactions

More information

MEAM 520. More Velocity Kinematics

MEAM 520. More Velocity Kinematics MEAM 520 More Velocity Kinematics Katherine J. Kuchenbecker, Ph.D. General Robotics, Automation, Sensing, and Perception Lab (GRASP) MEAM Department, SEAS, University of Pennsylvania Lecture 12: October

More information

CS 273 Prof. Serafim Batzoglou Prof. Jean-Claude Latombe Spring Lecture 12 : Energy maintenance (1) Lecturer: Prof. J.C.

CS 273 Prof. Serafim Batzoglou Prof. Jean-Claude Latombe Spring Lecture 12 : Energy maintenance (1) Lecturer: Prof. J.C. CS 273 Prof. Serafim Batzoglou Prof. Jean-Claude Latombe Spring 2006 Lecture 12 : Energy maintenance (1) Lecturer: Prof. J.C. Latombe Scribe: Neda Nategh How do you update the energy function during the

More information

Objective: Students will be able identify peptide bonds in proteins and describe the overall reaction between amino acids that create peptide bonds.

Objective: Students will be able identify peptide bonds in proteins and describe the overall reaction between amino acids that create peptide bonds. Scott Seiple AP Biology Lesson Plan Lesson: Primary and Secondary Structure of Proteins Purpose:. To understand how amino acids can react to form peptides through peptide bonds.. Students will be able

More information

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems

Molecular Mechanics. I. Quantum mechanical treatment of molecular systems Molecular Mechanics I. Quantum mechanical treatment of molecular systems The first principle approach for describing the properties of molecules, including proteins, involves quantum mechanics. For example,

More information

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure

Secondary Structure. Bioch/BIMS 503 Lecture 2. Structure and Function of Proteins. Further Reading. Φ, Ψ angles alone determine protein structure Bioch/BIMS 503 Lecture 2 Structure and Function of Proteins August 28, 2008 Robert Nakamoto rkn3c@virginia.edu 2-0279 Secondary Structure Φ Ψ angles determine protein structure Φ Ψ angles are restricted

More information

HOMOLOGY MODELING. The sequence alignment and template structure are then used to produce a structural model of the target.

HOMOLOGY MODELING. The sequence alignment and template structure are then used to produce a structural model of the target. HOMOLOGY MODELING Homology modeling, also known as comparative modeling of protein refers to constructing an atomic-resolution model of the "target" protein from its amino acid sequence and an experimental

More information

Design of a Novel Globular Protein Fold with Atomic-Level Accuracy

Design of a Novel Globular Protein Fold with Atomic-Level Accuracy Design of a Novel Globular Protein Fold with Atomic-Level Accuracy Brian Kuhlman, Gautam Dantas, Gregory C. Ireton, Gabriele Varani, Barry L. Stoddard, David Baker Presented by Kate Stafford 4 May 05 Protein

More information

THE UNIVERSITY OF MANITOBA. PAPER NO: 409 LOCATION: Fr. Kennedy Gold Gym PAGE NO: 1 of 6 DEPARTMENT & COURSE NO: CHEM 4630 TIME: 3 HOURS

THE UNIVERSITY OF MANITOBA. PAPER NO: 409 LOCATION: Fr. Kennedy Gold Gym PAGE NO: 1 of 6 DEPARTMENT & COURSE NO: CHEM 4630 TIME: 3 HOURS PAPER NO: 409 LOCATION: Fr. Kennedy Gold Gym PAGE NO: 1 of 6 DEPARTMENT & COURSE NO: CHEM 4630 TIME: 3 HOURS EXAMINATION: Biochemistry of Proteins EXAMINER: J. O'Neil Section 1: You must answer all of

More information

CHEM 4170 Problem Set #1

CHEM 4170 Problem Set #1 CHEM 4170 Problem Set #1 0. Work problems 1-7 at the end of Chapter ne and problems 1, 3, 4, 5, 8, 10, 12, 17, 18, 19, 22, 24, and 25 at the end of Chapter Two and problem 1 at the end of Chapter Three

More information

Timescales of Protein Dynamics

Timescales of Protein Dynamics Timescales of Protein Dynamics From Henzler-Wildman and Kern, Nature 2007 Summary of 1D Experiment time domain data Fourier Transform (FT) frequency domain data or Transverse Relaxation Ensemble of Nuclear

More information

Useful background reading

Useful background reading Overview of lecture * General comment on peptide bond * Discussion of backbone dihedral angles * Discussion of Ramachandran plots * Description of helix types. * Description of structures * NMR patterns

More information

Protein structure prediction. CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror

Protein structure prediction. CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror Protein structure prediction CS/CME/BioE/Biophys/BMI 279 Oct. 10 and 12, 2017 Ron Dror 1 Outline Why predict protein structure? Can we use (pure) physics-based methods? Knowledge-based methods Two major

More information

(W: 12:05-1:50, 50-N202)

(W: 12:05-1:50, 50-N202) 2016 School of Information Technology and Electrical Engineering at the University of Queensland Schedule of Events Week Date Lecture (W: 12:05-1:50, 50-N202) 1 27-Jul Introduction 2 Representing Position

More information

Alpha-helical Topology and Tertiary Structure Prediction of Globular Proteins Scott R. McAllister Christodoulos A. Floudas Princeton University

Alpha-helical Topology and Tertiary Structure Prediction of Globular Proteins Scott R. McAllister Christodoulos A. Floudas Princeton University Alpha-helical Topology and Tertiary Structure Prediction of Globular Proteins Scott R. McAllister Christodoulos A. Floudas Princeton University Department of Chemical Engineering Program of Applied and

More information

Protein Dynamics. The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron.

Protein Dynamics. The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron. Protein Dynamics The space-filling structures of myoglobin and hemoglobin show that there are no pathways for O 2 to reach the heme iron. Below is myoglobin hydrated with 350 water molecules. Only a small

More information

Introduction to" Protein Structure

Introduction to Protein Structure Introduction to" Protein Structure Function, evolution & experimental methods Thomas Blicher, Center for Biological Sequence Analysis Learning Objectives Outline the basic levels of protein structure.

More information

StructuralBiology. October 18, 2018

StructuralBiology. October 18, 2018 StructuralBiology October 18, 2018 1 Lecture 18: Computational Structural Biology CBIO (CSCI) 4835/6835: Introduction to Computational Biology 1.1 Overview and Objectives Even though we re officially moving

More information

Presenter: She Zhang

Presenter: She Zhang Presenter: She Zhang Introduction Dr. David Baker Introduction Why design proteins de novo? It is not clear how non-covalent interactions favor one specific native structure over many other non-native

More information

Protein Structure. Hierarchy of Protein Structure. Tertiary structure. independently stable structural unit. includes disulfide bonds

Protein Structure. Hierarchy of Protein Structure. Tertiary structure. independently stable structural unit. includes disulfide bonds Protein Structure Hierarchy of Protein Structure 2 3 Structural element Primary structure Secondary structure Super-secondary structure Domain Tertiary structure Quaternary structure Description amino

More information

Outline. Levels of Protein Structure. Primary (1 ) Structure. Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins

Outline. Levels of Protein Structure. Primary (1 ) Structure. Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins Margaret Daugherty Fall 2004 Outline Four levels of structure are used to describe proteins; Alpha helices and beta sheets

More information

Protein Structure Prediction II Lecturer: Serafim Batzoglou Scribe: Samy Hamdouche

Protein Structure Prediction II Lecturer: Serafim Batzoglou Scribe: Samy Hamdouche Protein Structure Prediction II Lecturer: Serafim Batzoglou Scribe: Samy Hamdouche The molecular structure of a protein can be broken down hierarchically. The primary structure of a protein is simply its

More information

Presentation Outline. Prediction of Protein Secondary Structure using Neural Networks at Better than 70% Accuracy

Presentation Outline. Prediction of Protein Secondary Structure using Neural Networks at Better than 70% Accuracy Prediction of Protein Secondary Structure using Neural Networks at Better than 70% Accuracy Burkhard Rost and Chris Sander By Kalyan C. Gopavarapu 1 Presentation Outline Major Terminology Problem Method

More information

Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror

Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror Protein structure (and biomolecular structure more generally) CS/CME/BioE/Biophys/BMI 279 Sept. 28 and Oct. 3, 2017 Ron Dror Please interrupt if you have questions, and especially if you re confused! Assignment

More information

Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability

Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Lecture 2-3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Part I. Review of forces Covalent bonds Non-covalent Interactions Van der Waals Interactions

More information

Inverse differential kinematics Statics and force transformations

Inverse differential kinematics Statics and force transformations Robotics 1 Inverse differential kinematics Statics and force transformations Prof Alessandro De Luca Robotics 1 1 Inversion of differential kinematics! find the joint velocity vector that realizes a desired

More information

Section Week 3. Junaid Malek, M.D.

Section Week 3. Junaid Malek, M.D. Section Week 3 Junaid Malek, M.D. Biological Polymers DA 4 monomers (building blocks), limited structure (double-helix) RA 4 monomers, greater flexibility, multiple structures Proteins 20 Amino Acids,

More information

Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202)

Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202) J = x θ τ = J T F 2018 School of Information Technology and Electrical Engineering at the University of Queensland Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202) 1 23-Jul Introduction + Representing

More information

ROBOTICS 01PEEQW. Basilio Bona DAUIN Politecnico di Torino

ROBOTICS 01PEEQW. Basilio Bona DAUIN Politecnico di Torino ROBOTICS 01PEEQW Basilio Bona DAUIN Politecnico di Torino Kinematic Functions Kinematic functions Kinematics deals with the study of four functions(called kinematic functions or KFs) that mathematically

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

RNA and Protein Structure Prediction

RNA and Protein Structure Prediction RNA and Protein Structure Prediction Bioinformatics: Issues and Algorithms CSE 308-408 Spring 2007 Lecture 18-1- Outline Multi-Dimensional Nature of Life RNA Secondary Structure Prediction Protein Structure

More information

Timescales of Protein Dynamics

Timescales of Protein Dynamics Timescales of Protein Dynamics From Henzler-Wildman and Kern, Nature 2007 Dynamics from NMR Show spies Amide Nitrogen Spies Report On Conformational Dynamics Amide Hydrogen Transverse Relaxation Ensemble

More information

ALL LECTURES IN SB Introduction

ALL LECTURES IN SB Introduction 1. Introduction 2. Molecular Architecture I 3. Molecular Architecture II 4. Molecular Simulation I 5. Molecular Simulation II 6. Bioinformatics I 7. Bioinformatics II 8. Prediction I 9. Prediction II ALL

More information

Matrices and Vectors. Definition of Matrix. An MxN matrix A is a two-dimensional array of numbers A =

Matrices and Vectors. Definition of Matrix. An MxN matrix A is a two-dimensional array of numbers A = 30 MATHEMATICS REVIEW G A.1.1 Matrices and Vectors Definition of Matrix. An MxN matrix A is a two-dimensional array of numbers A = a 11 a 12... a 1N a 21 a 22... a 2N...... a M1 a M2... a MN A matrix can

More information

2: CHEMICAL COMPOSITION OF THE BODY

2: CHEMICAL COMPOSITION OF THE BODY 1 2: CHEMICAL COMPOSITION OF THE BODY Although most students of human physiology have had at least some chemistry, this chapter serves very well as a review and as a glossary of chemical terms. In particular,

More information

Protein Structures. Sequences of amino acid residues 20 different amino acids. Quaternary. Primary. Tertiary. Secondary. 10/8/2002 Lecture 12 1

Protein Structures. Sequences of amino acid residues 20 different amino acids. Quaternary. Primary. Tertiary. Secondary. 10/8/2002 Lecture 12 1 Protein Structures Sequences of amino acid residues 20 different amino acids Primary Secondary Tertiary Quaternary 10/8/2002 Lecture 12 1 Angles φ and ψ in the polypeptide chain 10/8/2002 Lecture 12 2

More information

Giri Narasimhan. CAP 5510: Introduction to Bioinformatics. ECS 254; Phone: x3748

Giri Narasimhan. CAP 5510: Introduction to Bioinformatics. ECS 254; Phone: x3748 CAP 5510: Introduction to Bioinformatics Giri Narasimhan ECS 254; Phone: x3748 giri@cis.fiu.edu www.cis.fiu.edu/~giri/teach/bioinfs07.html 2/15/07 CAP5510 1 EM Algorithm Goal: Find θ, Z that maximize Pr

More information

COMP 598 Advanced Computational Biology Methods & Research. Introduction. Jérôme Waldispühl School of Computer Science McGill University

COMP 598 Advanced Computational Biology Methods & Research. Introduction. Jérôme Waldispühl School of Computer Science McGill University COMP 598 Advanced Computational Biology Methods & Research Introduction Jérôme Waldispühl School of Computer Science McGill University General informations (1) Office hours: by appointment Office: TR3018

More information

Molecular dynamics simulations of anti-aggregation effect of ibuprofen. Wenling E. Chang, Takako Takeda, E. Prabhu Raman, and Dmitri Klimov

Molecular dynamics simulations of anti-aggregation effect of ibuprofen. Wenling E. Chang, Takako Takeda, E. Prabhu Raman, and Dmitri Klimov Biophysical Journal, Volume 98 Supporting Material Molecular dynamics simulations of anti-aggregation effect of ibuprofen Wenling E. Chang, Takako Takeda, E. Prabhu Raman, and Dmitri Klimov Supplemental

More information

Advanced Certificate in Principles in Protein Structure. You will be given a start time with your exam instructions

Advanced Certificate in Principles in Protein Structure. You will be given a start time with your exam instructions BIRKBECK COLLEGE (University of London) Advanced Certificate in Principles in Protein Structure MSc Structural Molecular Biology Date: Thursday, 1st September 2011 Time: 3 hours You will be given a start

More information

Trajectory-tracking control of a planar 3-RRR parallel manipulator

Trajectory-tracking control of a planar 3-RRR parallel manipulator Trajectory-tracking control of a planar 3-RRR parallel manipulator Chaman Nasa and Sandipan Bandyopadhyay Department of Engineering Design Indian Institute of Technology Madras Chennai, India Abstract

More information

Bi 8 Midterm Review. TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen

Bi 8 Midterm Review. TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen Bi 8 Midterm Review TAs: Sarah Cohen, Doo Young Lee, Erin Isaza, and Courtney Chen The Central Dogma Biology Fundamental! Prokaryotes and Eukaryotes Nucleic Acid Components Nucleic Acid Structure DNA Base

More information

F. Piazza Center for Molecular Biophysics and University of Orléans, France. Selected topic in Physical Biology. Lecture 1

F. Piazza Center for Molecular Biophysics and University of Orléans, France. Selected topic in Physical Biology. Lecture 1 Zhou Pei-Yuan Centre for Applied Mathematics, Tsinghua University November 2013 F. Piazza Center for Molecular Biophysics and University of Orléans, France Selected topic in Physical Biology Lecture 1

More information

Robotics & Automation. Lecture 17. Manipulability Ellipsoid, Singularities of Serial Arm. John T. Wen. October 14, 2008

Robotics & Automation. Lecture 17. Manipulability Ellipsoid, Singularities of Serial Arm. John T. Wen. October 14, 2008 Robotics & Automation Lecture 17 Manipulability Ellipsoid, Singularities of Serial Arm John T. Wen October 14, 2008 Jacobian Singularity rank(j) = dimension of manipulability ellipsoid = # of independent

More information

AMINO ACIDS ARE JOINED TOGETHER BY BONDS. FILE

AMINO ACIDS ARE JOINED TOGETHER BY BONDS. FILE 04 February, 2018 AMINO ACIDS ARE JOINED TOGETHER BY BONDS. FILE Document Filetype: PDF 401.79 KB 0 AMINO ACIDS ARE JOINED TOGETHER BY BONDS. FILE Understanding the chemistry and properties of the peptide

More information

BCH 4053 Spring 2003 Chapter 6 Lecture Notes

BCH 4053 Spring 2003 Chapter 6 Lecture Notes BCH 4053 Spring 2003 Chapter 6 Lecture Notes 1 CHAPTER 6 Proteins: Secondary, Tertiary, and Quaternary Structure 2 Levels of Protein Structure Primary (sequence) Secondary (ordered structure along peptide

More information

1) NMR is a method of chemical analysis. (Who uses NMR in this way?) 2) NMR is used as a method for medical imaging. (called MRI )

1) NMR is a method of chemical analysis. (Who uses NMR in this way?) 2) NMR is used as a method for medical imaging. (called MRI ) Uses of NMR: 1) NMR is a method of chemical analysis. (Who uses NMR in this way?) 2) NMR is used as a method for medical imaging. (called MRI ) 3) NMR is used as a method for determining of protein, DNA,

More information

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation ECE5463: Introduction to Robotics Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation Prof. Wei Zhang Department of Electrical and Computer Engineering Ohio State University Columbus, Ohio,

More information

Outline. Levels of Protein Structure. Primary (1 ) Structure. Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins

Outline. Levels of Protein Structure. Primary (1 ) Structure. Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins Lecture 6:Protein Architecture II: Secondary Structure or From peptides to proteins Margaret Daugherty Fall 2003 Outline Four levels of structure are used to describe proteins; Alpha helices and beta sheets

More information

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Tertiary Structure Prediction

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Tertiary Structure Prediction CMPS 6630: Introduction to Computational Biology and Bioinformatics Tertiary Structure Prediction Tertiary Structure Prediction Why Should Tertiary Structure Prediction Be Possible? Molecules obey the

More information

Unit 1: Chemistry - Guided Notes

Unit 1: Chemistry - Guided Notes Scientific Method Notes: Unit 1: Chemistry - Guided Notes 1 Common Elements in Biology: Atoms are made up of: 1. 2. 3. In order to be stable, an atom of an element needs a full valence shell of electrons.

More information

Determining Flexibility of Molecules Using Resultants of Polynomial Systems

Determining Flexibility of Molecules Using Resultants of Polynomial Systems Determining Flexibility of Molecules Using Resultants of Polynomial Systems Robert H. Lewis 1 and Evangelos A. Coutsias 2 1 Fordham University, New York, NY 10458, USA 2 University of New Mexico, Albuquerque,

More information

Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability

Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Lecture 2 and 3: Review of forces (ctd.) and elementary statistical mechanics. Contributions to protein stability Part I. Review of forces Covalent bonds Non-covalent Interactions: Van der Waals Interactions

More information

Robot Dynamics II: Trajectories & Motion

Robot Dynamics II: Trajectories & Motion Robot Dynamics II: Trajectories & Motion Are We There Yet? METR 4202: Advanced Control & Robotics Dr Surya Singh Lecture # 5 August 23, 2013 metr4202@itee.uq.edu.au http://itee.uq.edu.au/~metr4202/ 2013

More information

1. What is an ångstrom unit, and why is it used to describe molecular structures?

1. What is an ångstrom unit, and why is it used to describe molecular structures? 1. What is an ångstrom unit, and why is it used to describe molecular structures? The ångstrom unit is a unit of distance suitable for measuring atomic scale objects. 1 ångstrom (Å) = 1 10-10 m. The diameter

More information

Protein dynamics. Folding/unfolding dynamics. Fluctuations near the folded state

Protein dynamics. Folding/unfolding dynamics. Fluctuations near the folded state Protein dynamics Folding/unfolding dynamics Passage over one or more energy barriers Transitions between infinitely many conformations B. Ozkan, K.A. Dill & I. Bahar, Protein Sci. 11, 1958-1970, 2002 Fluctuations

More information