Molecular Modeling lecture 17, Tue, Mar. 19. Rotation Least-squares Superposition Structure-based alignment algorithms

Size: px
Start display at page:

Download "Molecular Modeling lecture 17, Tue, Mar. 19. Rotation Least-squares Superposition Structure-based alignment algorithms"

Transcription

1 Molecular Modeling lecture 17, Tue, Mar. 19 Rotation Least-squares Superposition Structure-based alignment algorithms

2 Matrices and vectors Matrix algebra allows you to express multiple equations as one expression [ ] a b = c d means, 1a + 2b = c 3a + 4b = d The equations share the variables a, b.!2

3 Matrices and vectors Rows are multiplied by columns [ ] a b = c d 1a + 2b = c 3a + 4b = d!3

4 Matrices and vectors Identity matrix [ ] a b = a b!4

5 Matrices and vectors Inverse matrix If [ ][ ] = a c b d f h g j [ ] then, [ ] -1 [ ] f g = a c b d h j!5

6 Matrices and vectors Matrix and vector variables R contains 4 variables. R = [ ] a c b d v contains 2 variables. v = f g

7 Matrices and vectors Rv = u what is u? u = a f + b g c f + d g

8 In polar coordinates, Rotation is addition!8

9 Rotation is angular addition y atom starts at v=(x= rcosα, y= rsinα) axis of rotation = Cartesian origin r β (x,y ) α (x,y) x rotates around origin to v =(x =rcos(α+β), y'=rsin(α+β)) Rotations are always counter-clockwise (right-handed).

10 Sum of angles formuli cos (α+β) = cos α cos β sin α sin β sin (α+β) = sin α cos β + sin β cos α

11 A rotation matrix x = rcos α y (x,y ) y = rsin α β (x,y) r α x x' = r cos (α+β) = r (cos α cos β sin α sin β) = (r cos α) cos β (r sin α)sin β = x cos β y sin β y' = r sin (α+β) = r (sin α cos β + sin β cos α) = (r sin α) cos β + (r cos α) sin β = y cos β + x sin β! # " x' $! & = cosβ y' # % " sinβ sin β $! & rcosα $! # & = cos β cos β %" rsinα # % " sin β sin β $! cosβ % & # x$ " y & % rotation matrix is independent of r, α.

12 rotations around principal axes The Z coordinate stays the same. X and Y change. cos β -sin β 0 Rz = The Y coordinate stays the same. X and Z change. cos γ 0 sin γ Ry = sin β cos β sin γ 0 cos γ The X coordinate stays the same. Y and Z change R x = 0 cos α -sin α 0 sin α cos α

13 A series of rotations is the product of rotation matrices. cos β -sin β 0 cos γ 0 sin γ cos β cos γ -sin β cos β sin β cos β = sin β cos γ cos β -sin β sin γ sin γ 0 cos γ sin γ 0 cos γ Rotation around z Rotation around y 3D rotation This is a Y rotation followed by a Z rotation

14 multiplication order is right to left. X-rotation α degrees, followed by Y-rotation γ degrees cos γ 0 sin γ sin γ 0 cos γ cos α -sin α 0 sin α cos α R y R x = = cos γ sin α sin γ cos α sin γ 0 cos α -sin α -sin γ sin α cos γ cos α cos γ Y-rotation γ degrees, followed by X-rotation α degrees cos α -sin α 0 sin α cos α cos γ 0 sin γ sin γ 0 cos γ xr y = = cos γ 0 sin γ sin α sin γ cos α -cos γ sin α -cos α sin γ sin α cos α cos γ opposite order gives a different result.

15 Transposing the matrix reverses the rotation For the opposite rotation, flip the matrix. This is the transpose x y = A C B D cos β sin β -sin β cos β The inverse matrix = The transposed matrix, because = A B C D T x y cos β sin β -sin β cos β cos β -sin β sin β cos β =

16 Right-handed 90 principle axis rotations: 90 rotation around X 90 rotation around Y 90 rotation around Z Helpful hint: For a R-handed rotation, the -sine is up and to the right of the +sine. z y x y x z z x y

17 on paper...exercise 17.1: rotate a point v = (1., 4., 7.) 1. Write the matrix that rotates 90 around z 2. Rotate v -> v' 3. Write the matrix that rotates 90 around y 4. Rotate v' -> v'' What is v''? Show me your answer.

18 Least Squares Superposition minimizes the root mean squared deviation in aligned atoms!18

19 RMSD Root Mean Square Deviation in superimposed coordinates is the standard measure of structural difference. Σ(v 1 i - v 2 i) 2 i=1,n N Where v 1 i and v 2 i are the equivalent* coordinates from molecules 1 and 2, respectively. *Equivalent as defined by an alignment.

20 Least squares superposition Problem: find the rotation matrix, M, and vector, v, that minimize the following quantity: Σ(Ma i + v - b i ) 2 Where a i and b i are the equivalent coordinates from molecules a and b, respectively.

21 Alignment defines structurally equivalent positions. Only aligned positions are included in the RMSD calculation. 4DFR:A ISLIAALAVDRVIGMENAMPWNLPADLAWFKRNTLDKPVIMGRHTWESIG-RPLPGRKNI 1DFR:_ TAFLWAQNRNGLIGKDGHLPWHLPDDLHYFRAQTVGKIMVVGRRTYESFPKRPLPERTNV 4DFR:A ILSSQ-PGTDDRVTWVKSVDEAIAAC--GDVPEIMVIGGGRVYEQFLPKAQKLYLTHIDA 1DFR:_ VLTHQEDYQAQGAVVVHDVAAVFAYAKQHLDQELVIAGGAQIFTAFKDDVDTLLVTRLAG 4DFR:A EVEGDTHFPDYEPDDWESVFSEFHDADAQNS--HSYCFKILERR 1DFR:_ SFEGDTKMIPLNWDDFTKVSSRTVEDT---NPALTHTYEVWQKK Unaligned positions are not.

22 Finding structural equivalences by linear Least squares (1) At the position of best superposition, we have an approximate equality: (2) We can eliminate v by superposing the center of mass of both molecules. Simplifies to: Ma i + v = b i Ma' i = b i

23 Least squares superposition Set of a 3N linear equations, 3 equations for each atom : M 11 a(i) x +M 12 a(i) y + M 13 a(i) z = b(i) x M 21 a(i) 1 +M 22 a(i) 2 + M 23 a(i) z = b(i) y M 31 a(i) 1 +M 32 a(i) 2 + M 33 a(i) z = b(i) z for all i=1,n known unknown When we set these equations to be equal although they are not, the solution is a minimum of the squared differences or least-squares. known Shorthand: M a = b For the mathematically inclined, here's the real algorithm:

24 a Least squares (shorthand) M = b Green are known. Orange are unknown. a T M= a a T b Square of a is a T a a T a M = a T b Invert squared matrix. (Cholesky decomposition) (a T a) -1 a T a M = (at a) -1 a T b Multiplying both sides by the inverse of squared matrix solves for the rotation matrix M. M = (a T a) -1 a T b Summary: M = (a T a) -1 a T b

25 Square, 2x2 or 3x3 (2D or 3D) Determinant = 1 Non-scaling. x = Rx. Orthogonal Special properties of rotation matrices The inverse equals the transpose, R -1 = R T Every row/column is a unit vector ( x =1) Any two rows/columns are orthogonal (dot product = 0). The cross-product of any two rows equals the remaining row. The product of any two rotation matrices is a rotation matrix. Read more about rotation matrices at: mathworld.wolfram.com/rotationmatrix.html

26 least-squares superimposed molecules

27 Structure-based alignment algorithms use structure to define the sequence alignment!27

28 Chicken/Egg problem Least squares superposition defines the alignment. The alignment defines the least squares superposition.!28

29 Structural alignment algorithm types Geometric--intermolecular Algorithms may be do this by minimizing the intermolecular distances or rootmean-square deviation (rmsd) of superimposed alpha-carbon positions. Geometric--intramolecular Algorithms minimize the difference between aligned distance matrices. DALI. Non-Geometric Algorithms align structural properties, such as %buried, secondary structure type, or structural environment usually by dynamic programming. SSAP.

30 Structure-based alignment tools DALI Programs VAST CE FATCAT MAMMOTH PRiSM *SCALI *SARF *FlexSNAP Databases FSSP HOMSTRAD COMPASS PALI SSAP SuperPose *these also do non-sequential alignment.

31 Meaningful structural alignment Aligned residues have same secondary (local) structure. Aligned residues have the same local contacts Erroneous structural alignment Alpha helix aligned to beta strand. Paired beta aligned to un-paired beta.

32 What we are saying when we assert that two positions align. 1. The two positions have a common ancestor position. 2.The two positions have the same environment, perhaps function.!32

33 Twilight-zone homologs far exceed close homologs database frequency of true structural homologs "twilight zone" % identity Q: Why are there more distant homologs than close homologs?

34 Example of structural homologs (sometimes called analogs) 4DFR: Dihydrofolate reductase 1YAC: Octameric Hydrolase Of Unknown Specificity 5.9% sequence identity (best alignment!) 1YAC structure was solved without knowing its function. Alignment to 4DFR and others implies it is a hydrolase of some sort, probably uses NAD cofactors.

35 Viewing structural homologs by viewing the secondary structure Sometimes you can see the structural similarity better in structural layers. DHFR in yellow and orange. YAC in green and purple sheets only helices only

36 Let's study an algorithm DALI: a intramolecular geometric structural alignment algorithm DALI: (Distance matrix-based ALIgnment) Liisa Holm & Chris Sander (1) Generate a distance matrix for each protein The distance matrix contains all pairwise distances.(symmetrical) j i D ij = distance between alpha carbon i and alpha carbon j Geometric--intramolecular

37 Aligning two distance matrices Cut-andpaste alignment of distance matrices Resulting sequence alignment

38 DALI algorithm S = L i =1 L j =1 DALI maximizes S. φ R ( i, j) where, φ R ( i, j) = θ R d A dij A - d B kl ij θ R is just a constant. dij A is the distance from residue i to residue j, and dkl B is the distance from residue k to residue l. i is aligned to k and j is aligned to l. S is maximal when d ij A = d kl B everywhere. The alignment is the independent variable, i.e. the search space.

39 DALI algorithm: Get a square from structure A Aligns structures using distance matrices. Randomly align with structure B Keep the best S scores vs send high scores to pairs list Each pair of 6x6 s corresponds to a gapped alignment

40 DALI algorithm : Aligns structures using distance matrices. (1) select a pair of segments from the pairs list 1st pair 4dfr Axes = sequence position shade=distance, shorter distances are lighter shade. 1yac

41 DALI algorithm (2) Add second pair from pairs list. Calculate S. Better: Keep. Worse: Reject. 2nd pair 1st pair 4dfr cross blocks 1yac

42 DALI alignment output

43 Uses of structural alignment in modeling A structure-based alignment is the Gold Standard for a sequence alignment. Aligned structures tell you where structurally conserved regions are, versus where insertions/deletions are allowed. Structural analogs provide a source of plausible loop structures. Multiple aligned structures show evolutionary plasticity.

44 Exercise 17.2: MOE Superpose Do these pairs: 2ptl 2gb1 3sdh 1h97 3sdh 1phn File Open: RCSB PDB: code: xxxx Delete extra copies if there are multiple chains. Hide All atoms Ribbon Style: oval, Color: terminus Select synchronize (check) Protein Superpose Check RMSD, %identity. Try again with options "gaussian distance weighting" and "accent secondary structure". Find residues that are aligned but should not be, according to the requirement for the same secondary/local structure.

45 Review How do you multiply a matrix by a vector? Rotate the vector (1,2,3) by 90 around Z. How is the Z axis related to the X and Y axes? Can I apply rotations in any order and get the same result? Write the RMSD equation. Why do we need an alignment to calculate RMSD? What value is minimized in least-squares superposition? Is least squares optimal or heuristic? What is the output of a structure-based alignment? Is structure-based alignment optimal or heuristic? What kind of structure-based alignment algorithm is DALI? What two properties should be conserved between structurally aligned positions? What are analogs? What does DALI maximize? What is the search space of DALI?!45

46 Supplementary slides!46

47 supplementary slides: Principal axes unit vectors are matrix columns. ( a b c d e f g h i )x = a d g rotated x axis = b e h rotated y axis = c f i rotated z axis You can create a rotation matrix by defining three mutually orthogonal unit vectors, then lining them up side-by-side in a 3x3 matrix.!47

48 supplementary slides: two 3D rotation conventions: Euler angles, α β γ axis of z x z rotation: # cosγ sinγ 0& # &# cosα sinα 0& % (% (% ( % sinγ cosγ 0( % 0 cos β sinβ( % sinα cosα 0( % (% (% ( Order of $ 0 0 1' $ 0 sinβ cos β ' $ 0 0 1' rotations: Each rotation is around a principle axis. z Polar angles, φψκ y z -y -z # cosφ sinφ 0& # cosϕ 0 sinϕ& # cosκ sinκ 0& # cosϕ 0 sinϕ &# cosφ sinφ 0& % (% (% (% (% ( % sinφ cosφ 0( % (% sinκ cosκ 0( % (% sinφ cosφ 0( % (% (% (% (% ( $ 0 0 1' $ sinϕ 0 cosϕ ' $ 0 0 1' $ sinϕ 0 cosϕ' $ 0 0 1' Net rotation = κ, around an axis axis defined by φ and ψ

49 supplementary slides: Polar angle convention: # cosφ sinφ 0& # cosϕ 0 sinϕ& # cosκ sinκ 0& # cosϕ 0 sinϕ &# cosφ sinφ 0& % (% (% (% (% ( % sinφ cosφ 0( % (% sinκ cosκ 0( % (% sinφ cosφ 0( % (% (% (% (% ( $ 0 0 1' $ sinϕ 0 cosϕ ' $ 0 0 1' $ sinϕ 0 cosϕ' $ 0 0 1' z = north pole ψ κ y φ x = prime equator Rotation of κ degrees around an axis axis located at φ degrees longitude and ψ degrees latitude. Rotation order is Z(-φ), Y(-ψ), Z(κ), Y(ψ), Z(φ) Notice the nested rotations.

50 SSAP alignment A View is the set of all vectors from one residue. Each residue has its own "View", which is a set of vectors to nearest neighbor residues. Algorithm type: Geometric--intramolecular

51 SSAP alignment: views i and j must have similar backbone angles, otherwise the score is zero. View for Template residue i View for Target residue j j The difference between the two views is a measure of how similar the structures are, when viewed from i and j. i residue level score matrix

52 SSAP algorithm: Double Dynamic Programming residue level scoring matrix DP1 summary matrix DP2 For each ij pair, we find the best DP alignment that includes ij. Keep the DP score at position (i,j) in teh summary matrix. The summary matrix is subjected to a second round of DP, to give the optimal alignment.

53 Alignment of15 analogs helix sheet

54 Two other servers for structurebased alignment FATCAT VAST: Algorithm type: Geometric--intermolecular

55 Non-sequential alignment! 1alk vpt 4 3 SCALI non-sequential alignment Yuan & Bystroff, 2005

56 SCALI Non-sequential structure-based alignments can be used to identify similar motifs in the packing geometry of SSEs. For example, it can find two proteins that have 2/4/2 α/β/α 3-layer sandwich architecture, regardless of how the SSEs are connected. (1) Exhaustive gapless alignments (2) FASTA-style assembly of alignment from fragment pairs. (3) Alignment score based on sequence similarity, local structure similarity and contact map similarity. Algorithm type: Geometric--intramolecular

57 Exhaustive alignment, no gaps. protein structure B Each dot represents two positions that have the same local structure. Darker means similar in sequence. The SCALI alignment is constructed from fragment pairs (diagonal rows). protein structure A

58 FASTA-style search in alignment space alignments generation... SCALI uses a near-greedy algorithm. Each candidate parent alignment generates up to 50 children alignments. Children are selected based on similarity (sequence, local structure, contacts). Selected children become parents in the next generation. The program is done when there is nothing left to align.

59 Non-sequential alignment space alignment space vs β α β β β α Expressing a non-sequential alignment like a standard sequence alignment loses information. Using an alignment matrix is better, as in this example of two different ββα units.

Molecular Modeling lecture 4. Rotation Least-squares Superposition Structure-based alignment algorithms

Molecular Modeling lecture 4. Rotation Least-squares Superposition Structure-based alignment algorithms Molecular Modeling 2018 -- lecture 4 Rotation Least-squares Superposition Structure-based alignment algorithms Rotation is addition in polar coordinates 2 What happens when you move the mouse to rotate

More information

Molecular Modeling Lecture 7. Homology modeling insertions/deletions manual realignment

Molecular Modeling Lecture 7. Homology modeling insertions/deletions manual realignment Molecular Modeling 2018-- Lecture 7 Homology modeling insertions/deletions manual realignment Homology modeling also called comparative modeling Sequences that have similar sequence have similar structure.

More information

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment

Algorithms in Bioinformatics FOUR Pairwise Sequence Alignment. Pairwise Sequence Alignment. Convention: DNA Sequences 5. Sequence Alignment Algorithms in Bioinformatics FOUR Sami Khuri Department of Computer Science San José State University Pairwise Sequence Alignment Homology Similarity Global string alignment Local string alignment Dot

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

Sequence analysis and comparison

Sequence analysis and comparison The aim with sequence identification: Sequence analysis and comparison Marjolein Thunnissen Lund September 2012 Is there any known protein sequence that is homologous to mine? Are there any other species

More information

Protein structure analysis. Risto Laakso 10th January 2005

Protein structure analysis. Risto Laakso 10th January 2005 Protein structure analysis Risto Laakso risto.laakso@hut.fi 10th January 2005 1 1 Summary Various methods of protein structure analysis were examined. Two proteins, 1HLB (Sea cucumber hemoglobin) and 1HLM

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

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Structure Comparison

CMPS 6630: Introduction to Computational Biology and Bioinformatics. Structure Comparison CMPS 6630: Introduction to Computational Biology and Bioinformatics Structure Comparison Protein Structure Comparison Motivation Understand sequence and structure variability Understand Domain architecture

More information

Structural Alignment of Proteins

Structural Alignment of Proteins Goal Align protein structures Structural Alignment of Proteins 1 2 3 4 5 6 7 8 9 10 11 12 13 14 PHE ASP ILE CYS ARG LEU PRO GLY SER ALA GLU ALA VAL CYS PHE ASN VAL CYS ARG THR PRO --- --- --- GLU ALA ILE

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

Protein Structure Overlap

Protein Structure Overlap Protein Structure Overlap Maximizing Protein Structural Alignment in 3D Space Protein Structure Overlap Motivation () As mentioned several times, we want to know more about protein function by assessing

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

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

Algorithms in Bioinformatics

Algorithms in Bioinformatics Algorithms in Bioinformatics Sami Khuri Department of omputer Science San José State University San José, alifornia, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri Pairwise Sequence Alignment Homology

More information

Pymol Practial Guide

Pymol Practial Guide Pymol Practial Guide Pymol is a powerful visualizor very convenient to work with protein molecules. Its interface may seem complex at first, but you will see that with a little practice is simple and powerful

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

Classical Mechanics. Luis Anchordoqui

Classical Mechanics. Luis Anchordoqui 1 Rigid Body Motion Inertia Tensor Rotational Kinetic Energy Principal Axes of Rotation Steiner s Theorem Euler s Equations for a Rigid Body Eulerian Angles Review of Fundamental Equations 2 Rigid body

More information

1. Protein Data Bank (PDB) 1. Protein Data Bank (PDB)

1. Protein Data Bank (PDB) 1. Protein Data Bank (PDB) Protein structure databases; visualization; and classifications 1. Introduction to Protein Data Bank (PDB) 2. Free graphic software for 3D structure visualization 3. Hierarchical classification of protein

More information

Distance Between Ellipses in 2D

Distance Between Ellipses in 2D Distance Between Ellipses in 2D David Eberly, Geometric Tools, Redmond WA 98052 https://www.geometrictools.com/ This work is licensed under the Creative Commons Attribution 4.0 International License. To

More information

Week 10: Homology Modelling (II) - HHpred

Week 10: Homology Modelling (II) - HHpred Week 10: Homology Modelling (II) - HHpred Course: Tools for Structural Biology Fabian Glaser BKU - Technion 1 2 Identify and align related structures by sequence methods is not an easy task All comparative

More information

Homologous proteins have similar structures and structural superposition means to rotate and translate the structures so that corresponding atoms are

Homologous proteins have similar structures and structural superposition means to rotate and translate the structures so that corresponding atoms are 1 Homologous proteins have similar structures and structural superposition means to rotate and translate the structures so that corresponding atoms are as close to each other as possible. Structural similarity

More information

Sequence Alignment: A General Overview. COMP Fall 2010 Luay Nakhleh, Rice University

Sequence Alignment: A General Overview. COMP Fall 2010 Luay Nakhleh, Rice University Sequence Alignment: A General Overview COMP 571 - Fall 2010 Luay Nakhleh, Rice University Life through Evolution All living organisms are related to each other through evolution This means: any pair of

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

Homology Modeling (Comparative Structure Modeling) GBCB 5874: Problem Solving in GBCB

Homology Modeling (Comparative Structure Modeling) GBCB 5874: Problem Solving in GBCB Homology Modeling (Comparative Structure Modeling) Aims of Structural Genomics High-throughput 3D structure determination and analysis To determine or predict the 3D structures of all the proteins encoded

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

Elementary maths for GMT

Elementary maths for GMT Elementary maths for GMT Linear Algebra Part 2: Matrices, Elimination and Determinant m n matrices The system of m linear equations in n variables x 1, x 2,, x n a 11 x 1 + a 12 x 2 + + a 1n x n = b 1

More information

Prediction and refinement of NMR structures from sparse experimental data

Prediction and refinement of NMR structures from sparse experimental data Prediction and refinement of NMR structures from sparse experimental data Jeff Skolnick Director Center for the Study of Systems Biology School of Biology Georgia Institute of Technology Overview of talk

More information

Linear Algebra & Geometry why is linear algebra useful in computer vision?

Linear Algebra & Geometry why is linear algebra useful in computer vision? Linear Algebra & Geometry why is linear algebra useful in computer vision? References: -Any book on linear algebra! -[HZ] chapters 2, 4 Some of the slides in this lecture are courtesy to Prof. Octavia

More information

Protein Structure Prediction, Engineering & Design CHEM 430

Protein Structure Prediction, Engineering & Design CHEM 430 Protein Structure Prediction, Engineering & Design CHEM 430 Eero Saarinen The free energy surface of a protein Protein Structure Prediction & Design Full Protein Structure from Sequence - High Alignment

More information

Hongbing Zhang October 2018

Hongbing Zhang October 2018 Exact and Intuitive Geometry Explanation: Why Does a Half-angle-rotation in Spin or Quaternion Space Correspond to the Whole-angle-rotation in Normal 3D Space? Hongbing Zhang October 2018 Abstract Why

More information

Linear Algebra & Geometry why is linear algebra useful in computer vision?

Linear Algebra & Geometry why is linear algebra useful in computer vision? Linear Algebra & Geometry why is linear algebra useful in computer vision? References: -Any book on linear algebra! -[HZ] chapters 2, 4 Some of the slides in this lecture are courtesy to Prof. Octavia

More information

Ch. 7.3, 7.4: Vectors and Complex Numbers

Ch. 7.3, 7.4: Vectors and Complex Numbers Ch. 7.3, 7.4: Vectors and Complex Numbers Johns Hopkins University Fall 2014 (Johns Hopkins University) Ch. 7.3, 7.4: Vectors and Complex Numbers Fall 2014 1 / 38 Vectors(1) Definition (Vector) A vector

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

MATH Topics in Applied Mathematics Lecture 12: Evaluation of determinants. Cross product.

MATH Topics in Applied Mathematics Lecture 12: Evaluation of determinants. Cross product. MATH 311-504 Topics in Applied Mathematics Lecture 12: Evaluation of determinants. Cross product. Determinant is a scalar assigned to each square matrix. Notation. The determinant of a matrix A = (a ij

More information

Vectors Summary. can slide along the line of action. not restricted, defined by magnitude & direction but can be anywhere.

Vectors Summary. can slide along the line of action. not restricted, defined by magnitude & direction but can be anywhere. Vectors Summary A vector includes magnitude (size) and direction. Academic Skills Advice Types of vectors: Line vector: Free vector: Position vector: Unit vector (n ): can slide along the line of action.

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

OLLSCOIL NA heireann MA NUAD THE NATIONAL UNIVERSITY OF IRELAND MAYNOOTH MATHEMATICAL PHYSICS EE112. Engineering Mathematics II

OLLSCOIL NA heireann MA NUAD THE NATIONAL UNIVERSITY OF IRELAND MAYNOOTH MATHEMATICAL PHYSICS EE112. Engineering Mathematics II OLLSCOIL N heirenn M NUD THE NTIONL UNIVERSITY OF IRELND MYNOOTH MTHEMTICL PHYSICS EE112 Engineering Mathematics II Prof. D. M. Heffernan and Mr. S. Pouryahya 1 5 Scalars and Vectors 5.1 The Scalar Quantities

More information

Getting To Know Your Protein

Getting To Know Your Protein Getting To Know Your Protein Comparative Protein Analysis: Part III. Protein Structure Prediction and Comparison Robert Latek, PhD Sr. Bioinformatics Scientist Whitehead Institute for Biomedical Research

More information

Chapter 1. Introduction to Vectors. Po-Ning Chen, Professor. Department of Electrical and Computer Engineering. National Chiao Tung University

Chapter 1. Introduction to Vectors. Po-Ning Chen, Professor. Department of Electrical and Computer Engineering. National Chiao Tung University Chapter 1 Introduction to Vectors Po-Ning Chen, Professor Department of Electrical and Computer Engineering National Chiao Tung University Hsin Chu, Taiwan 30010, R.O.C. Notes for this course 1-1 A few

More information

Can protein model accuracy be. identified? NO! CBS, BioCentrum, Morten Nielsen, DTU

Can protein model accuracy be. identified? NO! CBS, BioCentrum, Morten Nielsen, DTU Can protein model accuracy be identified? Morten Nielsen, CBS, BioCentrum, DTU NO! Identification of Protein-model accuracy Why is it important? What is accuracy RMSD, fraction correct, Protein model correctness/quality

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

Protein Structure Comparison Methods

Protein Structure Comparison Methods Protein Structure Comparison Methods D. Petrova Key Words: Protein structure comparison; models; comparison algorithms; similarity measure Abstract. Existing methods for protein structure comparison are

More information

Introduction to Bioinformatics Algorithms Homework 3 Solution

Introduction to Bioinformatics Algorithms Homework 3 Solution Introduction to Bioinformatics Algorithms Homework 3 Solution Saad Mneimneh Computer Science Hunter College of CUNY Problem 1: Concave penalty function We have seen in class the following recurrence for

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

114 Grundlagen der Bioinformatik, SS 09, D. Huson, July 6, 2009

114 Grundlagen der Bioinformatik, SS 09, D. Huson, July 6, 2009 114 Grundlagen der Bioinformatik, SS 09, D. Huson, July 6, 2009 9 Protein tertiary structure Sources for this chapter, which are all recommended reading: D.W. Mount. Bioinformatics: Sequences and Genome

More information

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

CS273: Algorithms for Structure Handout # 2 and Motion in Biology Stanford University Thursday, 1 April 2004 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

More information

MOL410/510 Problem Set 1 - Linear Algebra - Due Friday Sept. 30

MOL410/510 Problem Set 1 - Linear Algebra - Due Friday Sept. 30 MOL40/50 Problem Set - Linear Algebra - Due Friday Sept. 30 Use lab notes to help solve these problems. Problems marked MUST DO are required for full credit. For the remainder of the problems, do as many

More information

Introduction and Vectors Lecture 1

Introduction and Vectors Lecture 1 1 Introduction Introduction and Vectors Lecture 1 This is a course on classical Electromagnetism. It is the foundation for more advanced courses in modern physics. All physics of the modern era, from quantum

More information

Homology Modeling. Roberto Lins EPFL - summer semester 2005

Homology Modeling. Roberto Lins EPFL - summer semester 2005 Homology Modeling Roberto Lins EPFL - summer semester 2005 Disclaimer: course material is mainly taken from: P.E. Bourne & H Weissig, Structural Bioinformatics; C.A. Orengo, D.T. Jones & J.M. Thornton,

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

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

CMPS 3110: Bioinformatics. Tertiary Structure Prediction

CMPS 3110: Bioinformatics. Tertiary Structure Prediction CMPS 3110: Bioinformatics Tertiary Structure Prediction Tertiary Structure Prediction Why Should Tertiary Structure Prediction Be Possible? Molecules obey the laws of physics! Conformation space is finite

More information

Protein Structure: Data Bases and Classification Ingo Ruczinski

Protein Structure: Data Bases and Classification Ingo Ruczinski Protein Structure: Data Bases and Classification Ingo Ruczinski Department of Biostatistics, Johns Hopkins University Reference Bourne and Weissig Structural Bioinformatics Wiley, 2003 More References

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

proteins Refinement by shifting secondary structure elements improves sequence alignments

proteins Refinement by shifting secondary structure elements improves sequence alignments proteins STRUCTURE O FUNCTION O BIOINFORMATICS Refinement by shifting secondary structure elements improves sequence alignments Jing Tong, 1,2 Jimin Pei, 3 Zbyszek Otwinowski, 1,2 and Nick V. Grishin 1,2,3

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

NMR, X-ray Diffraction, Protein Structure, and RasMol

NMR, X-ray Diffraction, Protein Structure, and RasMol NMR, X-ray Diffraction, Protein Structure, and RasMol Introduction So far we have been mostly concerned with the proteins themselves. The techniques (NMR or X-ray diffraction) used to determine a structure

More information

Pairwise & Multiple sequence alignments

Pairwise & Multiple sequence alignments Pairwise & Multiple sequence alignments Urmila Kulkarni-Kale Bioinformatics Centre 411 007 urmila@bioinfo.ernet.in Basis for Sequence comparison Theory of evolution: gene sequences have evolved/derived

More information

Sequence Analysis '17- lecture 8. Multiple sequence alignment

Sequence Analysis '17- lecture 8. Multiple sequence alignment Sequence Analysis '17- lecture 8 Multiple sequence alignment Ex5 explanation How many random database search scores have e-values 10? (Answer: 10!) Why? e-value of x = m*p(s x), where m is the database

More information

Tensors, and differential forms - Lecture 2

Tensors, and differential forms - Lecture 2 Tensors, and differential forms - Lecture 2 1 Introduction The concept of a tensor is derived from considering the properties of a function under a transformation of the coordinate system. A description

More information

Linear Algebra Review. Fei-Fei Li

Linear Algebra Review. Fei-Fei Li Linear Algebra Review Fei-Fei Li 1 / 51 Vectors Vectors and matrices are just collections of ordered numbers that represent something: movements in space, scaling factors, pixel brightnesses, etc. A vector

More information

3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT

3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT 3. SEQUENCE ANALYSIS BIOINFORMATICS COURSE MTAT.03.239 25.09.2012 SEQUENCE ANALYSIS IS IMPORTANT FOR... Prediction of function Gene finding the process of identifying the regions of genomic DNA that encode

More information

Procheck output. Bond angles (Procheck) Structure verification and validation Bond lengths (Procheck) Introduction to Bioinformatics.

Procheck output. Bond angles (Procheck) Structure verification and validation Bond lengths (Procheck) Introduction to Bioinformatics. Structure verification and validation Bond lengths (Procheck) Introduction to Bioinformatics Iosif Vaisman Email: ivaisman@gmu.edu ----------------------------------------------------------------- Bond

More information

AM 205: lecture 8. Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition

AM 205: lecture 8. Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition AM 205: lecture 8 Last time: Cholesky factorization, QR factorization Today: how to compute the QR factorization, the Singular Value Decomposition QR Factorization A matrix A R m n, m n, can be factorized

More information

Linear Algebra March 16, 2019

Linear Algebra March 16, 2019 Linear Algebra March 16, 2019 2 Contents 0.1 Notation................................ 4 1 Systems of linear equations, and matrices 5 1.1 Systems of linear equations..................... 5 1.2 Augmented

More information

Nature Structural & Molecular Biology: doi: /nsmb Supplementary Figure 1

Nature Structural & Molecular Biology: doi: /nsmb Supplementary Figure 1 Supplementary Figure 1 Cryo-EM structure and model of the C. thermophilum 90S preribosome. a, Gold standard FSC curve showing the average resolution of the 90S preribosome masked and unmasked (left). FSC

More information

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4 Linear Algebra Section. : LU Decomposition Section. : Permutations and transposes Wednesday, February 1th Math 01 Week # 1 The LU Decomposition We learned last time that we can factor a invertible matrix

More information

Elementary Linear Algebra

Elementary Linear Algebra Matrices J MUSCAT Elementary Linear Algebra Matrices Definition Dr J Muscat 2002 A matrix is a rectangular array of numbers, arranged in rows and columns a a 2 a 3 a n a 2 a 22 a 23 a 2n A = a m a mn We

More information

Protein Structure Prediction

Protein Structure Prediction Page 1 Protein Structure Prediction Russ B. Altman BMI 214 CS 274 Protein Folding is different from structure prediction --Folding is concerned with the process of taking the 3D shape, usually based on

More information

1. Vectors and Matrices

1. Vectors and Matrices E. 8.02 Exercises. Vectors and Matrices A. Vectors Definition. A direction is just a unit vector. The direction of A is defined by dir A = A, (A 0); A it is the unit vector lying along A and pointed like

More information

Multiple structure alignment with mstali

Multiple structure alignment with mstali Multiple structure alignment with mstali Shealy and Valafar Shealy and Valafar BMC Bioinformatics 2012, 13:105 Shealy and Valafar BMC Bioinformatics 2012, 13:105 SOFTWARE Open Access Multiple structure

More information

SUPPLEMENTARY MATERIALS

SUPPLEMENTARY MATERIALS SUPPLEMENTARY MATERIALS Enhanced Recognition of Transmembrane Protein Domains with Prediction-based Structural Profiles Baoqiang Cao, Aleksey Porollo, Rafal Adamczak, Mark Jarrell and Jaroslaw Meller Contact:

More information

Rigid Geometric Transformations

Rigid Geometric Transformations Rigid Geometric Transformations Carlo Tomasi This note is a quick refresher of the geometry of rigid transformations in three-dimensional space, expressed in Cartesian coordinates. 1 Cartesian Coordinates

More information

Transformations. Lars Vidar Magnusson. August 24,

Transformations. Lars Vidar Magnusson. August 24, Transformations Lars Vidar Magnusson August 24, 2012 http://www.it.hiof.no/~larsvmag/iti43309/index.html 2D Translation To translate an object is to move it in two-dimensinal space. If we have a point

More information

Elements of Continuum Elasticity. David M. Parks Mechanics and Materials II February 25, 2004

Elements of Continuum Elasticity. David M. Parks Mechanics and Materials II February 25, 2004 Elements of Continuum Elasticity David M. Parks Mechanics and Materials II 2.002 February 25, 2004 Solid Mechanics in 3 Dimensions: stress/equilibrium, strain/displacement, and intro to linear elastic

More information

Supplementary Figure 1. Aligned sequences of yeast IDH1 (top) and IDH2 (bottom) with isocitrate

Supplementary Figure 1. Aligned sequences of yeast IDH1 (top) and IDH2 (bottom) with isocitrate SUPPLEMENTARY FIGURE LEGENDS Supplementary Figure 1. Aligned sequences of yeast IDH1 (top) and IDH2 (bottom) with isocitrate dehydrogenase from Escherichia coli [ICD, pdb 1PB1, Mesecar, A. D., and Koshland,

More information

APPLICATIONS The eigenvalues are λ = 5, 5. An orthonormal basis of eigenvectors consists of

APPLICATIONS The eigenvalues are λ = 5, 5. An orthonormal basis of eigenvectors consists of CHAPTER III APPLICATIONS The eigenvalues are λ =, An orthonormal basis of eigenvectors consists of, The eigenvalues are λ =, A basis of eigenvectors consists of, 4 which are not perpendicular However,

More information

ENGI 9420 Lecture Notes 2 - Matrix Algebra Page Matrix operations can render the solution of a linear system much more efficient.

ENGI 9420 Lecture Notes 2 - Matrix Algebra Page Matrix operations can render the solution of a linear system much more efficient. ENGI 940 Lecture Notes - Matrix Algebra Page.0. Matrix Algebra A linear system of m equations in n unknowns, a x + a x + + a x b (where the a ij and i n n a x + a x + + a x b n n a x + a x + + a x b m

More information

Multiple Mapping Method: A Novel Approach to the Sequence-to-Structure Alignment Problem in Comparative Protein Structure Modeling

Multiple Mapping Method: A Novel Approach to the Sequence-to-Structure Alignment Problem in Comparative Protein Structure Modeling 63:644 661 (2006) Multiple Mapping Method: A Novel Approach to the Sequence-to-Structure Alignment Problem in Comparative Protein Structure Modeling Brajesh K. Rai and András Fiser* Department of Biochemistry

More information

CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I)

CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I) CISC 889 Bioinformatics (Spring 2004) Sequence pairwise alignment (I) Contents Alignment algorithms Needleman-Wunsch (global alignment) Smith-Waterman (local alignment) Heuristic algorithms FASTA BLAST

More information

22A-2 SUMMER 2014 LECTURE Agenda

22A-2 SUMMER 2014 LECTURE Agenda 22A-2 SUMMER 204 LECTURE 2 NATHANIEL GALLUP The Dot Product Continued Matrices Group Work Vectors and Linear Equations Agenda 2 Dot Product Continued Angles between vectors Given two 2-dimensional vectors

More information

HMM applications. Applications of HMMs. Gene finding with HMMs. Using the gene finder

HMM applications. Applications of HMMs. Gene finding with HMMs. Using the gene finder HMM applications Applications of HMMs Gene finding Pairwise alignment (pair HMMs) Characterizing protein families (profile HMMs) Predicting membrane proteins, and membrane protein topology Gene finding

More information

Rotational motion of a rigid body spinning around a rotational axis ˆn;

Rotational motion of a rigid body spinning around a rotational axis ˆn; Physics 106a, Caltech 15 November, 2018 Lecture 14: Rotations The motion of solid bodies So far, we have been studying the motion of point particles, which are essentially just translational. Bodies with

More information

Mobile Robotics 1. A Compact Course on Linear Algebra. Giorgio Grisetti

Mobile Robotics 1. A Compact Course on Linear Algebra. Giorgio Grisetti Mobile Robotics 1 A Compact Course on Linear Algebra Giorgio Grisetti SA-1 Vectors Arrays of numbers They represent a point in a n dimensional space 2 Vectors: Scalar Product Scalar-Vector Product Changes

More information

Pairwise sequence alignment

Pairwise sequence alignment Department of Evolutionary Biology Example Alignment between very similar human alpha- and beta globins: GSAQVKGHGKKVADALTNAVAHVDDMPNALSALSDLHAHKL G+ +VK+HGKKV A+++++AH+D++ +++++LS+LH KL GNPKVKAHGKKVLGAFSDGLAHLDNLKGTFATLSELHCDKL

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

Sequence analysis and Genomics

Sequence analysis and Genomics Sequence analysis and Genomics October 12 th November 23 rd 2 PM 5 PM Prof. Peter Stadler Dr. Katja Nowick Katja: group leader TFome and Transcriptome Evolution Bioinformatics group Paul-Flechsig-Institute

More information

Analysis and Prediction of Protein Structure (I)

Analysis and Prediction of Protein Structure (I) Analysis and Prediction of Protein Structure (I) Jianlin Cheng, PhD School of Electrical Engineering and Computer Science University of Central Florida 2006 Free for academic use. Copyright @ Jianlin Cheng

More information

A matrix over a field F is a rectangular array of elements from F. The symbol

A matrix over a field F is a rectangular array of elements from F. The symbol Chapter MATRICES Matrix arithmetic A matrix over a field F is a rectangular array of elements from F The symbol M m n (F ) denotes the collection of all m n matrices over F Matrices will usually be denoted

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

Determining a Triangle

Determining a Triangle Determining a Triangle 1 Constraints What data do we need to determine a triangle? There are two basic facts that constrain the data: 1. The triangle inequality: The sum of the length of two sides is greater

More information

7.4. The Inverse of a Matrix. Introduction. Prerequisites. Learning Outcomes

7.4. The Inverse of a Matrix. Introduction. Prerequisites. Learning Outcomes The Inverse of a Matrix 7.4 Introduction In number arithmetic every number a 0has a reciprocal b written as a or such that a ba = ab =. Similarly a square matrix A may have an inverse B = A where AB =

More information

The Select Command and Boolean Operators

The Select Command and Boolean Operators The Select Command and Boolean Operators Part of the Jmol Training Guide from the MSOE Center for BioMolecular Modeling Interactive version available at http://cbm.msoe.edu/teachingresources/jmol/jmoltraining/boolean.html

More information

Sum and difference formulae for sine and cosine. Elementary Functions. Consider angles α and β with α > β. These angles identify points on the

Sum and difference formulae for sine and cosine. Elementary Functions. Consider angles α and β with α > β. These angles identify points on the Consider angles α and β with α > β. These angles identify points on the unit circle, P (cos α, sin α) and Q(cos β, sin β). Part 5, Trigonometry Lecture 5.1a, Sum and Difference Formulas Dr. Ken W. Smith

More information

11 a 12 a 13 a 21 a 22 a b 12 b 13 b 21 b 22 b b 11 a 12 + b 12 a 13 + b 13 a 21 + b 21 a 22 + b 22 a 23 + b 23

11 a 12 a 13 a 21 a 22 a b 12 b 13 b 21 b 22 b b 11 a 12 + b 12 a 13 + b 13 a 21 + b 21 a 22 + b 22 a 23 + b 23 Chapter 2 (3 3) Matrices The methods used described in the previous chapter for solving sets of linear equations are equally applicable to 3 3 matrices. The algebra becomes more drawn out for larger matrices,

More information

2 Dean C. Adams and Gavin J. P. Naylor the best three-dimensional ordination of the structure space is found through an eigen-decomposition (correspon

2 Dean C. Adams and Gavin J. P. Naylor the best three-dimensional ordination of the structure space is found through an eigen-decomposition (correspon A Comparison of Methods for Assessing the Structural Similarity of Proteins Dean C. Adams and Gavin J. P. Naylor? Dept. Zoology and Genetics, Iowa State University, Ames, IA 50011, U.S.A. 1 Introduction

More information

CHAPTER 8: Matrices and Determinants

CHAPTER 8: Matrices and Determinants (Exercises for Chapter 8: Matrices and Determinants) E.8.1 CHAPTER 8: Matrices and Determinants (A) means refer to Part A, (B) means refer to Part B, etc. Most of these exercises can be done without a

More information

Part 4 The Select Command and Boolean Operators

Part 4 The Select Command and Boolean Operators Part 4 The Select Command and Boolean Operators http://cbm.msoe.edu/newwebsite/learntomodel Introduction By default, every command you enter into the Console affects the entire molecular structure. However,

More information

18.06 Problem Set 1 Solutions Due Thursday, 11 February 2010 at 4 pm in Total: 100 points

18.06 Problem Set 1 Solutions Due Thursday, 11 February 2010 at 4 pm in Total: 100 points 18.06 Problem Set 1 Solutions Due Thursday, 11 February 2010 at 4 pm in 2-106. Total: 100 points Section 1.2. Problem 23: The figure shows that cos(α) = v 1 / v and sin(α) = v 2 / v. Similarly cos(β) is

More information

REVIEW - Vectors. Vectors. Vector Algebra. Multiplication by a scalar

REVIEW - Vectors. Vectors. Vector Algebra. Multiplication by a scalar J. Peraire Dynamics 16.07 Fall 2004 Version 1.1 REVIEW - Vectors By using vectors and defining appropriate operations between them, physical laws can often be written in a simple form. Since we will making

More information