Using graphs to relate expression data and protein-protein interaction data

Size: px
Start display at page:

Download "Using graphs to relate expression data and protein-protein interaction data"

Transcription

1 Using graphs to relate expression data and protein-protein interaction data R. Gentleman and D. Scholtens October 31, 2017 Introduction In Ge et al. (2001) the authors consider an interesting question. They assemble gene expression data from a yeast cell-cycle experiment (Cho et al., 1998), literature proteinprotein interaction (PPI) data and yeast two-hybrid data. We have curated the data slightly to make it simpler to carry out the analyses reported in Ge et al. (2001). In particular we reduced the data to the 2885 genes that were common to all experiments. We have also represented most of the data in terms of graphs (nodes and edges) since that is the form we will use for most of our analyses. The results reported in this document are based on version of the yeastexpdata data package. 0.1 Graphs The cell-cycle data is stored in ccyclered and from this it is easy to create a clustergraph. A cluster graph is simply a graph that is created from clustered data. In this graph all genes in the same cluster have edges between them and there are no between cluster edges. clusts = split(ccyclered[["y.name"]], + ccyclered[["cluster"]]) cg1 = new("clustergraph", + clusters = lapply(clusts, as.character)) ccclust = conncomp(cg1) Next we are interested in looking for associations between the clusters in this graph (genes that show similar patterns of expression) and the literature curated set of proteinprotein interactions. 1

2 We note that these are not really literature purported protein complexes (readers might want to use the output of a procedure like that in apcomplex applied to TAP data to explore protein complex data). We also note that the data used to create these graphs is already somewhat out of date and that there is new data available from MIPS. We have chosen to continue with these data since they align closely with the report in Ge et al. (2001). data(litg) cclit = connectedcomp(litg) cclens = sapply(cclit, length) table(cclens) cclens ccl2 = cclit[cclens1] ccl2 = cclens[cclens1] We see that there are most of the proteins do not have edges to others and that there are a few, rather large sets of connected proteins. We can plot a few of those. sg1 = subgraph(ccl2[[5]], litg) sg2 = subgraph(ccl2[[1]], litg) It is worth noting that the structure in Figures 1 and 2 is suggestive of collections of proteins that form cohesive subgroups that work to achieve particular objectives. An open problem is the development of algorithms (and ultimately software and statistical models) capable of reliably identifying the constituent components. Among the important aspects of such a decomposition is the notion that some proteins will be involved in multiple complexes. 1 Testing Associations The hypothesis presented in? was to investigate a potential correlation between expression clusters and interaction clusters. The devised a strategy called the transcriptomeinteractome correlation mapping strategy to assess the level of dependence. Here we reformulate their ideas (a more extensive discussion with some extensions is provided in Balasubraminian et al. (2004)). 2

3 YDR382W YER009W YFL039C YLR229C YLR340W YDL127W YER111C YGR109C YGR152C YJL187C YKL042W YKL101W YLR212C YLR313C YMR199W YNL289W YPL256C YPR120C YOR160W YDR388W YJL157C YOR036W YPL031C YCL027W YLL024C YOR027W YOR185C YPL240C YMR294W YNL004W YNL243W YOL039W YOR098C YAL040C YBR200W YGR108W YPL242C YPR119W YCL040W YAL005C YLR216C YBR133C YER114C YDL179W YHR005C YJL194W YLR079W YLR319C YMR109W YDR432W YDR356W YEL003W YHR061C YHR172W YLL021W YNL126W YPL016W YDR085C YHR102W YOL016C YBR160W YMR308C YHL007C YKL068W YAL029C YBR109C YGL016W YLR293C YML065W YLR200W YML094W YMR092C YMR186W YDR309C YHR129C YAL041W YBL016W YBL079W YOR127W YPL174C YDR103W YDR323C YDR184C YHR069C YOL021C YOR181W YBR155W YPL140C Figure 1: One of the larger PPI graphs 3

4 YOL139C YDR180W YGR162W YDR386W YDL043C YMR117C YDR485C YML104C YMR106C YDL030W YDL013W YMR284W YDL042C YNL031C YDR227W YOR191W YNL030W YBR009C YLR134W YBR010W YIL144W YER179W YDL008W YNL172W YDR146C YBR073W YLR127C YDR118W YBL084C YER095W YDR004W YML032C YDR076W YAR007C YJL173C YNL312W Figure 2: Another of the larger PPI connected components. 4

5 The basic idea is to represent the different sets of interactions (relationships) in terms of graphs. Each graph is defined on the same set of nodes (the genes/proteins that are common to all experiments) and the specific set of relationships are represented as edges in the appropriate graph. Above we created one graph where the edges represent known (literature based) interactions, litg and the second is based on clustered gene expression data, cg1. We can now determine how many edges are in common between the two graphs by simply computing their intersection. commong = intersection(litg, cg1) commong A graphnel graph with undirected edges Number of Nodes = 2885 Number of Edges = 42 And we can see that there are 42 edges in common. Since the literature graph has 315 and the gene expression graph has we might wonder whether 42 is remarkably large or remarkably small. One way to test this assumption is to generate an appropriate null distribution and to compare the observed value (42) to the values from this distribution. While there are some reasons to consider a random edge model (as proposed by Erdos and Renyi) there are more compelling reasons to condition on the structure in the graph and to use a node label permutation distribution. This is demonstrated below. Note that this does take quite some time to run though. eperm = function (g1, g2, B=500) { + ans = rep(na, B) + n1 = nodes(g1) + + for(i in 1:B) { + nodes(g1) = sample(n1) + ans[i] = numedges(intersection(g1, g2)) + } + return(ans) + } set.seed(123) ##takes a long time #npdist = eperm(litg, cg1) data(npdist) max(npdist) [1] 23 5

6 2 Data Analysis Now that we have satisfied our testing curiosity we might want to start to carry out a little exploratory data analysis. There are clearly some questions that are of interest. They include the following: ˆ Which of the expression clusters have intersections and with which of the literature clusters? ˆ Are there expression clusters that have a number of literature cluster edges going between them (and hence suggesting that the expression clustering was too fine, or that the genes involved in the literature cluster are not cell-cycle regulated). ˆ Are there known cell-cycle regulated protein complexes and do the genes involved tend to cluster together? ˆ Is the expression behavior of genes that are involved in multiple literature clusters (or at least that we suspect of being so involved) different from that of genes that are involved in only one cluster? Many of these questions require access to more information. For example, we need to know more about the pattern of expression related to each of the gene expression clusters so that we can try to interpret them better. We need to have more information about the likely protein complexes from the literature data so that we can better identify reasonably complete protein complexes (and given them, then identify those genes that are involved in more than one complex). But, the most important fact to notice is that all of the substantial calculations and computations (given the meta-data) are very simple to put in graph theoretic terms. References R. Balasubraminian, T. LaFramboise, D. Scholtens, and R. Gentleman. Integrating disparate sources of protein protein interaction data. Technical report, Bioconductor, R.C. Cho et al. A genome-wide transcriptional analysis of the mitotic cell cycle. Mol. Cell, 2:65 73, H. Ge, Z. Liu, G. M. Church, and M. Vidal. Correlation between transcriptome and interactome mapping data from saccharomyces cerevisiae. Nature Genetics, 29: ,

Hotspots and Causal Inference For Yeast Data

Hotspots and Causal Inference For Yeast Data Hotspots and Causal Inference For Yeast Data Elias Chaibub Neto and Brian S Yandell October 24, 2012 Here we reproduce the analysis of the budding yeast genetical genomics data-set presented in Chaibub

More information

From protein networks to biological systems

From protein networks to biological systems FEBS 29314 FEBS Letters 579 (2005) 1821 1827 Minireview From protein networks to biological systems Peter Uetz a,1, Russell L. Finley Jr. b, * a Research Center Karlsruhe, Institute of Genetics, P.O. Box

More information

CELL CYCLE RESPONSE STRESS AVGPCC. YER179W DMC1 meiosis-specific protein unclear

CELL CYCLE RESPONSE STRESS AVGPCC. YER179W DMC1 meiosis-specific protein unclear ORFNAME LOCUS DESCRIPTION DATE HUBS: ESSENTIAL k AVGPCC STRESS RESPONSE CELL CYCLE PHEROMONE TREATMENT UNFOLDED PROTEIN RESPONSE YER179W DMC1 meiosis-specific protein 9-0.132-0.228-0.003-0.05 0.138 0.00

More information

Causal Model Selection Hypothesis Tests in Systems Genetics: a tutorial

Causal Model Selection Hypothesis Tests in Systems Genetics: a tutorial Causal Model Selection Hypothesis Tests in Systems Genetics: a tutorial Elias Chaibub Neto and Brian S Yandell July 2, 2012 1 Motivation Current efforts in systems genetics have focused on the development

More information

A Re-annotation of the Saccharomyces cerevisiae Genome

A Re-annotation of the Saccharomyces cerevisiae Genome Comparative and Functional Genomics Comp Funct Genom 2001; 2: 143 154. DOI: 10.1002 / cfg.86 Research Article A Re-annotation of the Saccharomyces cerevisiae Genome V. Wood*, K. M. Rutherford, A Ivens,

More information

GENETICS. Supporting Information

GENETICS. Supporting Information GENETICS Supporting Information http://www.genetics.org/cgi/content/full/genetics.110.117655/dc1 Trivalent Arsenic Inhibits the Functions of Chaperonin Complex XuewenPan,StefanieReissman,NickR.Douglas,ZhiweiHuang,DanielS.Yuan,

More information

Alterations in DNA Replication and Histone Levels Promote Histone Gene Amplification in Saccharomyces cerevisiae

Alterations in DNA Replication and Histone Levels Promote Histone Gene Amplification in Saccharomyces cerevisiae Supporting Information http://www.genetics.org/cgi/content/full/genetics.109.113662/dc1 Alterations in DNA Replication and Histone Levels Promote Histone Gene Amplification in Saccharomyces cerevisiae

More information

The Repetitive Sequence Database and Mining Putative Regulatory Elements in Gene Promoter Regions ABSTRACT

The Repetitive Sequence Database and Mining Putative Regulatory Elements in Gene Promoter Regions ABSTRACT JOURNAL OF COMPUTATIONAL BIOLOGY Volume 9, Number 4, 2002 Mary Ann Liebert, Inc. Pp. 621 640 The Repetitive Sequence Database and Mining Putative Regulatory Elements in Gene Promoter Regions JORNG-TZONG

More information

Signal recognition YKL122c An01g02800 strong similarity to signal recognition particle 68K protein SRP68 - Canis lupus

Signal recognition YKL122c An01g02800 strong similarity to signal recognition particle 68K protein SRP68 - Canis lupus Supplementary Table 16 Components of the secretory pathway Aspergillus niger A.niger orf A.niger gene Entry into ER Description of putative Aspergillus niger gene Best homolog to putative A.niger gene

More information

Phylogenetic classification of transporters and other membrane proteins from Saccharomyces cerevisiae

Phylogenetic classification of transporters and other membrane proteins from Saccharomyces cerevisiae Funct Integr Genomics (2002) 2:154 170 DOI 10.1007/s10142-002-0060-8 REVIEW Benoît De Hertogh Elvira Carvajal Emmanuel Talla Bernard Dujon Philippe Baret André Goffeau Phylogenetic classification of transporters

More information

Modeling and Visualizing Uncertainty in Gene Expression Clusters using Dirichlet Process Mixtures

Modeling and Visualizing Uncertainty in Gene Expression Clusters using Dirichlet Process Mixtures JOURNAL OF LATEX CLASS FILES, VOL. 1, NO. 8, AUGUST 2002 1 Modeling and Visualizing Uncertainty in Gene Expression Clusters using Dirichlet Process Mixtures Carl Edward Rasmussen, Bernard J de la Cruz,

More information

DISCOVERING PROTEIN COMPLEXES IN DENSE RELIABLE NEIGHBORHOODS OF PROTEIN INTERACTION NETWORKS

DISCOVERING PROTEIN COMPLEXES IN DENSE RELIABLE NEIGHBORHOODS OF PROTEIN INTERACTION NETWORKS 1 DISCOVERING PROTEIN COMPLEXES IN DENSE RELIABLE NEIGHBORHOODS OF PROTEIN INTERACTION NETWORKS Xiao-Li Li Knowledge Discovery Department, Institute for Infocomm Research, Heng Mui Keng Terrace, 119613,

More information

Ascospore Formation in the Yeast Saccharomyces cerevisiae

Ascospore Formation in the Yeast Saccharomyces cerevisiae MICROBIOLOGY AND MOLECULAR BIOLOGY REVIEWS, Dec. 2005, p. 565 584 Vol. 69, No. 4 1092-2172/05/$08.00 0 doi:10.1128/mmbr.69.4.565 584.2005 Copyright 2005, American Society for Microbiology. All Rights Reserved.

More information

Linking the Signaling Cascades and Dynamic Regulatory Networks Controlling Stress Responses

Linking the Signaling Cascades and Dynamic Regulatory Networks Controlling Stress Responses Linking the Signaling Cascades and Dynamic Regulatory Networks Controlling Stress Responses Anthony Gitter, Miri Carmi, Naama Barkai, and Ziv Bar-Joseph Supplementary Information Supplementary Results

More information

Systems biology and biological networks

Systems biology and biological networks Systems Biology Workshop Systems biology and biological networks Center for Biological Sequence Analysis Networks in electronics Radio kindly provided by Lazebnik, Cancer Cell, 2002 Systems Biology Workshop,

More information

Finding molecular complexes through multiple layer clustering of protein interaction networks. Bill Andreopoulos* and Aijun An

Finding molecular complexes through multiple layer clustering of protein interaction networks. Bill Andreopoulos* and Aijun An Int. J. Bioinformatics Research and Applications, Vol. x, No. x, xxxx 1 Finding molecular complexes through multiple layer clustering of protein interaction networks Bill Andreopoulos* and Aijun An Department

More information

Comparative Methods for the Analysis of Gene-Expression Evolution: An Example Using Yeast Functional Genomic Data

Comparative Methods for the Analysis of Gene-Expression Evolution: An Example Using Yeast Functional Genomic Data Comparative Methods for the Analysis of Gene-Expression Evolution: An Example Using Yeast Functional Genomic Data Todd H. Oakley,* 1 Zhenglong Gu,* Ehab Abouheif, 3 Nipam H. Patel, 2 and Wen-Hsiung Li*

More information

Introduction to Microarray Data Analysis and Gene Networks lecture 8. Alvis Brazma European Bioinformatics Institute

Introduction to Microarray Data Analysis and Gene Networks lecture 8. Alvis Brazma European Bioinformatics Institute Introduction to Microarray Data Analysis and Gene Networks lecture 8 Alvis Brazma European Bioinformatics Institute Lecture 8 Gene networks part 2 Network topology (part 2) Network logics Network dynamics

More information

Causal Graphical Models in Systems Genetics

Causal Graphical Models in Systems Genetics 1 Causal Graphical Models in Systems Genetics 2013 Network Analysis Short Course - UCLA Human Genetics Elias Chaibub Neto and Brian S Yandell July 17, 2013 Motivation and basic concepts 2 3 Motivation

More information

Adaptation of Saccharomyces cerevisiae to high hydrostatic pressure causing growth inhibition

Adaptation of Saccharomyces cerevisiae to high hydrostatic pressure causing growth inhibition FEBS 29557 FEBS Letters 579 (2005) 2847 2852 Adaptation of Saccharomyces cerevisiae to high hydrostatic pressure causing growth inhibition Hitoshi Iwahashi a, *, Mine Odani b, Emi Ishidou a, Emiko Kitagawa

More information

Detecting temporal protein complexes from dynamic protein-protein interaction networks

Detecting temporal protein complexes from dynamic protein-protein interaction networks Detecting temporal protein complexes from dynamic protein-protein interaction networks Le Ou-Yang, Dao-Qing Dai, Xiao-Li Li, Min Wu, Xiao-Fei Zhang and Peng Yang 1 Supplementary Table Table S1: Comparative

More information

Analysis and visualization of protein-protein interactions. Olga Vitek Assistant Professor Statistics and Computer Science

Analysis and visualization of protein-protein interactions. Olga Vitek Assistant Professor Statistics and Computer Science 1 Analysis and visualization of protein-protein interactions Olga Vitek Assistant Professor Statistics and Computer Science 2 Outline 1. Protein-protein interactions 2. Using graph structures to study

More information

Robust Sparse Estimation of Multiresponse Regression and Inverse Covariance Matrix via the L2 distance

Robust Sparse Estimation of Multiresponse Regression and Inverse Covariance Matrix via the L2 distance Robust Sparse Estimatio of Multirespose Regressio ad Iverse Covariace Matrix via the L2 distace Aurélie C. Lozao IBM Watso Research Ceter Yorktow Heights, New York aclozao@us.ibm.com Huijig Jiag IBM Watso

More information

Table S1, Yvert et al.

Table S1, Yvert et al. Table S1, Yvert et al. List of 593 clusters of genes showing correlated expression in the cross. For each gene, 90 expression values (BY: 2 independent cultures, RM: 2 independent cultures, 86 segregants:

More information

Genome-wide expression screens indicate a global role for protein kinase CK2 in chromatin remodeling

Genome-wide expression screens indicate a global role for protein kinase CK2 in chromatin remodeling JCS epress online publication date 4 March 2003 Research Article 1563 Genome-wide expression screens indicate a global role for protein kinase CK2 in chromatin remodeling Thomas Barz, Karin Ackermann,

More information

networks? networks are spaces generated by interaction

networks? networks are spaces generated by interaction networks? networks are spaces generated by interaction DNA damage response and repair DNA metabolism DNA recombination DNA replication RNA localization and processing autophagy budding carbohydrate metabolism

More information

Defining the Budding Yeast Chromatin Associated Interactome

Defining the Budding Yeast Chromatin Associated Interactome Supplementary Data Defining the Budding Yeast Chromatin Associated Interactome Jean-Philippe Lambert 1, Jeffrey Fillingham 2,3, Mojgan Siahbazi 1, Jack Greenblatt 3, Kristin Baetz 1, Daniel Figeys 1 1

More information

Supplemental Table S2. List of 166 Transcription Factors Deleted in Mutants Assayed in this Study ORF Gene Description

Supplemental Table S2. List of 166 Transcription Factors Deleted in Mutants Assayed in this Study ORF Gene Description Supplemental Table S2. List of 166 Transcription Factors Deleted in Mutants Assayed in this Study ORF Gene Description YER045C ACA1* a Basic leucine zipper (bzip) transcription factor of the ATF/CREB family,

More information

Research Article Predicting Protein Complexes in Weighted Dynamic PPI Networks Based on ICSC

Research Article Predicting Protein Complexes in Weighted Dynamic PPI Networks Based on ICSC Hindawi Complexity Volume 2017, Article ID 4120506, 11 pages https://doi.org/10.1155/2017/4120506 Research Article Predicting Protein Complexes in Weighted Dynamic PPI Networks Based on ICSC Jie Zhao,

More information

Yeast require an Intact Tryptophan Biosynthesis Pathway and Exogenous Tryptophan for Resistance to Sodium Dodecyl Sulfate

Yeast require an Intact Tryptophan Biosynthesis Pathway and Exogenous Tryptophan for Resistance to Sodium Dodecyl Sulfate Yeast require an Intact Tryptophan Biosynthesis Pathway and Exogenous Tryptophan for Resistance to Sodium Dodecyl Sulfate Laura M. Ammons 1,2, Logan R. Bingham 1,2, Sarah Callery 1,2, Elizabeth Corley

More information

Screening the yeast deletant mutant collection for hypersensitivity and hyper-resistance to sorbate, a weak organic acid food preservative

Screening the yeast deletant mutant collection for hypersensitivity and hyper-resistance to sorbate, a weak organic acid food preservative Yeast Yeast 2004; 21: 927 946. Published online in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/yea.1141 Yeast Functional Analysis Report Screening the yeast deletant mutant collection

More information

Genome-wide protein interaction screens reveal functional networks involving Sm-like proteins

Genome-wide protein interaction screens reveal functional networks involving Sm-like proteins Yeast Yeast 2000; 17: 95±110. Research Article Genome-wide protein interaction screens reveal functional networks involving Sm-like proteins Micheline Fromont-Racine 1{, Andrew E. Mayes 2{, Adeline Brunet-Simon

More information

Using Networks to Integrate Omic and Semantic Data: Towards Understanding Protein Function on a Genome Scale

Using Networks to Integrate Omic and Semantic Data: Towards Understanding Protein Function on a Genome Scale Using Networks to Integrate Omic and Semantic Data: Towards Understanding Protein Function on a Genome Scale Biomarker Data Analysis.10.01, 9:25-9:50 Mark B Gerstein Yale (Comp. Bio. & Bioinformatics)

More information

Combining Microarrays and Biological Knowledge for Estimating Gene Networks via Bayesian Networks

Combining Microarrays and Biological Knowledge for Estimating Gene Networks via Bayesian Networks Combining Microarrays and Biological Knowledge for Estimating Gene Networks via Bayesian Networks Seiya Imoto 1, Tomoyuki Higuchi 2, Takao Goto 1, Kousuke Tashiro 3, Satoru Kuhara 3 and Satoru Miyano 1

More information

Case story: Analysis of the Cell Cycle

Case story: Analysis of the Cell Cycle DNA microarray analysis, January 2 nd 2006 Case story: Analysis of the Cell Cycle Center for Biological Sequence Analysis Outline Introduction Cell division and cell cycle regulation Experimental studies

More information

Intersection of RNA Processing and Fatty Acid Synthesis and Attachment in Yeast Mitochondria

Intersection of RNA Processing and Fatty Acid Synthesis and Attachment in Yeast Mitochondria Intersection of RNA Processing and Fatty Acid Synthesis and Attachment in Yeast Mitochondria Item Type text; Electronic Dissertation Authors Schonauer, Melissa Publisher The University of Arizona. Rights

More information

Compositional Correlation for Detecting Real Associations. Among Time Series

Compositional Correlation for Detecting Real Associations. Among Time Series Compositional Correlation for Detecting Real Associations Among Time Series Fatih DIKBAS Civil Engineering Department, Pamukkale University, Turkey Correlation remains to be one of the most widely used

More information

Clustering gene expression data using graph separators

Clustering gene expression data using graph separators 1 Clustering gene expression data using graph separators Bangaly Kaba 1, Nicolas Pinet 1, Gaëlle Lelandais 2, Alain Sigayret 1, Anne Berry 1. LIMOS/RR-07-02 13/02/2007 - révisé le 11/05/2007 1 LIMOS, UMR

More information

Supplementary Information

Supplementary Information Supplementary Information For the article "The organization of transcriptional activity in the yeast, S. cerevisiae" by I. J. Farkas, H. Jeong, T. Vicsek, A.-L. Barabási, and Z. N. Oltvai For the Referees

More information

(Fold Change) acetate biosynthesis ALD6 acetaldehyde dehydrogenase 3.0 acetyl-coa biosynthesis ACS2 acetyl-coa synthetase 2.5

(Fold Change) acetate biosynthesis ALD6 acetaldehyde dehydrogenase 3.0 acetyl-coa biosynthesis ACS2 acetyl-coa synthetase 2.5 Supplementary Table 1 Overexpression strains that showed resistance or hypersensitivity to rapamycin. Strains that were more than two-fold enriched on average (and at least 1.8-fold enriched in both experiment

More information

Honors Thesis: Supplementary Material. LCC 4700: Undergraduate Thesis Writing

Honors Thesis: Supplementary Material. LCC 4700: Undergraduate Thesis Writing Honors Thesis: Supplementary Material LCC 4700: Undergraduate Thesis Writing The Evolutionary Impact of Functional RNA Secondary Structures within Protein- Coding Regions in Yeast Charles Warden Advisor:

More information

Hierarchical modelling of automated imaging data

Hierarchical modelling of automated imaging data Darren Wilkinson http://tinyurl.com/darrenjw School of Mathematics & Statistics, Newcastle University, UK Theory of Big Data 2 UCL, London 6th 8th January, 2016 Overview Background: Budding yeast as a

More information

Large-scale phenotypic analysis reveals identical contributions to cell functions of known and unknown yeast genes

Large-scale phenotypic analysis reveals identical contributions to cell functions of known and unknown yeast genes Yeast Yeast 2001; 18: 1397 1412. DOI: 10.1002 /yea.784 Yeast Functional Analysis Report Large-scale phenotypic analysis reveals identical contributions to cell functions of known and unknown yeast genes

More information

The yeast interactome (unit: g303204)

The yeast interactome (unit: g303204) The yeast interactome (unit: g303204) Peter Uetz 1 & Andrei Grigoriev 2 1 Institute of Genetics (ITG), Forschungszentrum Karlsruhe, Karlsruhe, Germany 2 GPC Biotech, Martinsried, Germany Addresses 1 Institute

More information

Constraint-Based Workshops

Constraint-Based Workshops Constraint-Based Workshops 2. Reconstruction Databases November 29 th, 2007 Defining Metabolic Reactions ydbh hslj ldha 1st level: Primary metabolites LAC 2nd level: Neutral Formulas C 3 H 6 O 3 Charged

More information

Spatio-temporal dynamics of yeast mitochondrial biogenesis: transcriptional and post-transcriptional. mrna oscillatory modules.

Spatio-temporal dynamics of yeast mitochondrial biogenesis: transcriptional and post-transcriptional. mrna oscillatory modules. Spatio-temporal dynamics of yeast mitochondrial biogenesis: transcriptional and post-transcriptional mrna oscillatory modules. Gaëlle Lelandais, Yann Saint-Georges, Colette Geneix, Liza Al-Shikhley, Geneviève

More information

How many protein-coding genes are there in the Saccharomyces cerevisiae genome?

How many protein-coding genes are there in the Saccharomyces cerevisiae genome? Yeast Yeast 2002; 19: 619 629. Published online in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002 / yea.865 Research Article How many protein-coding genes are there in the Saccharomyces

More information

Bacterial genome chimaerism and the origin of mitochondria

Bacterial genome chimaerism and the origin of mitochondria 49 Bacterial genome chimaerism and the origin of mitochondria Ankur Abhishek, Anish Bavishi, Ashay Bavishi, and Madhusudan Choudhary Abstract: Many studies have sought to determine the origin and evolution

More information

Bayesian inference for stochastic kinetic models. intracellular reaction networks

Bayesian inference for stochastic kinetic models. intracellular reaction networks for stochastic models of intracellular reaction networks Darren Wilkinson School of Mathematics & Statistics and Centre for Integrated Systems Biology of Ageing and Nutrition Newcastle University, UK IMA

More information

Genetic basis of mitochondrial function and morphology in Saccharomyces. Kai Stefan Dimmer, Stefan Fritz, Florian Fuchs, Marlies Messerschmitt, Nadja

Genetic basis of mitochondrial function and morphology in Saccharomyces. Kai Stefan Dimmer, Stefan Fritz, Florian Fuchs, Marlies Messerschmitt, Nadja MBC in Press, published on February 4, 2002 as 10.1091/mbc.01-12-0588 Genetic basis of mitochondrial function and morphology in Saccharomyces cerevisiae Kai Stefan Dimmer, Stefan Fritz, Florian Fuchs,

More information

Received 17 January 2005/Accepted 22 February 2005

Received 17 January 2005/Accepted 22 February 2005 EUKARYOTIC CELL, May 2005, p. 849 860 Vol. 4, No. 5 1535-9778/05/$08.00 0 doi:10.1128/ec.4.5.849 860.2005 Copyright 2005, American Society for Microbiology. All Rights Reserved. A Two-Hybrid Screen of

More information

Cytoscape An open-source software platform for the exploration of molecular interaction networks

Cytoscape An open-source software platform for the exploration of molecular interaction networks Cytoscape An open-source software platform for the exploration of molecular interaction networks Systems Biology Group UP Biologie Systémique Institut Pasteur, Paris Overview 1. Molecular interaction networks

More information

Localizing proteins in the cell from their phylogenetic profiles

Localizing proteins in the cell from their phylogenetic profiles Localizing proteins in the cell from their phylogenetic profiles Edward M. Marcotte*, Ioannis Xenarios*, Alexander M. van der Bliek*, and David Eisenberg* *Molecular Biology Institute, University of California

More information

ppendix E - Growth Rates of Individual Genes on Various Non-Fementable Carbon So ORF Gene Lactate Glycerol EtOH Description

ppendix E - Growth Rates of Individual Genes on Various Non-Fementable Carbon So ORF Gene Lactate Glycerol EtOH Description ppendix E - Growth Rates of Individual Genes on Various Non-Fementable Carbon So ORF Gene Lactate Glycerol EtOH Description YAL1C MDM1 2 2 Mitochondrial outer membrane protein involved in mitochondrial

More information

Mg 2 Deprivation Elicits Rapid Ca 2 Uptake and Activates Ca 2 /Calcineurin Signaling in Saccharomyces cerevisiae

Mg 2 Deprivation Elicits Rapid Ca 2 Uptake and Activates Ca 2 /Calcineurin Signaling in Saccharomyces cerevisiae EUKARYOTIC CELL, Apr. 2007, p. 592 599 Vol. 6, No. 4 1535-9778/07/$08.00 0 doi:10.1128/ec.00382-06 Copyright 2007, American Society for Microbiology. All Rights Reserved. Mg 2 Deprivation Elicits Rapid

More information

Growth of Yeast, Saccharomyces cerevisiae, under Hypergravity Conditions

Growth of Yeast, Saccharomyces cerevisiae, under Hypergravity Conditions Syracuse University SURFACE Syracuse University Honors Program Capstone Projects Syracuse University Honors Program Capstone Projects Spring 5-1-2011 Growth of Yeast, Saccharomyces cerevisiae, under Hypergravity

More information

UvA-DARE (Digital Academic Repository)

UvA-DARE (Digital Academic Repository) UvA-DARE (Digital Academic Repository) In silicio identification of glycosyl-phosphatidylinositol-anchored plasma-membrane and cell wall proteins of Saccharomyces cerevisiae Caro, L.H.P.; Tettelin, H.;

More information

ACCEPTED. Title: Increased respiration in the sch9 mutant is required for increasing chronological life span but not replicative life span

ACCEPTED. Title: Increased respiration in the sch9 mutant is required for increasing chronological life span but not replicative life span EC Accepts, published online ahead of print on 9 May 2008 Eukaryotic Cell doi:10.1128/ec.00330-07 Copyright 2008, American Society for Microbiology and/or the Listed Authors/Institutions. All Rights Reserved.

More information

Identifying Correlations between Chromosomal Proximity of Genes and Distance of Their Products in Protein-Protein Interaction Networks of Yeast

Identifying Correlations between Chromosomal Proximity of Genes and Distance of Their Products in Protein-Protein Interaction Networks of Yeast Identifying Correlations between Chromosomal Proximity of Genes and Distance of Their Products in Protein-Protein Interaction Networks of Yeast Daniele Santoni 1 *, Filippo Castiglione 2, Paola Paci 1

More information

DNA microarrays simultaneously monitor the expression

DNA microarrays simultaneously monitor the expression Transitive functional annotation by shortest-path analysis of gene expression data Xianghong Zhou*, Ming-Chih J. Kao*, and Wing Hung Wong* *Department of Biostatistics, Harvard School of Public Health,

More information

Origin and Consequences of the Relationship between Protein Mean and Variance

Origin and Consequences of the Relationship between Protein Mean and Variance Origin and Consequences of the Relationship between Protein Mean and Variance Francesco Luigi Massimo Vallania 1,2 *, Marc Sherman 1,3, Zane Goodwin 1,2, Ilaria Mogno 1, Barak Alon Cohen 1, Robi David

More information

MRP4 MRPS5. function. Their functional link can be checked by double or triple deletion experiments. YDR036C

MRP4 MRPS5. function. Their functional link can be checked by double or triple deletion experiments. YDR036C Table 5. The list of 202 derived functional modules MRP4 and MRPS5 are structural constituents of mitochondrial small ribosomal subunit involved in protein biosynthesis. Therefore, yet unannotated YDR036C

More information

Protein complexes identification based on go attributed network embedding

Protein complexes identification based on go attributed network embedding Xu et al. BMC Bioinformatics (2018) 19:535 https://doi.org/10.1186/s12859-018-2555-x RESEARCH ARTICLE Protein complexes identification based on go attributed network embedding Bo Xu 1,2*,KunLi 1, Wei Zheng

More information

MINIREVIEW. Eric M. Rubenstein and Martin C. Schmidt*

MINIREVIEW. Eric M. Rubenstein and Martin C. Schmidt* EUKARYOTIC CELL, Apr. 2007, p. 571 583 Vol. 6, No. 4 1535-9778/07/$08.00 0 doi:10.1128/ec.00026-07 Copyright 2007, American Society for Microbiology. All Rights Reserved. MINIREVIEW Mechanisms Regulating

More information

FUNPRED-1: PROTEIN FUNCTION PREDICTION FROM A PROTEIN INTERACTION NETWORK USING NEIGHBORHOOD ANALYSIS

FUNPRED-1: PROTEIN FUNCTION PREDICTION FROM A PROTEIN INTERACTION NETWORK USING NEIGHBORHOOD ANALYSIS CELLULAR & MOLECULAR BIOLOGY LETTERS http://www.cmbl.org.pl Received: 25 July 2014 Volume 19 (2014) pp 675-691 Final form accepted: 20 November 2014 DOI: 10.2478/s11658-014-0221-5 Published online: 25

More information

BIOINFORMATICS. Predicting protein function from protein/protein interaction data: a probabilistic approach. Stanley Letovsky and Simon Kasif

BIOINFORMATICS. Predicting protein function from protein/protein interaction data: a probabilistic approach. Stanley Letovsky and Simon Kasif BIOINFORMATICS Vol. 19 Suppl. 1 2003, pages i197 i204 DOI: 10.1093/bioinormatics/btg1026 Predicting protein unction rom protein/protein interaction data: a probabilistic approach Stanley Letovsky and Simon

More information

The Yeast Nuclear Pore Complex: Composition, Architecture, and Transport Mechanism

The Yeast Nuclear Pore Complex: Composition, Architecture, and Transport Mechanism The Yeast Nuclear Pore Complex: Composition, Architecture, and Transport Mechanism Michael P. Rout,* John D. Aitchison, Adisetyantari Suprapto,* Kelly Hjertaas, Yingming Zhao,* and Brian T. Chait* *The

More information

A network of protein protein interactions in yeast

A network of protein protein interactions in yeast A network of protein protein interactions in yeast Benno Schwikowski 1,2 *, Peter Uetz 3, and Stanley Fields 3,4 1 The Institute for Systems Biology, 4225 Roosevelt Way NE, Suite 200, Seattle, WA 98105.

More information

Guilt by Association of Common Interaction Partners. Limsoon Wong Joint work with Hon Nian Chua & Wing-Kin Sung

Guilt by Association of Common Interaction Partners. Limsoon Wong Joint work with Hon Nian Chua & Wing-Kin Sung Gilt by Association of Common Interaction Partners Limsoon Wong Joint ork ith Hon ian Cha & Wing-Kin Sng Workshop on BioAlgorithms IMS Jly 006 Protein Fnction Prediction Approaches Seqence alignment (e.g.

More information

Analysis of Yeast s ORF Upstream Regions by Parallel Processing, Microarrays, and Computational Methods

Analysis of Yeast s ORF Upstream Regions by Parallel Processing, Microarrays, and Computational Methods Analysis of Yeast s ORF Upstream Regions by Parallel Processing, Microarrays, and Computational Methods Steven Hampson Dept. of Information and Computer Science University of California, Irvine Irvine,

More information

Exploiting Indirect Neighbours and Topological Weight to Predict Protein Function from Protein-Protein Interactions

Exploiting Indirect Neighbours and Topological Weight to Predict Protein Function from Protein-Protein Interactions Exploiting Indirect eighbors and Topological Weight to Predict Protein Fnction from Protein-Protein Interactions Limsoon Wong Joint ork ith Hon ian Cha & Wing-Kin Sng Keynote lectre for BioDM 006 Protein

More information

Dissection of transcriptional regulation networks and prediction of gene functions in Saccharomyces cerevisiae Boorsma, A.

Dissection of transcriptional regulation networks and prediction of gene functions in Saccharomyces cerevisiae Boorsma, A. UvA-DARE (Digital Academic Repository) Dissection of transcriptional regulation networks and prediction of gene functions in Saccharomyces cerevisiae Boorsma, A. Link to publication Citation for published

More information

Classification des séquences régulatrices sur base de motifs

Classification des séquences régulatrices sur base de motifs LIFL - 3 mars 2003 lassification des séquences régulatrices sur base de motifs Jacques van Helden Jacques.van.Helden@ulb.ac.be Regulatory Sequence Analysis Regulatory regions and regulatory elements Jacques

More information

Matrix-based pattern matching

Matrix-based pattern matching Regulatory sequence analysis Matrix-based pattern matching Jacques van Helden Jacques.van-Helden@univ-amu.fr Aix-Marseille Université, France Technological Advances for Genomics and Clinics (TAGC, INSERM

More information

Annotating gene function by combining expression data with a modular gene network

Annotating gene function by combining expression data with a modular gene network BIOINFORMATICS Vol. 23 ISMB/ECCB 2007, pages i468 i478 doi:10.1093/bioinformatics/btm173 Annotating gene function by combining expression data with a modular gene network Motoki Shiga, Ichigaku Takigawa

More information

Received 29 May 2006/Accepted 8 June 2006

Received 29 May 2006/Accepted 8 June 2006 EUKARYOTIC CELL, Aug. 2006, p. 1388 1398 Vol. 5, No. 8 1535-9778/06/$08.00 0 doi:10.1128/ec.00154-06 Copyright 2006, American Society for Microbiology. All Rights Reserved. Heterologous Expression Implicates

More information

EXTRACTING GLOBAL STRUCTURE FROM GENE EXPRESSION PROFILES

EXTRACTING GLOBAL STRUCTURE FROM GENE EXPRESSION PROFILES EXTRACTING GLOBAL STRUCTURE FROM GENE EXPRESSION PROFILES Charless Fowlkes 1, Qun Shan 2, Serge Belongie 3, and Jitendra Malik 1 Departments of Computer Science 1 and Molecular Cell Biology 2, University

More information

Percentage of genomic features annotated in the S. cerevisiae reference genome covered by different S. cerevisiae assemblies.

Percentage of genomic features annotated in the S. cerevisiae reference genome covered by different S. cerevisiae assemblies. Supplementary Figure 1 Percentage of genomic features annotated in the S. cerevisiae reference genome covered by different S. cerevisiae assemblies. Our PacBio assembly (strain S288C, underscored) shows

More information

Protein import into plant mitochondria: signals, machinery, processing, and regulation

Protein import into plant mitochondria: signals, machinery, processing, and regulation Journal of Experimental Botany, Vol. 65, No. 22 pp. 6301 6335, 2014 doi:10.1093/jxb/eru399 Advance Access publication 16 October, 2014 Darwin Review Protein import into plant mitochondria: signals, machinery,

More information

Combining Microarrays and Biological Knowledge for Estimating Gene Networks via Bayesian Networks

Combining Microarrays and Biological Knowledge for Estimating Gene Networks via Bayesian Networks Combiig Microarrays ad Biological Kowledge for Estimatig Gee Networks via Bayesia Networks Seiya Imoto 1, Tomoyuki Higuchi 2, Takao Goto 1, Kousuke Tashiro 3, Satoru Kuhara 3 ad Satoru Miyao 1 1 Huma Geome

More information

BMC 2002, Bioinformatics

BMC 2002, Bioinformatics BMC Bioinformatics BioMed Central BMC, Bioinformatics 3 Methodoloy article Correlatin overrepresented upstream motifs to ene expression: a computational approach to reulatory element discovery in eukaryotes

More information

Corrections. MEDICAL SCIENCES. For the article Inhibitors of soluble epoxide

Corrections. MEDICAL SCIENCES. For the article Inhibitors of soluble epoxide Corrections MEDICAL SCIENCES. For the article Inhibitors of soluble epoxide hydrolase attenuate vascular smooth muscle cell proliferation, by Benjamin B. Davis, David A. Thompson, Laura L. Howard, Christophe

More information

Updated catalogue of homologues to human disease-related proteins in the yeast genome

Updated catalogue of homologues to human disease-related proteins in the yeast genome FEBS 20044 FEBS Letters 426 (1998) 7^16 Genomics Updated catalogue of homologues to human disease-related proteins in the yeast genome Miguel A. Andrade 1;a, Chris Sander b, Alfonso Valencia a; * a Protein

More information

Computational Genomics. Reconstructing dynamic regulatory networks in multiple species

Computational Genomics. Reconstructing dynamic regulatory networks in multiple species 02-710 Computational Genomics Reconstructing dynamic regulatory networks in multiple species Methods for reconstructing networks in cells CRH1 SLT2 SLR3 YPS3 YPS1 Amit et al Science 2009 Pe er et al Recomb

More information

Mitochondrial inheritance and fermentative : oxidative balance in hybrids between Saccharomyces cerevisiae and Saccharomyces uvarum

Mitochondrial inheritance and fermentative : oxidative balance in hybrids between Saccharomyces cerevisiae and Saccharomyces uvarum Yeast Yeast 2008; 25: 485 500. Published online in Wiley InterScience (www.interscience.wiley.com).1600 Research Article Mitochondrial inheritance and fermentative : oxidative balance in hybrids between

More information

Clustering of Pathogenic Genes in Human Co-regulatory Network. Michael Colavita Mentor: Soheil Feizi Fifth Annual MIT PRIMES Conference May 17, 2015

Clustering of Pathogenic Genes in Human Co-regulatory Network. Michael Colavita Mentor: Soheil Feizi Fifth Annual MIT PRIMES Conference May 17, 2015 Clustering of Pathogenic Genes in Human Co-regulatory Network Michael Colavita Mentor: Soheil Feizi Fifth Annual MIT PRIMES Conference May 17, 2015 Topics Background Genetic Background Regulatory Networks

More information

reconstructing biological networks from data: part 1 - cmonkey

reconstructing biological networks from data: part 1 - cmonkey reconstructing biological networks from data: part 1 - cmonkey Richard Bonneau bonneau@nyu.edu http://www.cs.nyu.edu/ ~bonneau/ New York University, Dept. of Biology & Computer Science Dept. A. RMSD over

More information

Adhesion to the yeast cell surface as a mechanism for trapping pathogenic bacteria by Saccharomyces probiotics

Adhesion to the yeast cell surface as a mechanism for trapping pathogenic bacteria by Saccharomyces probiotics Journal of Medical Microbiology (2012), 61, 1194 1207 DOI 10.1099/jmm.0.042283-0 Adhesion to the yeast cell surface as a mechanism for trapping pathogenic bacteria by Saccharomyces probiotics F. C. P.

More information

6 Septation and Cytokinesis in Fungi

6 Septation and Cytokinesis in Fungi 6 Septation and Cytokinesis in Fungi J. Wendland 1,A.Walther 1 CONTENTS I. Introduction... 105 II. Selecting Sites of Septation... 106 A. Bud Site Selection in Saccharomyces cerevisiae... 106 B. Placement

More information

Predicting essential genes in fungal genomes

Predicting essential genes in fungal genomes Michael Seringhaus, Alberto Paccanaro, Anthony Borneman, Michael Snyder and Mark Gerstein Genome Res. 2006 16: 1126-1135; originally published online Aug 9, 2006; Access the most recent version at doi:10.1101/gr.5144106

More information

Introduction to Bioinformatics

Introduction to Bioinformatics CSCI8980: Applied Machine Learning in Computational Biology Introduction to Bioinformatics Rui Kuang Department of Computer Science and Engineering University of Minnesota kuang@cs.umn.edu History of Bioinformatics

More information

Cy, Nu. Pre9 Rpn10 Rpn2 Rpn8 141: Pre10 Pre2 Pre3 Pre6 Pup3 Scl1

Cy, Nu. Pre9 Rpn10 Rpn2 Rpn8 141: Pre10 Pre2 Pre3 Pre6 Pup3 Scl1 Supplementary table S2. List of protein es. The first column provides the identifier and the second the name of the, if known. The third column contains the core proteins (i.e. those present in 2/3 rd

More information

Bayesian Hierarchical Self Modeling Warping Regression

Bayesian Hierarchical Self Modeling Warping Regression Bayesian Hierarchical Self Modeling Warping Regression Donatello Telesca 1,3, Lurdes Y.T. Inoue 2,3 Technical Report No. 510 Department of Statistics University of Washington Author s Footnote 1 University

More information

Mutational Robustness and Asymmetric Functional Specialization of Duplicate Genes

Mutational Robustness and Asymmetric Functional Specialization of Duplicate Genes Mutational Robustness and Asymmetric Functional Specialization of Duplicate Genes Andreas Wagner SFI WORKING PAPER: 2002-02-006 SFI Working Papers contain accounts of scientific work of the author(s) and

More information

The role of PCNA as a scaffold protein in cellular signaling is functionally conserved between yeast and humans

The role of PCNA as a scaffold protein in cellular signaling is functionally conserved between yeast and humans The role of PCNA as a scaffold protein in cellular signaling is functionally conserved between yeast and humans Camilla Olaisen 1, Hans Fredrik N. Kvitvang 2, Sungmin Lee 2, Eivind Almaas 2, Per Bruheim

More information

Knowledge-based analysis of microarray gene expression data by using support vector machines

Knowledge-based analysis of microarray gene expression data by using support vector machines Knowledge-based analysis of microarray gene expression data by using support vector machines Michael P. S. Brown*, William Noble Grundyt*, David Lin*, Nello Cristianinis, Charles Walsh Sugnetn, Terrence

More information

Bioinformatics. Transcriptome

Bioinformatics. Transcriptome Bioinformatics Transcriptome Jacques.van.Helden@ulb.ac.be Université Libre de Bruxelles, Belgique Laboratoire de Bioinformatique des Génomes et des Réseaux (BiGRe) http://www.bigre.ulb.ac.be/ Bioinformatics

More information

Integrating naive Bayes models and external knowledge to examine copper and iron homeostasis in S. cerevisiae

Integrating naive Bayes models and external knowledge to examine copper and iron homeostasis in S. cerevisiae Physiol Genomics 4: 127 135, 2000. Integrating naive Bayes models and external knowledge to examine copper and iron homeostasis in S. cerevisiae E. J. MOLER,* D. C. RADISKY,* AD I. S. MIA Department of

More information

Science histogram was a mistake. This mistake was corrected in this manuscript.

Science histogram was a mistake. This mistake was corrected in this manuscript. Supplementary Note When the two genes for alcohol dehydrogenase (Adh 1 and Adh 2) are aligned, and the nucleotides at the silent sites of the two fold redundant codon systems compared, one discovers that

More information

Genome-Scale Gene Function Prediction Using Multiple Sources of High-Throughput Data in Yeast Saccharomyces cerevisiae ABSTRACT

Genome-Scale Gene Function Prediction Using Multiple Sources of High-Throughput Data in Yeast Saccharomyces cerevisiae ABSTRACT OMICS A Journal of Integrative Biology Volume 8, Number 4, 2004 Mary Ann Liebert, Inc. Genome-Scale Gene Function Prediction Using Multiple Sources of High-Throughput Data in Yeast Saccharomyces cerevisiae

More information