Manual for RNA-As-Graphs Topology (RAGTOP) software suite

Size: px
Start display at page:

Download "Manual for RNA-As-Graphs Topology (RAGTOP) software suite"

Transcription

1 Manual for RNA-As-Graphs Topology (RAGTOP) software suite Schlick lab Contents 1 General Information Copyright statement Citation requirements Support Download instructions 2 3 Main features General tree graph definitions RNA 3D graph sampling with Monte Carlo F-RAG for RNA 3D structure prediction F-RAG for design of RNA-like motifs Other features Removal of pseudoknots from the 2D structure Generating loop and vertex information for RAG-3D External libraries used 12 1 General Information This is the user manual for the RNA-As-Graphs Topology (RAGTOP) software suite, developed in the lab of Prof. Tamar Schlick at New York University. The different features offered by this software include representing RNA secondary (2D) structure as three-dimensional (3D) tree graphs and sampling different graph topologies [1, 2]; fragment assembly for RNA graphs (F-RAG) to generate 3D atomic models of RNA for graphs [3], and design of sequences to fold onto RNA-like tree graph topologies [4]. 1.1 Copyright statement The RAGTOP software suite was developed in the lab of Prof. Tamar Schlick at New York University. The package is provided for use in research purposes only; for other applications please contact Prof. Tamar Schlick (schlick@nyu.edu). We require everyone who publishes or presents results from RAGTOP to please cite our program, names of individual components, and associated original publications, as below: 1

2 1.2 Citation requirements Please cite the papers below when using RAGTOP. Papers 1 and 2 are for RAGTOP s JunctionExplorer component to predict coaxial stacking and family for 3-way and 4-way junctions; papers 3 and 4 are for RAGTOP s Monte Carlo/Simulated Annealing component to sample 3D tree graph topologies; and papers 5 and 6 are for RAGTOP s F-RAG component to generate atomic models for RNA 3D structure prediction and design of RNA-like topologies. 1. C. Laing, D. Wen, J. T. L. Wang, and T. Schlick, Predicting coaxial helical stacking in RNA junctions., Nucleic Acids Res, vol. 40, no. 2, pp , C. Laing, S. Jung, N. Kim, S. Elmetwaly, M. Zahran, and T. Schlick, Predicting helical topologies in RNA junctions as tree graphs, PLoS ONE, vol. 8, no. 8, p. e71947, N. Kim, C. Laing, S. Elmetwaly, S. Jung, J. Curuksu, and T. Schlick, Graph-based sampling for approximating global helical topologies of RNA, Proc Natl Acad Sci USA, vol. 111, no. 11, pp , C. S. Bayrak, N. Kim, and T. Schlick, Using sequence signatures and kink-turn motifs in knowledgebased statistical potentials for RNA structure prediction., Nucleic Acids Res, vol. 45, no. 9, pp , S. Jain and T. Schlick, F-RAG: Generating atomic models from RNA graphs using fragment assembly, J Mol Biol, vol. 429, no. 23, pp , S. Jain, A. Laederach, S. B. Ramos, and T. Schlick, A pipeline for computational design of novel RNA-like topologies, Nucleic Acid Res, (In Revision), Support Please feel free to contact us by if you have questions. We are also planning to develop a RAGTOP webserver. The input for F-RAG requires running RAG-3D partitioning and search. Please contact us for RAG-3D scripts and database. 2 Download instructions RAGTOP executables (for Mac OS and Linux operating systems) are available to download from our website ( 1. Download the software package for your operating system and untar it: tar zxvf <package name> 2. Change directory to the package directory with the executable file: cd <package directory> The package directory contains: 1. The executable file RAGTOP 2

3 2. The parameter files for the scoring potential and alternate fragments (helices, hairpins, and internal loops for F-RAG) needed to run RAGTOP 3. Examples/ directory with sample input and output files for different features 4. Description files for external libraries used (see Section 5) Please refer to the sections below for instructions on how to run RAGTOP for different features. 3 Main features 3.1 General tree graph definitions The 2D structure of an RNA molecule can be represented in the form of an undirected tree graph G = (V, E) [5, 6]. Vertices V correspond to different loops: hairpin loops, internal loops and bulges (with at least two nucleotides in either strand), junctions, and dangling ends. A dangling end refers to exterior loop residues next to stems at the ends of the RNA sequence. Edges E correspond to helical stems, with at least two canonical base pairs (AU, GC, and GU wobble). Isolated single base pairs are ignored. We convert the 2D tree graph into a 3D tree graph with additional vertices and edges [1]. Two vertices are added to represent the 5 and 3 ends for each helix, along with vertices for internal loops and bulges that contain less than two nucleotides in either strand. The edges of the graph now connect the two vertices representing each helix, or the loop vertices to the proximal end helical vertices. The lengths of each edge are scaled by the number of residues in the corresponding helices and loops. Figure 1 shows the 2D and 3D tree graphs for a 57-residue fragment of rrna (PDB ID: 1DK1). Figure 1: 2D and 3D tree graphs for a 57-residue fragment of rrna (PDB ID: 1DK1) Our RAGTOP code takes the 2D structure as input and constructs the corresponding 3D tree graph. For the purposes of the code, the loops in the 2D structure are numbered as follows: the dangling ends are numbered first, followed by hairpins, internal loops and bulges, and then junctions. Within each loop category, the loops are numbered in the order their strands are encountered in the 5 to the 3 direction. The vertices of the 3D tree graph are numbered similarly, with the helical end vertices connected to the loop vertices being numbered along with their loop vertices (i.e., before the next loop is numbered). Figure 2 shows an example of numbering loops and vertices for a given 2D structure and the corresponding 3D tree graph. 3

4 Figure 2: Loop and vertex numbers used in the code for the 2D structure the corresponding 3D tree graph for a 57-residue fragment of rrna (PDB ID: 1DK1) 3.2 RNA 3D graph sampling with Monte Carlo This feature samples 3D tree graphs of known 2D structure and selects candidate graph topologies [1, 2] for further processing. The candidate graphs can serve as input for F-RAG (for building atomic models) for RNA 3D structure prediction (see Subsection 3.3). The input 2D structure is converted to a 3D tree graph (as described in Subsection 3.1) and the coaxial stacking and family for helical arrangements for RNA junctions are predicted using data mining tools [7, 8]. Next, Monte Carlo/Simulated Annealing (MC/SA) sampling is performed at flexible internal loop vertices of the 3D tree graph. For each move, an internal loop and one of its adjacent helices is randomly selected for rotation along a randomly selected axis (x, y, or z). For random moves (default), the range of angle is always full (i.e., 360 ). For local or restricted moves, the angle range is reduced gradually from 360 to 10. The SA protocol (default) involves cooling the system temperature by the effective term T i = c/log2(1 + i/s), where c is a constant, i is the iteration number, and s is the total number of MC moves specified a priori (50,000 steps). The junction orientation is fixed during the MC/SA simulation. All sampled graph topologies are scored by a knowledge-based scoring function derived from known RNA structures. Terms include bend and twist potentials of helices around internal loops (enhanced by identifying kink-turn sequence patterns), and radius of gyration measurements. The flags needed to run the MC/SA simulation for 3D tree graph topology sampling are: Required flags: -mcrun -file filename -inputdir path -outputdir path MC/SA run input 2D structure in bpseq format (without extension) input directory output directory 4

5 Optional flags: -mc nosa -mc restrict -ref -pdbdir path The input directory must contain: SA is not performed restricted moves are used (instead of random moves) during MC a reference structure will be read from path and the corresponding 3D tree graph will be used as the MC starting point 1. The input 2D structure (filename.bpseq) After the MC/SA run is completed, the output directory will contain: 1. The 3D tree graph constructed from the 2D structure after junction prediction and before the MC/SA sampling (filename Graph.pdb) 2. The accepted graph topologies from the MC/SA sampling (as a zipped file) along with their scores (graphs.zip and scores filename.txt) 3. Bend, twist, radius of gyration, total scores, and accept/reject decision for all 50,000 MC/SA sampling steps (bends filename.txt, twist filename.txt, radius filename.txt, scores all filename.txt, and RGsampling filename.txt) 4. Text file listing the parameters used in the MC/SA sampling (MC Params.txt) Examples/MCRun/ contains sample input and output directories for the following MC/SA run:./ragtop -mcrun -file 1DK1 -inputdir Examples/Graph/Input/ -outputdir Examples/Graph/Output/ 3.3 F-RAG for RNA 3D structure prediction Fragment-Assembly for RNA-As-Graphs (F-RAG) is used for generation of atomic models for a target RNA 2D structure and a 3D tree graph topology [3] obtained by MC/SA graph sampling (described in Subsection 3.2). This task is performed using fragment assembly, where the target graph is partitioned into subgraphs [9, 10], and the best matching atomic fragments are assembled using common graph vertices. This requires running RAG-3D search [10] to partition the target graph into subgraphs and return the best matching atomic fragments for each of those subgraphs that are then used as input for the F-RAG algorithm. All generated models are scored using the knowledge-based potential developed for 3D tree graph topology sampling [1, 2]. The flags needed to run F-RAG for generating atomic models for a 2D structure and a target 3D tree graph are: 5

6 Required flags: -atomcoords -file filename -inputdir path -outputdir path -graphname id -subgraph subfile -fragment dir path -libdir path Optional flags: run F-RAG for generating atomic models for a given 3D tree graph input filename identifier input directory output directory target 3D tree graph identifier subgraph information for target 3D tree graph fragment directory with atomic fragment files LibFiles directory (containing files used for mutating bases and alternate hairpin and internal loops) -ref -pdbdir path The input directory must contain: if specified, a reference structure will be read from the path and the corresponding 3D tree graph will be used as the target for atomic model generation 1. The input 2D structure (filename.bpseq) 2. The target 3D tree graph topology (filename idgraph.pdb) 3. The file containing the subgraph information of the target 3D tree graph (subfile) The subgraph information file should have the following format (see example subgraph file Examples/AtomCoords/Input/Subgraphs.txt for subgraph division shown in Figure 3): numsubgraphs numfragments numvertices subgraph0 subgraph1... subgraphn 1 subgraph 0 fragments subgraph 1 fragments... subgraph n-1 fragments n numfrags 0 numfrags 1... numfrags n 1 numvertices 0 numvertices 1... numvertices n 1 list of subgraph 0 vertices list of subgraph 1 vertices list of subgraph n-1 vertices (e.g., subgraph0 frag0, one fragment per line) where n is the number of subgraphs, numfrags i is the number of fragments for subgraph i, and numvertices i is the number of 3D tree graph vertices in subgraph i (not including vertices for single residue internal loops or bulges). 6

7 Figure 3: Subgraphs used in F-RAG for a 57-residue fragment of rrna (PDB ID: 1DK1). See Subsection 3.1 for how 3D tree graph vertices are numbered. The fragment directory must contain: 1. The PDB files for atomic fragments corresponding to different target subgraphs (e.g., subgraph0 frag0.pdb) 2. The 2D structure files for atomic fragments corresponding to different target subgraphs (e.g., subgraph0 frag0.bpseq) After the F-RAG run is completed, the output directory will contain: 1. The 3D tree graph constructed from the 2D structure after junction prediction (filename Graph.pdb) 2. Generated atomic models and associated 3D tree graphs (Model i.pdb and Graph i.pdb, where i is the atomic model number) 3. Text file with columns listing the atomic model number, graph RMSD of the atomic model 3D tree graph with the target 3D graph, score of the atomic model 3D tree graph, if the atomic model 3D tree graph contains a steric clash, and number of residues in the atomic model (ModelScores.txt) 4. Text file with columns listing the atomic model number and the fragments used to construct that atomic model (ModelFragments.txt) The atomic models generated by F-RAG are not optimized for energy or geometry and may contain missing residues and chain breaks. For best results, we recommend running F-RAG for multiple subgraph decompositions of the target 3D tree graph, selecting atomic models with the highest number of residues and lowest scores (lower scores are better), followed by geometry optimization and/or energy minimization before further use [3]. 7

8 Examples/AtomCoords/ contain sample input and output directories for F-RAG run for the target 2D structure and subgraph decomposition shown in Figure 3. The following command was used for the F-RAG run:./ragtop -atomcoords -file 1DK1 -graphname P2 -inputdir Examples/AtomCoords/Input/ -outputdir Examples/Graph/Output/ -subgraph Subgraphs.txt -fragment dir Examples/AtomCoords/Input/MATCHES/ -libdir LibFiles/ 3.4 F-RAG for design of RNA-like motifs This functionality is for Fragment-Assembly for RNA-As-Graphs (F-RAG) as used for designing sequences and plausible atomic models that fold onto a target RNA-like tree graph topology [4]. This task is performed using fragment assembly, where the target RNA-like topology [11] is partitioned into subgraphs, and the atomic fragments corresponding to those subgraphs are assembled using common loops and helices. F-RAG uses the atomic fragments in the RAG-3D database [10] for each of target subgraphs as input. All generated models are scored using the knowledge-based potential developed for 3D tree graph topology sampling [1, 2]. The flags needed to run F-RAG for generating atomic models to fold onto a target RNA-like topology are: Required flags: -design -file filename -inputdir path -outputdir path -subgraph subfile -fragment dir path Optional flags: run F-RAG for generating atomic models for a given RNA-like topology information for target RNA-like topology input directory output directory subgraph information for target RNA-like topology fragment directory with atomic fragment files -libdir path directory containing atomic fragments for restricted hairpins or internal loops (if restricted loops are specified in the target file) The input directory must contain: 1. The file describing the target RNA-like topology (filename) 2. The file containing the subgraph information of the target RNA-like topology (subfile) The file with the target RNA-like topology information should have the following format (see example target file Examples/Design/Input/Target.txt for RNA-like topology shown in Figure 4): 8

9 numloops looporder adjmatrix restrictloops restrictloopfiles n 5 to 3 order of loops adjacency matrix for the target graph (5 to 3 order) rloopnum restrictfrag where n is the number of loops in the target RNA-like topology, looporder specifies the order of loops in the 5 to 3 order, and adjacency matrix specifies the loop connections in the 5 to 3 order. The looporder and adjacency matrix specify the orientation of the target topology. If any loop is to be restricted to a specific fragment, rloopnum specifies the loop number, and restrictfrag specifies the name of the fragment to be used. The subgraph information file should have the same format as described in Subsection 3.3 (see example subgraph file Examples/Design/Input/Subgraphs.txt for subgraph division shown in Figure 4): Figure 4: Loop numbers, vertex numbers and subgraphs used in F-RAG for the RNA-like topology 8 9. See Subsection 3.1 for how the loops and 3D tree graph vertices are numbered. The fragment directory must contain: 1. The PDB files for atomic fragments corresponding to different target subgraphs (e.g., subgraph0 frag0.pdb) 9

10 2. The 2D structure files for atomic fragments corresponding to different target subgraphs (e.g., subgraph0 frag0.bpseq) If specified, the restricted fragment directory must contain: 1. The PDB file for the atomic fragment to be used for the restricted loop (e.g., restrictfrag.pdb) 2. The 2D structure file for the atomic fragment to be used for the restricted loop (e.g., restrict- Frag.bpseq) After the F-RAG run is completed, the output directory will contain: 1. Generated atomic models and corresponding 3D tree graphs and 2D structure files (Model i.pdb, Graph i.pdb, and Model i.bpseq, where i is the atomic model number) 2. Text file with columns listing the atomic model number, score of the atomic model 3D tree graph, if the atomic model 3D tree graph contains a steric clash, and number of residues in the atomic model (ModelScores.txt) 3. Text file with columns listing the atomic model number and the fragments used to construct that atomic model (ModelFragments.txt) The atomic models generated by F-RAG are not optimized for energy or geometry and may contain chain breaks. The sequences of the atomic models are not guaranteed to fold onto the target RNA-like topology with RNA 2D structure prediction programs. For best results, we recommend running F-RAG for multiple orientations and subgraph decompositions of the target RNA-like topology, selecting atomic models without chain breaks and lowest scores (lower scores are better), followed by further screening based on the graph topologies of the 2D structures predicted by at least two different structure prediction programs [4]. Examples/Design/ contain sample input and output directories for F-RAG run for the target RNA-like topology orientation and subgraph decomposition shown in Figure 4. The following command was used for the F-RAG run:./ragtop -design -file Target.txt -inputdir Examples/Design/Input/ -outputdir Examples/Design/Output/ -subgraph Subgraphs.txt -libdir LibFiles/InternalLoops/ -fragment dir Examples/Design/Input/Fragments/ 4 Other features 4.1 Removal of pseudoknots from the 2D structure RAGTOP can also be used to remove pseudoknots from an input 2D structure by using the following flags: 10

11 Required flags: -remove pk -file filename -inputdir path -outputdir path remove the pseudoknot from the input structure input 2D structure in bpseq format (without extension) input directory output directory The input directory must contain the input 2D structure (filename.bpseq). After the run is completed, the output directory will contain the 2D structure file without pseudoknots (filename nopk.bpseq). 4.2 Generating loop and vertex information for RAG-3D This feature is used to generate files containing description of the loops types in a given RNA 2D structure and the vertex types in its corresponding 3D tree graph. These files are used as input for RAG-3D search [10] to partition a 3D tree graph into subgraphs and return best matching fragments for each subgraph (used as input for F-RAG for 3D structure prediction as described in Subsection 3.3). The flags needed to generate loop and vertex information for a 2D structure are: Required flags: -graph -file filename -inputdir path -outputdir path generate the loop and vertex files input 2D structure in bpseq format (without extension) input directory output directory The input directory must contain: 1. The input 2D structure (filename.bpseq) After the run is completed, the output directory will contain: 1. The 3D tree graph constructed from the 2D structure after junction prediction (filename Graph.pdb) 2. Text file with loop numbers (dangling end, hairpin, internal loop, or junction) and corresponding residue numbers (Loopsfilename.txt) 3. Text file with vertex number for helical vertices in the tree graph, along with corresponding residue numbers (Verticesfilename.txt) 4. Text file with vertex number for loop vertices and corresponding loop type (VertexTypesfilename.txt) Examples/Graph/ contains sample input and output directories for the following run:./ragtop -graph -file 1DK1 -inputdir Examples/Graph/Input/ -outputdir Examples/Graph/Output/ 11

12 5 External libraries used 1. Template Numerical Toolkit (TNT) - an interface for scientific computing in C++. It is developed at the National Institute of Standards and Technology (NIST) and available to download from https: //math.nist.gov/tnt/index.html. 2. Mersenne Twister - a random number generator ( MT/emt.html). Please see the enclosed description file. 3. Random Forests with Artificial Construct Ensembles (rfacer) - developed by Timo Erkkila. Please see the enclosed description file. References [1] N. Kim, C. Laing, S. Elmetwaly, S. Jung, J. Curuksu, and T. Schlick, Graph-based sampling for approximating global helical topologies of RNA., Proc Natl Acad Sci USA, vol. 111, no. 11, pp , [2] C. S. Bayrak, N. Kim, and T. Schlick, Using sequence signatures and kink-turn motifs in knowledgebased statistical potentials for RNA structure prediction., Nucleic Acids Res, vol. 45, no. 9, pp , [3] S. Jain and T. Schlick, F-RAG: Generating atomic models from RNA graphs using fragment assembly, J Mol Biol, vol. 429, no. 23, pp , [4] S. Jain, A. Laederach, S. B. Ramos, and T. Schlick, A pipeline for computational design of novel RNA-like topologies, Nucleic Acid Res, p. In Revision, [5] H. H. Gan, S. Pasquali, and T. Schlick, Exploring the repertoire of RNA secondary motifs using graph theory; implications for RNA design, Nucleic Acids Res, vol. 31, no. 11, pp , [6] H. H. Gan, D. Fera, J. Zorn, N. Shiffeldrim, M. Tang, U. Laserson, N. Kim, and T. Schlick, RAG: RNA-As-Graphs database concepts, analysis, and features, Bioinformatics, vol. 20, no. 8, pp , [7] C. Laing, D. Wen, J. T. L. Wang, and T. Schlick, Predicting coaxial helical stacking in RNA junctions., Nucleic Acids Res, vol. 40, no. 2, pp , [8] C. Laing, S. Jung, N. Kim, S. Elmetwaly, M. Zahran, and T. Schlick, Predicting helical topologies in RNA junctions as tree graphs, PLoS ONE, vol. 8, no. 8, p. e71947, [9] N. Kim, Z. Zheng, S. Elmetwaly, and T. Schlick, RNA graph partitioning for the discovery of RNA modularity: a novel application of graph partition algorithm to biology, PLoS ONE, vol. 9, no. 9, p. e106074, [10] M. Zahran, C. S. Bayrak, S. Elmetwaly, and T. Schlick, RAG-3D: a search tool for RNA 3D substructures, Nucleic Acids Res, vol. 43, no. 19, pp ,

13 [11] N. Baba, S. Elmetwaly, N. Kim, and T. Schlick, Predicting large RNA-like topologies by a knowledgebased clustering approach, J Mol Biol, vol. 428, no. 5, pp ,

GRaph theory is a field of mathematics with applications

GRaph theory is a field of mathematics with applications IAENG International Journal of Computer Science, 44:2, IJCS_44_2_3 Partitioning and Classification of RNA Secondary Structures into Pseudonotted and Pseudoknot-free Regions Using a Graph-Theoretical Approach

More information

Supplementary Material

Supplementary Material Supplementary Material Statistical Potentials i) Internal Loop Potentials (Bend and Torsion Angles) An internal loop is defined by two double stranded regions connected by a bulge. In RAG-3D, these two

More information

RAG-3D: a search tool for RNA 3D substructures

RAG-3D: a search tool for RNA 3D substructures City University of New York (CUNY) CUNY Academic Works Publications and Research New York City College of Technology October 2015 RAG-3D: a search tool for RNA 3D substructures Mai Zahran CUNY New York

More information

Dynamic Programming Course: A structure based flexible search method for motifs in RNA. By: Veksler, I., Ziv-Ukelson, M., Barash, D.

Dynamic Programming Course: A structure based flexible search method for motifs in RNA. By: Veksler, I., Ziv-Ukelson, M., Barash, D. Dynamic Programming Course: A structure based flexible search method for motifs in RNA By: Veksler, I., Ziv-Ukelson, M., Barash, D., Kedem, K Outline Background Motivation RNA s structure representations

More information

7.36/7.91/20.390/20.490/6.802/6.874 PROBLEM SET 3. Gibbs Sampler, RNA secondary structure, Protein Structure with PyRosetta, Connections (25 Points)

7.36/7.91/20.390/20.490/6.802/6.874 PROBLEM SET 3. Gibbs Sampler, RNA secondary structure, Protein Structure with PyRosetta, Connections (25 Points) 7.36/7.91/20.390/20.490/6.802/6.874 PROBLEM SET 3. Gibbs Sampler, RNA secondary structure, Protein Structure with PyRosetta, Connections (25 Points) Due: Thursday, April 3 th at noon. Python Scripts All

More information

Modeling solution conformation of a non-coding RNA molecule using PyRy3D web-server.

Modeling solution conformation of a non-coding RNA molecule using PyRy3D web-server. Modeling solution conformation of a non-coding RNA molecule using PyRy3D web-server. During this exercise you will learn how to build a 3D model of an RNA molecule based on secondary structure restraints

More information

Science Olympiad Protein Modeling Event Guide to Scoring Zinc Finger Motif

Science Olympiad Protein Modeling Event Guide to Scoring Zinc Finger Motif Science Olympiad Protein Modeling Event Guide to Scoring Zinc Finger Motif Once you have folded the zinc finger motif (chain C, residues 4-31 of 1ZAA.pdb), use this guide in conjunction with the rubric

More information

JET 2 User Manual 1 INSTALLATION 2 EXECUTION AND FUNCTIONALITIES. 1.1 Download. 1.2 System requirements. 1.3 How to install JET 2

JET 2 User Manual 1 INSTALLATION 2 EXECUTION AND FUNCTIONALITIES. 1.1 Download. 1.2 System requirements. 1.3 How to install JET 2 JET 2 User Manual 1 INSTALLATION 1.1 Download The JET 2 package is available at www.lcqb.upmc.fr/jet2. 1.2 System requirements JET 2 runs on Linux or Mac OS X. The program requires some external tools

More information

A Partition Function Algorithm for Nucleic Acid Secondary Structure Including Pseudoknots

A Partition Function Algorithm for Nucleic Acid Secondary Structure Including Pseudoknots A Partition Function Algorithm for Nucleic Acid Secondary Structure Including Pseudoknots ROBERT M. DIRKS, 1 NILES A. PIERCE 2 1 Department of Chemistry, California Institute of Technology, Pasadena, California

More information

Dynamic Programming (cont d) CS 466 Saurabh Sinha

Dynamic Programming (cont d) CS 466 Saurabh Sinha Dynamic Programming (cont d) CS 466 Saurabh Sinha Spliced Alignment Begins by selecting either all putative exons between potential acceptor and donor sites or by finding all substrings similar to the

More information

The beginning of this guide offers a brief introduction to the Protein Data Bank, where users can download structure files.

The beginning of this guide offers a brief introduction to the Protein Data Bank, where users can download structure files. Structure Viewers Take a Class This guide supports the Galter Library class called Structure Viewers. See our Classes schedule for the next available offering. If this class is not on our upcoming schedule,

More information

A Parallel Implementation of a Higher-order Self Consistent Mean Field. Effectively solving the protein repacking problem is a key step to successful

A Parallel Implementation of a Higher-order Self Consistent Mean Field. Effectively solving the protein repacking problem is a key step to successful Karl Gutwin May 15, 2005 18.336 A Parallel Implementation of a Higher-order Self Consistent Mean Field Effectively solving the protein repacking problem is a key step to successful protein design. Put

More information

FastCluster: a graph theory based algorithm for removing redundant sequences

FastCluster: a graph theory based algorithm for removing redundant sequences J. Biomedical Science and Engineering, 2009, 2, 621-625 doi: 10.4236/jbise.2009.28090 Published Online December 2009 (http://www.scirp.org/journal/jbise/). FastCluster: a graph theory based algorithm for

More information

Bioinformatics III Structural Bioinformatics and Genome Analysis

Bioinformatics III Structural Bioinformatics and Genome Analysis Bioinformatics III Structural Bioinformatics and Genome Analysis Chapter 3 Structural Comparison and Alignment 3.1 Introduction 1. Basic algorithms review Dynamic programming Distance matrix 2. SARF2,

More information

RNA Folding with Hard and Soft Constraints - Supplementary Material

RNA Folding with Hard and Soft Constraints - Supplementary Material RNA Folding with Hard and Soft Constraints - Supplementary Material Ronny Lorenz 1, Ivo L. Hofacker 1,2,3, and Peter F. Stadler 4,1,3,5,6,7 1 Institute for Theoretical Chemistry, University of Vienna,

More information

Practical 10: Protein dynamics and visualization Documentation

Practical 10: Protein dynamics and visualization Documentation Practical 10: Protein dynamics and visualization Documentation Release 1.0 Oliver Beckstein March 07, 2013 CONTENTS 1 Basics of protein structure 3 2 Analyzing protein structure and topology 5 2.1 Topology

More information

Prediction of RNA secondary structure including kissing hairpin motifs

Prediction of RNA secondary structure including kissing hairpin motifs Prediction of RNA secondary structure including kissing hairpin motifs Corinna Theis, Stefan Janssen and Robert Giegerich Faculty of Technology & Center for Biotechnology Bielefeld University, Germany

More information

Graph Theory. Graph Theory. COURSE: Introduction to Biological Networks. Euler s Solution LECTURE 1: INTRODUCTION TO NETWORKS.

Graph Theory. Graph Theory. COURSE: Introduction to Biological Networks. Euler s Solution LECTURE 1: INTRODUCTION TO NETWORKS. Graph Theory COURSE: Introduction to Biological Networks LECTURE 1: INTRODUCTION TO NETWORKS Arun Krishnan Koenigsberg, Russia Is it possible to walk with a route that crosses each bridge exactly once,

More information

A Branch and Bound Algorithm for the Protein Folding Problem in the HP Lattice Model

A Branch and Bound Algorithm for the Protein Folding Problem in the HP Lattice Model Article A Branch and Bound Algorithm for the Protein Folding Problem in the HP Lattice Model Mao Chen* and Wen-Qi Huang School of Computer Science and Technology, Huazhong University of Science and Technology,

More information

A Short Rasmol Tutorial: trna

A Short Rasmol Tutorial: trna A Short Rasmol Tutorial: trna Note that this tutorial is due at the beginning of class on Wednesday, October 3. amino acid attaches here 3 end trna secondary structure. The sequence of yeast trna Phe is

More information

Linear trees and RNA secondary. structuret's

Linear trees and RNA secondary. structuret's ELSEVIER Discrete Applied Mathematics 51 (1994) 317-323 DISCRETE APPLIED MATHEMATICS Linear trees and RNA secondary. structuret's William R. Schmitt*.", Michael S. Watermanb "University of Memphis. Memphis,

More information

BIOINFORMATICS. A vector-based method for drawing RNA secondary structure. Abstract. Introduction. System and methods. 286 Oxford University Press

BIOINFORMATICS. A vector-based method for drawing RNA secondary structure. Abstract. Introduction. System and methods. 286 Oxford University Press BIOINFORMATICS A vector-based method for drawing RNA secondary structure Abstract Motivation: To produce a polygonal display of RNA secondary structure with minimal overlap and distortion of structural

More information

Homology Modeling Professional for HyperChem Release Notes

Homology Modeling Professional for HyperChem Release Notes Homology Modeling Professional for HyperChem Release Notes This document lists additional information about Homology Modeling Professional for HyperChem. Current Revision Revision H1 (Version 8.1.1) Current

More information

ssrna Example SASSIE Workflow Data Interpolation

ssrna Example SASSIE Workflow Data Interpolation NOTE: This PDF file is for reference purposes only. This lab should be accessed directly from the web at https://sassieweb.chem.utk.edu/sassie2/docs/sample_work_flows/ssrna_example/ssrna_example.html.

More information

A Monte-Carlo Estimate of DNA Loop Formation

A Monte-Carlo Estimate of DNA Loop Formation A Monte-Carlo Estimate of DNA Loop Formation CAROL BETH POST,* Department of Chemistry, University of California, San Diego, La Jolla, California 92093 Synopsis The ends of rather short double-helical

More information

SimRNA (version 3.20) User Manual

SimRNA (version 3.20) User Manual SimRNA (version 3.20) User Manual 1. SimRNA: Functionality SimRNA is a tool for simulations of RNA conformational dynamics (folding, unfolding, multiple chain complex formation etc.), and its applications

More information

Deciphering the Information Encoded in RNA Viral Genomes

Deciphering the Information Encoded in RNA Viral Genomes Deciphering the Information Encoded in RNA Viral Genomes Christine E. Heitsch Genome Center of Wisconsin and Mathematics Department University of Wisconsin Madison Detecting and Processing Regularities

More information

DNA Tutorial for Arcimboldo

DNA Tutorial for Arcimboldo BORGES ARCIMBOLDO DNA Tutorial for Arcimboldo Aims of the tutorial This tutorial shows how to launch BORGES ARCIMBOLDO in the particular case of DNA binding protein libraries (Pröpper et al., 2014). In

More information

Introduction to the Protein Data Bank Master Chimie Info Roland Stote Page #

Introduction to the Protein Data Bank Master Chimie Info Roland Stote Page # Introduction to the Protein Data Bank Master Chimie Info - 2009 Roland Stote The purpose of the Protein Data Bank is to collect and organize 3D structures of proteins, nucleic acids, protein-nucleic acid

More information

REDCAT LABORATORY EXERCISE BCMB/CHEM 8190, April 13, REDCAT may be downloaded from:

REDCAT LABORATORY EXERCISE BCMB/CHEM 8190, April 13, REDCAT may be downloaded from: REDCAT LABORATORY EXERCISE BCMB/CHEM 8190, April 13, 2012 Installation note for instructors: REDCAT may be downloaded from: http://ifestos.cse.sc.edu/software.php#redcat You will also find further instructions

More information

A Coprocessor Architecture for Fast Protein Structure Prediction

A Coprocessor Architecture for Fast Protein Structure Prediction A Coprocessor Architecture for Fast Protein Structure Prediction M. Marolia, R. Khoja, T. Acharya, C. Chakrabarti Department of Electrical Engineering Arizona State University, Tempe, USA. Abstract Predicting

More information

RNA SECONDARY STRUCTURE PREDICTION TOOL

RNA SECONDARY STRUCTURE PREDICTION TOOL San Jose State University SJSU ScholarWorks Master's Projects Master's Theses and Graduate Research Spring 2011 RNA SECONDARY STRUCTURE PREDICTION TOOL Meenakshee Mali San Jose State University Follow

More information

How to use the DEGseq Package

How to use the DEGseq Package How to use the DEGseq Package Likun Wang 1,2 and Xi Wang 1. October 30, 2018 1 MOE Key Laboratory of Bioinformatics and Bioinformatics Division, TNLIST /Department of Automation, Tsinghua University. 2

More information

Docking Study with HyperChem Release Notes

Docking Study with HyperChem Release Notes Docking Study with HyperChem Release Notes This document lists additional information about Docking Study with HyperChem family, Essential, Premium Essential, Professional, Advanced, Ultimat, and Cluster.

More information

CHEM5302 Fall 2015: Introduction to Maestro and the command line

CHEM5302 Fall 2015: Introduction to Maestro and the command line CHEM5302 Fall 2015: Introduction to Maestro and the command line Ronald Levy October 29, 2015 1 Introduction As this course has evolved through the years, the landscape of computational hardware and software

More information

Chapter 6. Multiple sequence alignment (week 10)

Chapter 6. Multiple sequence alignment (week 10) Course organization Introduction ( Week 1,2) Part I: Algorithms for Sequence Analysis (Week 1-11) Chapter 1-3, Models and theories» Probability theory and Statistics (Week 3)» Algorithm complexity analysis

More information

CHEM 5412 Spring 2017: Introduction to Maestro and Linux Command Line

CHEM 5412 Spring 2017: Introduction to Maestro and Linux Command Line CHEM 5412 Spring 2017: Introduction to Maestro and Linux Command Line March 28, 2017 1 Introduction Molecular modeling, as with other computational sciences, has rapidly grown and taken advantage of the

More information

Prediction of Geometrically Feasible Three Dimensional Structures of Pseudoknotted RNA through Free Energy Estimation

Prediction of Geometrically Feasible Three Dimensional Structures of Pseudoknotted RNA through Free Energy Estimation Prediction of eometrically Feasible Three Dimensional Structures of Pseudoknotted RN through Free Energy Estimation Jian Zhang 1,2, Joseph Dundas 1, Ming Lin 3, Rong hen 3, Wei Wang 2, Jie Liang 1, 1 Department

More information

Small-Molecule Ligand Docking into Comparative Models with Rosetta

Small-Molecule Ligand Docking into Comparative Models with Rosetta Supplementary Information Small-Molecule Ligand Docking into Comparative Models with Rosetta Steven A. Combs 1,2,*, Samuel L. DeLuca 1,3,*, Stephanie H. DeLuca 1,3,*, Gordon H. Lemmon 1,3,*, David P. Nannemann

More information

REDCAT INSTALLATION. BCMB/CHEM 8190, April 7,

REDCAT INSTALLATION. BCMB/CHEM 8190, April 7, REDCAT INSTALLATION BCMB/CHEM 8190, April 7, 2006 Installation note for instructors: Download REDCAT from: http://tesla.ccrc.uga.edu/software/redcat While REDCAT is developed on and for Linux systems,

More information

Parametric analysis of RNA branching configurations

Parametric analysis of RNA branching configurations Parametric analysis of RNA branching configurations Valerie Hower, Christine E. Heitsch Abstract Motivated by recent work in parametric sequence alignment, we study the parameter space for scoring RNA

More information

Towards a Weighted-Tree Similarity Algorithm for RNA Secondary Structure Comparison

Towards a Weighted-Tree Similarity Algorithm for RNA Secondary Structure Comparison Towards a Weighted-Tree Similarity Algorithm for RNA Secondary Structure Comparison Jing Jin, Biplab K. Sarker, Virendra C. Bhavsar, Harold Boley 2, Lu Yang Faculty of Computer Science, University of New

More information

A Seeded Genetic Algorithm for RNA Secondary Structural Prediction with Pseudoknots

A Seeded Genetic Algorithm for RNA Secondary Structural Prediction with Pseudoknots San Jose State University SJSU ScholarWorks Master's Projects Master's Theses and Graduate Research 2008 A Seeded Genetic Algorithm for RNA Secondary Structural Prediction with Pseudoknots Ryan Pham San

More information

MONSTER v1.0 User s Guide

MONSTER v1.0 User s Guide MONSTER v1.0 User s Guide Contents Chapter 1: Getting Started... 3 MONSTER v 1.0... 3 Pipeline overview... 3 System requirements... 4 Setting up... 4 Additional files... 5 Chapter 2: Basic Usage... 6 Aim

More information

) I R L Press Limited, Oxford, England. The protein identification resource (PIR)

) I R L Press Limited, Oxford, England. The protein identification resource (PIR) Volume 14 Number 1 Volume 1986 Nucleic Acids Research 14 Number 1986 Nucleic Acids Research The protein identification resource (PIR) David G.George, Winona C.Barker and Lois T.Hunt National Biomedical

More information

A modular data analysis pipeline for the discovery of novel RNA motifs

A modular data analysis pipeline for the discovery of novel RNA motifs Retrospective Theses and Dissertations Iowa State University Capstones, Theses and Dissertations 2006 A modular data analysis pipeline for the discovery of novel RNA motifs Justin Schonfeld Iowa State

More information

Managing Your Biological Data with Python

Managing Your Biological Data with Python Chapman & Hall/CRC Mathematical and Computational Biology Series Managing Your Biological Data with Python Ailegra Via Kristian Rother Anna Tramontano CRC Press Taylor & Francis Group Boca Raton London

More information

RAMMCAP The Rapid Analysis of Multiple Metagenomes with a Clustering and Annotation Pipeline

RAMMCAP The Rapid Analysis of Multiple Metagenomes with a Clustering and Annotation Pipeline RAMMCAP The Rapid Analysis of Multiple Metagenomes with a Clustering and Annotation Pipeline Weizhong Li, liwz@sdsc.edu CAMERA project (http://camera.calit2.net) Contents: 1. Introduction 2. Implementation

More information

Re-dock of Roscovitine Against Human Cyclin-Dependent Kinase 2 with Molegro Virtual Docker

Re-dock of Roscovitine Against Human Cyclin-Dependent Kinase 2 with Molegro Virtual Docker Tutorial Re-dock of Roscovitine Against Human Cyclin-Dependent Kinase 2 with Molegro Virtual Docker Prof. Dr. Walter Filgueira de Azevedo Jr. walter@azevedolab.net azevedolab.net 1 Introduction In this

More information

Geometry Optimization Made Simple with Translation and Rotation Coordinates

Geometry Optimization Made Simple with Translation and Rotation Coordinates Geometry Optimization Made Simple with Translation and Rotation Coordinates Lee-Ping Wang 1 and Chenchen Song 2, 3 1) Department of Chemistry, University of California; 1 Shields Ave; Davis, CA 95616.

More information

Package ASEB. January 20, 2019

Package ASEB. January 20, 2019 Title Predict Acetylated Lysine Sites Version 1.26.0 Package ASEB January 20, 2019 Author Likun Wang and Tingting Li . ASEB is an R package to predict lysine

More information

PyMOL is a molecular visualization tool. There are many such tools available both commercially and publicly available:

PyMOL is a molecular visualization tool. There are many such tools available both commercially and publicly available: Workshop #1: PyMOL PyMOL is a molecular visualization tool. There are many such tools available both commercially and publicly available: PyMOL (www.pymol.org) Swiss-PdbViewer (spdbv.vital-it.ch) RasMol

More information

Multiple sequence alignment accuracy estimation and its role in creating an automated bioinformatician

Multiple sequence alignment accuracy estimation and its role in creating an automated bioinformatician Multiple sequence alignment accuracy estimation and its role in creating an automated bioinformatician Dan DeBlasio dandeblasio.com danfdeblasio StringBio 2018 Tunable parameters!2 Tunable parameters Quant

More information

RUNNING MOLECULAR DYNAMICS SIMULATIONS WITH CHARMM: A BRIEF TUTORIAL

RUNNING MOLECULAR DYNAMICS SIMULATIONS WITH CHARMM: A BRIEF TUTORIAL RUNNING MOLECULAR DYNAMICS SIMULATIONS WITH CHARMM: A BRIEF TUTORIAL While you can probably write a reasonable program that carries out molecular dynamics (MD) simulations, it s sometimes more efficient

More information

Structural Bioinformatics

Structural Bioinformatics Structural Bioinformatics Elucidation of the 3D structures of biomolecules. Analysis and comparison of biomolecular structures. Prediction of biomolecular recognition. Handles three-dimensional (3-D) structures.

More information

Algebraic Dynamic Programming

Algebraic Dynamic Programming Algebraic Dynamic Programming Session 1: Introduction Robert Giegerich 1 (Lecture) Stefan Janssen (Exercises) Faculty of Technology http://www.techfak.uni-bielefeld.de/ags/pi/lehre/adp 1 robert@techfak.uni-bielefeld.de

More information

Refinement into cryo-em maps. Garib Murshudov MRC-LMB, Cambridge, UK

Refinement into cryo-em maps. Garib Murshudov MRC-LMB, Cambridge, UK Refinement into cryo-em maps Garib Murshudov MRC-LMB, Cambridge, UK Contents About REFMAC Fit into EM maps Effect of oversharpening About REFMAC Refmac is a program for refinement of atomic models into

More information

CLC Server. End User USER MANUAL

CLC Server. End User USER MANUAL CLC Server End User USER MANUAL Manual for CLC Server 10.0.1 Windows, macos and Linux March 8, 2018 This software is for research purposes only. QIAGEN Aarhus Silkeborgvej 2 Prismet DK-8000 Aarhus C Denmark

More information

Automatic MR Garib Murshudov MRC-LMB, Cambridge

Automatic MR Garib Murshudov MRC-LMB, Cambridge Automatic MR Garib Murshudov MRC-LMB, Cambridge These slides provided by Ronan Keegan MR pipelines in CCP4 MrBUMP - Ronan Keegan, Martin Winn BALBES Fei Long, Alexei Vagin, Garib Murshudov Ample - Ronan

More information

Deliverable D5.5. D5.5 VRE-integrated PDBe Search and Query API. World-wide E-infrastructure for structural biology. Grant agreement no.

Deliverable D5.5. D5.5 VRE-integrated PDBe Search and Query API. World-wide E-infrastructure for structural biology. Grant agreement no. Deliverable D5.5 Project Title: World-wide E-infrastructure for structural biology Project Acronym: West-Life Grant agreement no.: 675858 Deliverable title: D5.5 VRE-integrated PDBe Search and Query API

More information

To execute this program all we need to do is to type the name of the file (plotlog) in MATLAB main console and the complete file will be executed.

To execute this program all we need to do is to type the name of the file (plotlog) in MATLAB main console and the complete file will be executed. Programs and functions While using MATLAB as a fancy calculator has its own uses. It is also possible to use MATLAB as a programming language and to develop with it significant codes with considerable

More information

Three-dimensional structure and flexibility of a membrane-coating module of the nuclear pore complex

Three-dimensional structure and flexibility of a membrane-coating module of the nuclear pore complex CORRECTION NOTICE Nat. Struct. Mol. Biol. advance online publication, doi:10.1038/nsmb.1618 (7 June 2009) Three-dimensional structure and flexibility of a membrane-coating module of the nuclear pore complex

More information

Properties of Biological Networks

Properties of Biological Networks Properties of Biological Networks presented by: Ola Hamud June 12, 2013 Supervisor: Prof. Ron Pinter Based on: NETWORK BIOLOGY: UNDERSTANDING THE CELL S FUNCTIONAL ORGANIZATION By Albert-László Barabási

More information

Workshop #7: Docking. Suggested Readings

Workshop #7: Docking. Suggested Readings Workshop #7: Docking Protein protein docking is the prediction of a complex structure starting from its monomer components. The search space can be extremely large, so large amounts of computational resources

More information

Dynamic Programming & Smith-Waterman algorithm

Dynamic Programming & Smith-Waterman algorithm m m Seminar: Classical Papers in Bioinformatics May 3rd, 2010 m m 1 2 3 m m Introduction m Definition is a method of solving problems by breaking them down into simpler steps problem need to contain overlapping

More information

jviz.rna - An Interactive Graphical Tool for Visualizing RNA Secondary Structure Including Pseudoknots

jviz.rna - An Interactive Graphical Tool for Visualizing RNA Secondary Structure Including Pseudoknots jviz.rna - An Interactive Graphical Tool for Visualizing RNA Secondary Structure Including Pseudoknots Kay C. Wiese, Senior Member, IEEE and Edward Glen, Student Member, IEEE Simon Fraser University School

More information

Bioinformatics explained: Smith-Waterman

Bioinformatics explained: Smith-Waterman Bioinformatics Explained Bioinformatics explained: Smith-Waterman May 1, 2007 CLC bio Gustav Wieds Vej 10 8000 Aarhus C Denmark Telephone: +45 70 22 55 09 Fax: +45 70 22 55 19 www.clcbio.com info@clcbio.com

More information

PyMod Documentation (Version 2.1, September 2011)

PyMod Documentation (Version 2.1, September 2011) PyMod User s Guide PyMod Documentation (Version 2.1, September 2011) http://schubert.bio.uniroma1.it/pymod/ Emanuele Bramucci & Alessandro Paiardini, Francesco Bossa, Stefano Pascarella, Department of

More information

A FILTERING TECHNIQUE FOR FRAGMENT ASSEMBLY- BASED PROTEINS LOOP MODELING WITH CONSTRAINTS

A FILTERING TECHNIQUE FOR FRAGMENT ASSEMBLY- BASED PROTEINS LOOP MODELING WITH CONSTRAINTS A FILTERING TECHNIQUE FOR FRAGMENT ASSEMBLY- BASED PROTEINS LOOP MODELING WITH CONSTRAINTS F. Campeotto 1,2 A. Dal Palù 3 A. Dovier 2 F. Fioretto 1 E. Pontelli 1 1. Dept. Computer Science, NMSU 2. Dept.

More information

Performance analysis of parallel de novo genome assembly in shared memory system

Performance analysis of parallel de novo genome assembly in shared memory system IOP Conference Series: Earth and Environmental Science PAPER OPEN ACCESS Performance analysis of parallel de novo genome assembly in shared memory system To cite this article: Syam Budi Iryanto et al 2018

More information

February 2010 Christopher Bruns

February 2010 Christopher Bruns Molecular Simulation with OpenMM Zephyr February 2010 Christopher Bruns What is OpenMM Zephyr? Graphical user interface for running GPU accelerated molecular dynamics simulations Automates running of gromacs

More information

CS612 - Algorithms in Bioinformatics

CS612 - Algorithms in Bioinformatics Fall 2017 Structural Manipulation November 22, 2017 Rapid Structural Analysis Methods Emergence of large structural databases which do not allow manual (visual) analysis and require efficient 3-D search

More information

Biologically significant sequence alignments using Boltzmann probabilities

Biologically significant sequence alignments using Boltzmann probabilities Biologically significant sequence alignments using Boltzmann probabilities P Clote Department of Biology, Boston College Gasson Hall 16, Chestnut Hill MA 0267 clote@bcedu Abstract In this paper, we give

More information

Parametric and Inverse Parametric Sequence Alignment

Parametric and Inverse Parametric Sequence Alignment Parametric and Inverse Parametric Sequence Alignment Nan Lu, nlu@math.gatech.edu School of Mathematics, Georgia Institute of Technology School of Mathematics, Georgia Institute of Technology 22:36, April

More information

CryoEM Skeleton Length Estimation using a Decimated Curve

CryoEM Skeleton Length Estimation using a Decimated Curve CryoEM Skeleton Length Estimation using a Decimated Curve Andrew McKnight, Kamal Al Nasr, Dong Si, Andrey Chernikov, Nikos Chrisochoides, Jing He Abstract - Cryo-electron Microscopy (cryoem) is an important

More information

Active Workflow Combination type

Active Workflow Combination type Molecular Profiling Research Center for Drug Discovery (MolProf), AIST Active Workflow Combination type Installation manual MolProf, AIST 2016/04/25 Contents 1 Introduction... 2 2 About Active workflow

More information

The Gene Modular Detection of Random Boolean Networks by Dynamic Characteristics Analysis

The Gene Modular Detection of Random Boolean Networks by Dynamic Characteristics Analysis Journal of Materials, Processing and Design (2017) Vol. 1, Number 1 Clausius Scientific Press, Canada The Gene Modular Detection of Random Boolean Networks by Dynamic Characteristics Analysis Xueyi Bai1,a,

More information

Visualization of Secondary RNA Structure Prediction Algorithms

Visualization of Secondary RNA Structure Prediction Algorithms San Jose State University SJSU ScholarWorks Master's Projects Master's Theses and Graduate Research 2006 Visualization of Secondary RNA Structure Prediction Algorithms Brandon Hunter San Jose State University

More information

A NEW TECHNIQUE FOR SKETCHING EPICYCLIC GEAR MECHANISMS USING ACYCLIC GRAPH

A NEW TECHNIQUE FOR SKETCHING EPICYCLIC GEAR MECHANISMS USING ACYCLIC GRAPH International Journal of Mechanical and Production Engineering Research and Development (IJMPERD) ISSN(P): 2249-6890; ISSN(E): 2249-8001 Vol. 4, Issue 3, Jun 2014, 79-90 TJPRC Pvt. Ltd. A NEW TECHNIQUE

More information

Heterotachy models in BayesPhylogenies

Heterotachy models in BayesPhylogenies Heterotachy models in is a general software package for inferring phylogenetic trees using Bayesian Markov Chain Monte Carlo (MCMC) methods. The program allows a range of models of gene sequence evolution,

More information

Justin T. Douglas 1/21/09 A short guide to NMR structure calculations using Xplor-NIH.

Justin T. Douglas 1/21/09 A short guide to NMR structure calculations using Xplor-NIH. A short guide to NMR structure calculations using Xplor-NIH. The purpose of this guide is help people get started using Xplor-NIH for NMR structure calculations. It is not an exhaustive guide, nor is it

More information

Game Level Layout from Design Specification

Game Level Layout from Design Specification Copyright of figures and other materials in the paper belongs original authors. Game Level Layout from Design Specification Chongyang Ma et al. EUROGRAPHICS 2014 Presented by YoungBin Kim 2015. 01. 13

More information

Molecular Distance Geometry and Atomic Orderings

Molecular Distance Geometry and Atomic Orderings Molecular Distance Geometry and Atomic Orderings Antonio Mucherino IRISA, University of Rennes 1 Workshop Set Computation for Control ENSTA Bretagne, Brest, France December 5 th 2013 The Distance Geometry

More information

Simple REFMAC tutorials

Simple REFMAC tutorials Simple REFMAC tutorials Prerequisites: To use this tutorial you need to have ccp4. For jelly body, automatic and local ncs restraints, occupancy refinement you need to have the latest version of ccp4-6.2

More information

Rsubread package: high-performance read alignment, quantification and mutation discovery

Rsubread package: high-performance read alignment, quantification and mutation discovery Rsubread package: high-performance read alignment, quantification and mutation discovery Wei Shi 14 September 2015 1 Introduction This vignette provides a brief description to the Rsubread package. For

More information

LINEAR PROGRAMMING BASED APPROACH. Tatsuya AKUTSU a. Human Genome Center, Institute of Medical Science,

LINEAR PROGRAMMING BASED APPROACH. Tatsuya AKUTSU a. Human Genome Center, Institute of Medical Science, LINEAR PROGRAMMING BASED APPROACH TO THE DERIVATION OF A CONTACT POTENTIAL FOR PROTEIN THREADING Tatsuya AKUTSU a Human Genome Center, Institute of Medical Science, University of Tokyo, 4-6-1 Shirokanedai,

More information

A Demonstration of Clustering in Protein Contact Maps for alpha Helix Pairs

A Demonstration of Clustering in Protein Contact Maps for alpha Helix Pairs A Demonstration of Clustering in Protein Contact Maps for alpha Helix Pairs Robert Fraser 1 and Janice Glasgow 2 1 University of Waterloo, Waterloo, ON, Canada, N2L 3G1 r3fraser@cs.uwaterloo.ca, www home

More information

A Multiple Graph Layers Model with Application to RNA Secondary Structures Comparison

A Multiple Graph Layers Model with Application to RNA Secondary Structures Comparison Author manuscript, published in "String Processing and Information Retrieval 2005, Argentine (2005)" A Multiple Graph Layers Model with Application to RNA Secondary Structures Comparison Julien Allali

More information

CMView 1.1 User's Manual

CMView 1.1 User's Manual Table of Contents Overview... 1 Contact map definition... 1 Contact types... 1 Screen elements... 2 Function Reference... 3 File... 3 Select... 5 Color... 7 Action... 7 Compare... 8 Help... 10 Context

More information

Chimera EM Map Tutorial: RNA Polymerase II

Chimera EM Map Tutorial: RNA Polymerase II Chimera EM Map Tutorial: RNA Polymerase II May 1, 2007 This tutorial focuses on display of volume data from single particle EM reconstructions. We'll look at maps of two conformations of human RNA polymerase

More information

Benchmarking and Extension of Protein3DFit. Nasir Mahmood

Benchmarking and Extension of Protein3DFit. Nasir Mahmood Benchmarking and Extension of Protein3DFit Nasir Mahmood Benchmarking and Extension of Protein3DFit o Introduction o Why Align Structures? o Structure Alignment: Issues & problem o Method o Algorithm o

More information

Predicting RNA Secondary Structures By Folding Simulation: Software and Experiments

Predicting RNA Secondary Structures By Folding Simulation: Software and Experiments Utah State University DigitalCommons@USU All Graduate Theses and Dissertations Graduate Studies 5-2009 Predicting RNA Secondary Structures By Folding Simulation: Software and Experiments Joel Omni Gillespie

More information

Dynamic Programming User Manual v1.0 Anton E. Weisstein, Truman State University Aug. 19, 2014

Dynamic Programming User Manual v1.0 Anton E. Weisstein, Truman State University Aug. 19, 2014 Dynamic Programming User Manual v1.0 Anton E. Weisstein, Truman State University Aug. 19, 2014 Dynamic programming is a group of mathematical methods used to sequentially split a complicated problem into

More information

Rsubread package: high-performance read alignment, quantification and mutation discovery

Rsubread package: high-performance read alignment, quantification and mutation discovery Rsubread package: high-performance read alignment, quantification and mutation discovery Wei Shi 14 September 2015 1 Introduction This vignette provides a brief description to the Rsubread package. For

More information

Contrast adjustment via Bayesian sequential partitioning

Contrast adjustment via Bayesian sequential partitioning Contrast adjustment via Bayesian sequential partitioning Zhiyu Wang, Shuo Xie, Bai Jiang Abstract Photographs taken in dim light have low color contrast. However, traditional methods for adjusting contrast

More information

Tiling Assembly for Annotation-independent Novel Gene Discovery

Tiling Assembly for Annotation-independent Novel Gene Discovery Tiling Assembly for Annotation-independent Novel Gene Discovery By Jennifer Lopez and Kenneth Watanabe Last edited on September 7, 2015 by Kenneth Watanabe The following procedure explains how to run the

More information

Package gquad. June 7, 2017

Package gquad. June 7, 2017 Type Package Package gquad June 7, 2017 Title Prediction of G Quadruplees and Other Non-B DNA Motifs Version 2.1-1 Date 2017-06-06 Author Maintainer Genomic biology is not limited to

More information

Small Libraries of Protein Fragments through Clustering

Small Libraries of Protein Fragments through Clustering Small Libraries of Protein Fragments through Clustering Varun Ganapathi Department of Computer Science Stanford University June 8, 2005 Abstract When trying to extract information from the information

More information

Graph-Theoretic Approach to RNA Modeling Using Comparative Data

Graph-Theoretic Approach to RNA Modeling Using Comparative Data From: ISMB-95 Proceedings. Copyright 1995, AAAI (www.aaai.org). All rights reserved. Graph-Theoretic Approach to RNA Modeling Using Comparative Data Robert B. Cary and Gary D. Stormo Dept. of Molecular,

More information

Solving Traveling Salesman Problems Using Molecular Programming

Solving Traveling Salesman Problems Using Molecular Programming Solving Traveling Salesman Problems Using Molecular Programming Soo-Yong Shin Artificial Intelligence Lab (SCAI) Dept. of Computer Engineering Seoul National University Seoul 151-742, Korea. syshin@scai.snu.ac.kr

More information