Simple model of mrna production

Size: px
Start display at page:

Download "Simple model of mrna production"

Transcription

1 Simple model of mrna production We assume that the number of mrna (m) of a gene can change either due to the production of a mrna by transcription of DNA (which occurs at a constant rate α) or due to degradation of the mrna (which occurs at a constant rate β). The equation of evolution for m is. = α βm At steady-state: = 0, so m = α/β. The general evolution for starting for molecules is m(t) m 0 m(t) = m (1 exp[ βt]) + m 0 exp[ βt] In [2]: import numpy as np import matplotlib.pyplot as plt %matplotlib inline In [18]: alpha=10 #mrna production rate (unit: molecules/time) beta=1 #mrna degradation rate (unit: 1/time) m0=0 #initial number of mrna minf=alpha/beta #steady-state number of mrna t = np.linspace(0, 10, 256, endpoint=true) #time m = minf*(1-np.exp(-beta*t))+m0*np.exp(-beta*t) #evolution of m plt.xlabel('time t') plt.ylabel('m(t)') plt.ylim((m0-1,minf+1)) plt.plot(t,m,'k') plt.plot(t,m0+0*t,'--r') plt.plot(t,minf+0*t,'--r') plt.plot(t,m0+(minf-m0)/2+0*t,'--b') plt.plot(np.log(2)+0*t,np.linspace(m0-1, minf+1, 256, endpoint=true),'--b') 1 sur 5 15/11/ :04

2 The convergence to steady-state is exponential with a half-life ( m( t 1/2 ) = m 0 + ( m m 0 )/2) of t 1/2 = log(2)/β. Thus, the time to approach steady-state is controlled by β the rate of decay/degradation. How can a organism increase the rate of response to a signal to turn on a gene? Increasing β alone increases the rate of response but also decreases steady state expression and results in more rapid turnover which is energitically costly. To increase the rate without affecting the magnitude requires α and β to be simultaneously tuned while preserving their ratio, ie α should be increased (more production) which is also costly. Evolution, find a compromise between energy and response rate? Including the protein level We add the protein level to the previous model by considering that protein (p) are produced from mrna at a constant rate γ and are degraded at a constant rate μ. The mass-action law gives: = α βm dp = γm μp At steady state: m = α/β and p = γ m /μ = (γα)/(βμ) (the product of production rates divided by the product of degradation rates). The general solution for p can be exactly derived μ p(t) = p [(1 exp[ μt]) + ( ) ( m 0 / m 1)(exp[ βt] exp[ μt])] + p 0 exp[ μt] μ β But in case where the dynamics of mrna is faster than the one of protein ( β >> μ), we can safely replace m(t) by its steady-state value m leading to dp = γm μp Hence p(t) p (1 exp[ μt]) + p 0 exp[ μt]. This is a simple form of an approximation known as quasisteady-state approximation, because to derive it we assume that some "fast" variable (here m) are quickly converging to their steady state ( / = 0). In general, we can make this approximation for any variable that has a relaxation time much shorter than the dynamics we are interested in. 2 sur 5 15/11/ :04

3 In [32]: alpha=10 #mrna production rate (unit: molecules/time) beta=1 #mrna degradation rate (unit: 1/time) gamma=4 #protein production rate (unit:1/time) mu=0.05 #protein degradation rate (unit: 1/time) t = np.linspace(0, 10/mu, 256, endpoint=true) #time m0=0 #initial number of mrna minf=alpha/beta #steady-state number of mrna m = minf*(1-np.exp(-beta*t))+m0*np.exp(-beta*t) #evolution of m p0=0 #initial number of protein pinf=alpha*gamma/(beta*mu) p=pinf*((1-np.exp(-mu*t))+mu/(mu-beta)*(m0/minf-1)*(np.exp(-beta*t)-np.exp(-mu* t)))+p0*np.exp(-mu*t) #exact evolution of p papprox=pinf*(1-np.exp(-mu*t))+p0*np.exp(-mu*t) #approximated evolution of p plt.xlabel('time t') plt.ylabel('m(t)/minf,p(t)/pinf') plt.plot(t,m/minf,'k') plt.plot(t,p/pinf,'r') plt.plot(t,papprox/pinf,'--r') Transcriptional regulation We consider that the transcription of the gene of interest is controlled by an «external» factor X (a protein, a chemicals, etc.) that can bind to a regulatory region present in the promoter of the gene. Therefore, the promoter can be in two states: (0) the promoter is free and the mrna production rate is α 0 ; (1) X is bound to DNA and the mrna production rate is α 1. The equation of evolution for m is then given by = α 0 Φ 0 (X) + α 1 Φ 1 (X) βm with Φ i (X) the probability that the promoter is in the (i) state. Here Φ 0 + Φ 1 = 1 (the promoter state is either 0 or 1). At the promoter, we have X + (0) (1). The law of mass-action gives dφ 1 = k 01 XΦ 0 k 10 Φ 1 Protein-DNA binding is often fast (see table) and reaches steady-state on a timescale (sec.) smaller than mrna transcription (min.). So we can use the quasi-steady-state approximation for the promoter state, this leads to Φ 0 = k 10 /( k 10 + k 01 X) = 1/(1 + (X/K)) and Φ 1 = k 01 X/( k 10 + k 01 X) = (X/K)/(1 + (X/K)) with K = k 10 / k 01 the (thermodynamical) equilibrium dissociation constant of the protein-dna association. 3 sur 5 15/11/ :04

4 In [34]: x = np.linspace(0, 10, 256, endpoint=true) #X/K plt.plot(x,1/(1+x),'k') #Phi_0 plt.plot(x,x/(1+x),'r') #Phi_1 plt.xlabel('x/k') plt.ylabel('phi_0 (black), Phi_1 (red)') Φ i is saturable and hyperbolic, converges slowly to 0 or 1 (not a good switch). Note that X in the Φ's formulas is the total number (or concentration) of free X molecules that may be different of the number of total molecules. Sometimes (when the number of molecules is very very low), it is necessary to account for such "depletion" effect, but usually (since the number of promoter is small compared to the total number of X), we can identified the number of free TF molecules to their total number. Going back to the equation for m, we can rewrite the mrna production rate as 1 (X/K) α 1 + ( α 0 α 1 ) = α 0 + ( α 1 α 0 ) 1 + (X/K) 1 + (X/K) If α 0 > α 1, X is a repressor of gene expression: transcription rate decreases with X ( α 1 is the leaky rate, amount not under control). On contrary, if α 1 > α 0, X is an activator of gene expression: transcription rate increases with X ( α 0 is the basal rate of expression). In [35]: alpha0=1 alpha1=5 x = np.linspace(0, 10, 256, endpoint=true) #X/K plt.plot(x,alpha0/(1+x)+alpha1*x/(1+x),'k') #transcription rate plt.xlabel('x/k') plt.ylabel('transcription rate') 4 sur 5 15/11/ :04

5 In [ ]: 5 sur 5 15/11/ :04

Stochastic model of mrna production

Stochastic model of mrna production Stochastic model of mrna production We assume that the number of mrna (m) of a gene can change either due to the production of a mrna by transcription of DNA (which occurs at a rate α) or due to degradation

More information

CS-E5880 Modeling biological networks Gene regulatory networks

CS-E5880 Modeling biological networks Gene regulatory networks CS-E5880 Modeling biological networks Gene regulatory networks Jukka Intosalmi (based on slides by Harri Lähdesmäki) Department of Computer Science Aalto University January 12, 2018 Outline Modeling gene

More information

Lecture 4: Transcription networks basic concepts

Lecture 4: Transcription networks basic concepts Lecture 4: Transcription networks basic concepts - Activators and repressors - Input functions; Logic input functions; Multidimensional input functions - Dynamics and response time 2.1 Introduction The

More information

56:198:582 Biological Networks Lecture 8

56:198:582 Biological Networks Lecture 8 56:198:582 Biological Networks Lecture 8 Course organization Two complementary approaches to modeling and understanding biological networks Constraint-based modeling (Palsson) System-wide Metabolism Steady-state

More information

2 Dilution of Proteins Due to Cell Growth

2 Dilution of Proteins Due to Cell Growth Problem Set 1 1 Transcription and Translation Consider the following set of reactions describing the process of maing a protein out of a gene: G β g G + M M α m M β m M + X X + S 1+ 1 X S 2+ X S X S 2

More information

Basic Synthetic Biology circuits

Basic Synthetic Biology circuits Basic Synthetic Biology circuits Note: these practices were obtained from the Computer Modelling Practicals lecture by Vincent Rouilly and Geoff Baldwin at Imperial College s course of Introduction to

More information

Topic 4 - #14 The Lactose Operon

Topic 4 - #14 The Lactose Operon Topic 4 - #14 The Lactose Operon The Lactose Operon The lactose operon is an operon which is responsible for the transport and metabolism of the sugar lactose in E. coli. - Lactose is one of many organic

More information

Lecture 7: Simple genetic circuits I

Lecture 7: Simple genetic circuits I Lecture 7: Simple genetic circuits I Paul C Bressloff (Fall 2018) 7.1 Transcription and translation In Fig. 20 we show the two main stages in the expression of a single gene according to the central dogma.

More information

L3.1: Circuits: Introduction to Transcription Networks. Cellular Design Principles Prof. Jenna Rickus

L3.1: Circuits: Introduction to Transcription Networks. Cellular Design Principles Prof. Jenna Rickus L3.1: Circuits: Introduction to Transcription Networks Cellular Design Principles Prof. Jenna Rickus In this lecture Cognitive problem of the Cell Introduce transcription networks Key processing network

More information

7.32/7.81J/8.591J: Systems Biology. Fall Exam #1

7.32/7.81J/8.591J: Systems Biology. Fall Exam #1 7.32/7.81J/8.591J: Systems Biology Fall 2013 Exam #1 Instructions 1) Please do not open exam until instructed to do so. 2) This exam is closed- book and closed- notes. 3) Please do all problems. 4) Use

More information

Genetic transcription and regulation

Genetic transcription and regulation Genetic transcription and regulation Central dogma of biology DNA codes for DNA DNA codes for RNA RNA codes for proteins not surprisingly, many points for regulation of the process DNA codes for DNA replication

More information

3.B.1 Gene Regulation. Gene regulation results in differential gene expression, leading to cell specialization.

3.B.1 Gene Regulation. Gene regulation results in differential gene expression, leading to cell specialization. 3.B.1 Gene Regulation Gene regulation results in differential gene expression, leading to cell specialization. We will focus on gene regulation in prokaryotes first. Gene regulation accounts for some of

More information

Activation of a receptor. Assembly of the complex

Activation of a receptor. Assembly of the complex Activation of a receptor ligand inactive, monomeric active, dimeric When activated by growth factor binding, the growth factor receptor tyrosine kinase phosphorylates the neighboring receptor. Assembly

More information

Biomolecular Feedback Systems

Biomolecular Feedback Systems Biomolecular Feedback Systems Domitilla Del Vecchio MIT Richard M. Murray Caltech Version 1.0b, September 14, 2014 c 2014 by Princeton University Press All rights reserved. This is the electronic edition

More information

BME 5742 Biosystems Modeling and Control

BME 5742 Biosystems Modeling and Control BME 5742 Biosystems Modeling and Control Lecture 24 Unregulated Gene Expression Model Dr. Zvi Roth (FAU) 1 The genetic material inside a cell, encoded in its DNA, governs the response of a cell to various

More information

2. Mathematical descriptions. (i) the master equation (ii) Langevin theory. 3. Single cell measurements

2. Mathematical descriptions. (i) the master equation (ii) Langevin theory. 3. Single cell measurements 1. Why stochastic?. Mathematical descriptions (i) the master equation (ii) Langevin theory 3. Single cell measurements 4. Consequences Any chemical reaction is stochastic. k P d φ dp dt = k d P deterministic

More information

Problem Set 2. 1 Competitive and uncompetitive inhibition (12 points) Systems Biology (7.32/7.81J/8.591J)

Problem Set 2. 1 Competitive and uncompetitive inhibition (12 points) Systems Biology (7.32/7.81J/8.591J) Problem Set 2 1 Competitive and uncompetitive inhibition (12 points) a. Reversible enzyme inhibitors can bind enzymes reversibly, and slowing down or halting enzymatic reactions. If an inhibitor occupies

More information

13.4 Gene Regulation and Expression

13.4 Gene Regulation and Expression 13.4 Gene Regulation and Expression Lesson Objectives Describe gene regulation in prokaryotes. Explain how most eukaryotic genes are regulated. Relate gene regulation to development in multicellular organisms.

More information

Dynamics of the Mixed Feedback Loop Integrated with MicroRNA

Dynamics of the Mixed Feedback Loop Integrated with MicroRNA The Second International Symposium on Optimization and Systems Biology (OSB 08) Lijiang, China, October 31 November 3, 2008 Copyright 2008 ORSC & APORC, pp. 174 181 Dynamics of the Mixed Feedback Loop

More information

UNIT 6 PART 3 *REGULATION USING OPERONS* Hillis Textbook, CH 11

UNIT 6 PART 3 *REGULATION USING OPERONS* Hillis Textbook, CH 11 UNIT 6 PART 3 *REGULATION USING OPERONS* Hillis Textbook, CH 11 REVIEW: Signals that Start and Stop Transcription and Translation BUT, HOW DO CELLS CONTROL WHICH GENES ARE EXPRESSED AND WHEN? First of

More information

Gene Regulation and Expression

Gene Regulation and Expression THINK ABOUT IT Think of a library filled with how-to books. Would you ever need to use all of those books at the same time? Of course not. Now picture a tiny bacterium that contains more than 4000 genes.

More information

Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday

Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday Complete all warm up questions Focus on operon functioning we will be creating operon models on Monday 1. What is the Central Dogma? 2. How does prokaryotic DNA compare to eukaryotic DNA? 3. How is DNA

More information

Prokaryotic Gene Expression (Learning Objectives)

Prokaryotic Gene Expression (Learning Objectives) Prokaryotic Gene Expression (Learning Objectives) 1. Learn how bacteria respond to changes of metabolites in their environment: short-term and longer-term. 2. Compare and contrast transcriptional control

More information

AP3162D: Lecture 2 - Gene-regulatory circuits: Deterministic dynamics

AP3162D: Lecture 2 - Gene-regulatory circuits: Deterministic dynamics AP3162D: Lecture 2 - Gene-regulatory circuits: Deterministic dynamics Hyun Youk Delft University of Technology (Dated: February 22, 2018) In this lecture, we will discuss how to model standard gene-regulatory

More information

APGRU6L2. Control of Prokaryotic (Bacterial) Genes

APGRU6L2. Control of Prokaryotic (Bacterial) Genes APGRU6L2 Control of Prokaryotic (Bacterial) Genes 2007-2008 Bacterial metabolism Bacteria need to respond quickly to changes in their environment STOP u if they have enough of a product, need to stop production

More information

Bioinformatics: Network Analysis

Bioinformatics: Network Analysis Bioinformatics: Network Analysis Kinetics of Gene Regulation COMP 572 (BIOS 572 / BIOE 564) - Fall 2013 Luay Nakhleh, Rice University 1 The simplest model of gene expression involves only two steps: the

More information

Bistability and a differential equation model of the lac operon

Bistability and a differential equation model of the lac operon Bistability and a differential equation model of the lac operon Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 4500, Fall 2016 M. Macauley

More information

Measuring TF-DNA interactions

Measuring TF-DNA interactions Measuring TF-DNA interactions How is Biological Complexity Achieved? Mediated by Transcription Factors (TFs) 2 Regulation of Gene Expression by Transcription Factors TF trans-acting factors TF TF TF TF

More information

Name: SBI 4U. Gene Expression Quiz. Overall Expectation:

Name: SBI 4U. Gene Expression Quiz. Overall Expectation: Gene Expression Quiz Overall Expectation: - Demonstrate an understanding of concepts related to molecular genetics, and how genetic modification is applied in industry and agriculture Specific Expectation(s):

More information

Prokaryotic Regulation

Prokaryotic Regulation Prokaryotic Regulation Control of transcription initiation can be: Positive control increases transcription when activators bind DNA Negative control reduces transcription when repressors bind to DNA regulatory

More information

Translation and Operons

Translation and Operons Translation and Operons You Should Be Able To 1. Describe the three stages translation. including the movement of trna molecules through the ribosome. 2. Compare and contrast the roles of three different

More information

A Simple Protein Synthesis Model

A Simple Protein Synthesis Model A Simple Protein Synthesis Model James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University September 3, 213 Outline A Simple Protein Synthesis Model

More information

Controlling Gene Expression

Controlling Gene Expression Controlling Gene Expression Control Mechanisms Gene regulation involves turning on or off specific genes as required by the cell Determine when to make more proteins and when to stop making more Housekeeping

More information

Advanced Protein Models

Advanced Protein Models Advanced Protein Models James. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University March 27, 2014 Outline Advanced Protein Models The Bound Fraction Transcription

More information

Chapter 15 Active Reading Guide Regulation of Gene Expression

Chapter 15 Active Reading Guide Regulation of Gene Expression Name: AP Biology Mr. Croft Chapter 15 Active Reading Guide Regulation of Gene Expression The overview for Chapter 15 introduces the idea that while all cells of an organism have all genes in the genome,

More information

Advanced Protein Models

Advanced Protein Models Advanced Protein Models James. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University March 27, 2014 Outline 1 Advanced Protein Models 2 The Bound Fraction

More information

Biology. Biology. Slide 1 of 26. End Show. Copyright Pearson Prentice Hall

Biology. Biology. Slide 1 of 26. End Show. Copyright Pearson Prentice Hall Biology Biology 1 of 26 Fruit fly chromosome 12-5 Gene Regulation Mouse chromosomes Fruit fly embryo Mouse embryo Adult fruit fly Adult mouse 2 of 26 Gene Regulation: An Example Gene Regulation: An Example

More information

Control of Gene Expression in Prokaryotes

Control of Gene Expression in Prokaryotes Why? Control of Expression in Prokaryotes How do prokaryotes use operons to control gene expression? Houses usually have a light source in every room, but it would be a waste of energy to leave every light

More information

Lecture 6: The feed-forward loop (FFL) network motif

Lecture 6: The feed-forward loop (FFL) network motif Lecture 6: The feed-forward loop (FFL) network motif Chapter 4 of Alon x 4. Introduction x z y z y Feed-forward loop (FFL) a= 3-node feedback loop (3Loop) a=3 Fig 4.a The feed-forward loop (FFL) and the

More information

Written Exam 15 December Course name: Introduction to Systems Biology Course no

Written Exam 15 December Course name: Introduction to Systems Biology Course no Technical University of Denmark Written Exam 15 December 2008 Course name: Introduction to Systems Biology Course no. 27041 Aids allowed: Open book exam Provide your answers and calculations on separate

More information

Network motifs in the transcriptional regulation network (of Escherichia coli):

Network motifs in the transcriptional regulation network (of Escherichia coli): Network motifs in the transcriptional regulation network (of Escherichia coli): Janne.Ravantti@Helsinki.Fi (disclaimer: IANASB) Contents: Transcription Networks (aka. The Very Boring Biology Part ) Network

More information

12-5 Gene Regulation

12-5 Gene Regulation 12-5 Gene Regulation Fruit fly chromosome 12-5 Gene Regulation Mouse chromosomes Fruit fly embryo Mouse embryo Adult fruit fly Adult mouse 1 of 26 12-5 Gene Regulation Gene Regulation: An Example Gene

More information

REVIEW SESSION. Wednesday, September 15 5:30 PM SHANTZ 242 E

REVIEW SESSION. Wednesday, September 15 5:30 PM SHANTZ 242 E REVIEW SESSION Wednesday, September 15 5:30 PM SHANTZ 242 E Gene Regulation Gene Regulation Gene expression can be turned on, turned off, turned up or turned down! For example, as test time approaches,

More information

GENE REGULATION AND PROBLEMS OF DEVELOPMENT

GENE REGULATION AND PROBLEMS OF DEVELOPMENT GENE REGULATION AND PROBLEMS OF DEVELOPMENT By Surinder Kaur DIET Ropar Surinder_1998@ yahoo.in Mob No 9988530775 GENE REGULATION Gene is a segment of DNA that codes for a unit of function (polypeptide,

More information

Co-ordination occurs in multiple layers Intracellular regulation: self-regulation Intercellular regulation: coordinated cell signalling e.g.

Co-ordination occurs in multiple layers Intracellular regulation: self-regulation Intercellular regulation: coordinated cell signalling e.g. Gene Expression- Overview Differentiating cells Achieved through changes in gene expression All cells contain the same whole genome A typical differentiated cell only expresses ~50% of its total gene Overview

More information

4. Why not make all enzymes all the time (even if not needed)? Enzyme synthesis uses a lot of energy.

4. Why not make all enzymes all the time (even if not needed)? Enzyme synthesis uses a lot of energy. 1 C2005/F2401 '10-- Lecture 15 -- Last Edited: 11/02/10 01:58 PM Copyright 2010 Deborah Mowshowitz and Lawrence Chasin Department of Biological Sciences Columbia University New York, NY. Handouts: 15A

More information

Regulation and signaling. Overview. Control of gene expression. Cells need to regulate the amounts of different proteins they express, depending on

Regulation and signaling. Overview. Control of gene expression. Cells need to regulate the amounts of different proteins they express, depending on Regulation and signaling Overview Cells need to regulate the amounts of different proteins they express, depending on cell development (skin vs liver cell) cell stage environmental conditions (food, temperature,

More information

Genetic transcription and regulation

Genetic transcription and regulation Genetic transcription and regulation Central dogma of biology DNA codes for DNA DNA codes for RNA RNA codes for proteins not surprisingly, many points for regulation of the process https://www.youtube.com/

More information

Bistability in ODE and Boolean network models

Bistability in ODE and Boolean network models Bistability in ODE and Boolean network models Matthew Macauley Department of Mathematical Sciences Clemson University http://www.math.clemson.edu/~macaule/ Math 4500, Spring 2017 M. Macauley (Clemson)

More information

Simulation of Chemical Reactions

Simulation of Chemical Reactions Simulation of Chemical Reactions Cameron Finucane & Alejandro Ribeiro Dept. of Electrical and Systems Engineering University of Pennsylvania aribeiro@seas.upenn.edu http://www.seas.upenn.edu/users/~aribeiro/

More information

Phys 450 Spring 2011 Solution set 6. A bimolecular reaction in which A and B combine to form the product P may be written as:

Phys 450 Spring 2011 Solution set 6. A bimolecular reaction in which A and B combine to form the product P may be written as: Problem Phys 45 Spring Solution set 6 A bimolecular reaction in which A and combine to form the product P may be written as: k d A + A P k d k a where k d is a diffusion-limited, bimolecular rate constant

More information

Regulation of Gene Expression

Regulation of Gene Expression Chapter 18 Regulation of Gene Expression PowerPoint Lecture Presentations for Biology Eighth Edition Neil Campbell and Jane Reece Lectures by Chris Romero, updated by Erin Barley with contributions from

More information

A systems approach to biology

A systems approach to biology A systems approach to biology SB200 Lecture 5 30 September 2008 Jeremy Gunawardena jeremy@hms.harvard.edu Recap of Lecture 4 matrix exponential exp(a) = 1 + A + A2/2 +... + Ak/k! +... dx/dt = Ax matrices

More information

Bioinformatics 3. V18 Kinetic Motifs. Fri, Jan 8, 2016

Bioinformatics 3. V18 Kinetic Motifs. Fri, Jan 8, 2016 Bioinformatics 3 V18 Kinetic Motifs Fri, Jan 8, 2016 Modelling of Signalling Pathways Curr. Op. Cell Biol. 15 (2003) 221 1) How do the magnitudes of signal output and signal duration depend on the kinetic

More information

Bioinformatics 3! V20 Kinetic Motifs" Mon, Jan 13, 2014"

Bioinformatics 3! V20 Kinetic Motifs Mon, Jan 13, 2014 Bioinformatics 3! V20 Kinetic Motifs" Mon, Jan 13, 2014" Modelling of Signalling Pathways" Curr. Op. Cell Biol. 15 (2003) 221" 1) How do the magnitudes of signal output and signal duration depend on the

More information

56:198:582 Biological Networks Lecture 9

56:198:582 Biological Networks Lecture 9 56:198:582 Biological Networks Lecture 9 The Feed-Forward Loop Network Motif Subgraphs in random networks We have discussed the simplest network motif, self-regulation, a pattern with one node We now consider

More information

Differential transcriptional regulation by alternatively designed mechanisms: A mathematical modeling approach

Differential transcriptional regulation by alternatively designed mechanisms: A mathematical modeling approach In Silico Biology 12 (2017) 95 127 DOI 10.3233/ISB-160467 IOS Press 95 Differential transcriptional regulation by alternatively designed mechanisms: A mathematical modeling approach Necmettin Yildirim

More information

Bi 8 Lecture 11. Quantitative aspects of transcription factor binding and gene regulatory circuit design. Ellen Rothenberg 9 February 2016

Bi 8 Lecture 11. Quantitative aspects of transcription factor binding and gene regulatory circuit design. Ellen Rothenberg 9 February 2016 Bi 8 Lecture 11 Quantitative aspects of transcription factor binding and gene regulatory circuit design Ellen Rothenberg 9 February 2016 Major take-home messages from λ phage system that apply to many

More information

Name Period The Control of Gene Expression in Prokaryotes Notes

Name Period The Control of Gene Expression in Prokaryotes Notes Bacterial DNA contains genes that encode for many different proteins (enzymes) so that many processes have the ability to occur -not all processes are carried out at any one time -what allows expression

More information

Principles of Synthetic Biology: Midterm Exam

Principles of Synthetic Biology: Midterm Exam Principles of Synthetic Biology: Midterm Exam October 28, 2010 1 Conceptual Simple Circuits 1.1 Consider the plots in figure 1. Identify all critical points with an x. Put a circle around the x for each

More information

Enzyme Reactions. Lecture 13: Kinetics II Michaelis-Menten Kinetics. Margaret A. Daugherty Fall v = k 1 [A] E + S ES ES* EP E + P

Enzyme Reactions. Lecture 13: Kinetics II Michaelis-Menten Kinetics. Margaret A. Daugherty Fall v = k 1 [A] E + S ES ES* EP E + P Lecture 13: Kinetics II Michaelis-Menten Kinetics Margaret A. Daugherty Fall 2003 Enzyme Reactions E + S ES ES* EP E + P E = enzyme ES = enzyme-substrate complex ES* = enzyme/transition state complex EP

More information

Michaelis-Menten Kinetics. Lecture 13: Kinetics II. Enzyme Reactions. Margaret A. Daugherty. Fall Substrates bind to the enzyme s active site

Michaelis-Menten Kinetics. Lecture 13: Kinetics II. Enzyme Reactions. Margaret A. Daugherty. Fall Substrates bind to the enzyme s active site Lecture 13: Kinetics II Michaelis-Menten Kinetics Margaret A. Daugherty Fall 2003 Enzyme Reactions E + S ES ES* EP E + P E = enzyme ES = enzyme-substrate complex ES* = enzyme/transition state complex EP

More information

System Biology - Deterministic & Stochastic Dynamical Systems

System Biology - Deterministic & Stochastic Dynamical Systems System Biology - Deterministic & Stochastic Dynamical Systems System Biology - Deterministic & Stochastic Dynamical Systems 1 The Cell System Biology - Deterministic & Stochastic Dynamical Systems 2 The

More information

Computational Cell Biology Lecture 4

Computational Cell Biology Lecture 4 Computational Cell Biology Lecture 4 Case Study: Basic Modeling in Gene Expression Yang Cao Department of Computer Science DNA Structure and Base Pair Gene Expression Gene is just a small part of DNA.

More information

The Riboswitch is functionally separated into the ligand binding APTAMER and the decision-making EXPRESSION PLATFORM

The Riboswitch is functionally separated into the ligand binding APTAMER and the decision-making EXPRESSION PLATFORM The Riboswitch is functionally separated into the ligand binding APTAMER and the decision-making EXPRESSION PLATFORM Purine riboswitch TPP riboswitch SAM riboswitch glms ribozyme In-line probing is used

More information

FYTN05/TEK267 Chemical Forces and Self Assembly

FYTN05/TEK267 Chemical Forces and Self Assembly FYTN05/TEK267 Chemical Forces and Self Assembly FYTN05/TEK267 Chemical Forces and Self Assembly 1 Michaelis-Menten (10.3,10.4) M-M formalism can be used in many contexts, e.g. gene regulation, protein

More information

Prokaryotic Gene Expression (Learning Objectives)

Prokaryotic Gene Expression (Learning Objectives) Prokaryotic Gene Expression (Learning Objectives) 1. Learn how bacteria respond to changes of metabolites in their environment: short-term and longer-term. 2. Compare and contrast transcriptional control

More information

Advanced Protein Models again: adding regulation

Advanced Protein Models again: adding regulation Advanced Protein Models again: adding regulation James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University April 1, 2014 Outline 1 Simple Regulations

More information

Unit 3: Control and regulation Higher Biology

Unit 3: Control and regulation Higher Biology Unit 3: Control and regulation Higher Biology To study the roles that genes play in the control of growth and development of organisms To be able to Give some examples of features which are controlled

More information

Statistical mechanics of biological processes

Statistical mechanics of biological processes Statistical mechanics of biological processes 1 Modeling biological processes Describing biological processes requires models. If reaction occurs on timescales much faster than that of connected processes

More information

Control of Gene Expression

Control of Gene Expression Control of Gene Expression Mechanisms of Gene Control Gene Control in Eukaryotes Master Genes Gene Control In Prokaryotes Epigenetics Gene Expression The overall process by which information flows from

More information

Warm-Up. Explain how a secondary messenger is activated, and how this affects gene expression. (LO 3.22)

Warm-Up. Explain how a secondary messenger is activated, and how this affects gene expression. (LO 3.22) Warm-Up Explain how a secondary messenger is activated, and how this affects gene expression. (LO 3.22) Yesterday s Picture The first cell on Earth (approx. 3.5 billion years ago) was simple and prokaryotic,

More information

BE 150 Problem Set #2 Issued: 16 Jan 2013 Due: 23 Jan 2013

BE 150 Problem Set #2 Issued: 16 Jan 2013 Due: 23 Jan 2013 M. Elowitz and R. M. Murray Winter 2013 CALIFORNIA INSTITUTE OF TECHNOLOGY Biology and Biological Engineering (BBE) BE 150 Problem Set #2 Issued: 16 Jan 2013 Due: 23 Jan 2013 1. (Shaping pulses; based

More information

Are DNA Transcription Factor Proteins Maxwellian Demons?

Are DNA Transcription Factor Proteins Maxwellian Demons? Are DNA Transcription Factor Proteins Maxwellian Demons? * physics as a design constraint on molecular evolution. Alexander Grosberg, Longhua Hu, U. Minnesota, NYU U. Minnesota Biophysical Journal 2008

More information

Topic 4: Equilibrium binding and chemical kinetics

Topic 4: Equilibrium binding and chemical kinetics Topic 4: Equilibrium binding and chemical kinetics Outline: Applications, applications, applications use Boltzmann to look at receptor-ligand binding use Boltzmann to look at PolII-DNA binding and gene

More information

Multistability in the lactose utilization network of Escherichia coli

Multistability in the lactose utilization network of Escherichia coli Multistability in the lactose utilization network of Escherichia coli Lauren Nakonechny, Katherine Smith, Michael Volk, Robert Wallace Mentor: J. Ruby Abrams Agenda Motivation Intro to multistability Purpose

More information

Evolutionary analysis of the well characterized endo16 promoter reveals substantial variation within functional sites

Evolutionary analysis of the well characterized endo16 promoter reveals substantial variation within functional sites Evolutionary analysis of the well characterized endo16 promoter reveals substantial variation within functional sites Paper by: James P. Balhoff and Gregory A. Wray Presentation by: Stephanie Lucas Reviewed

More information

Control of Prokaryotic (Bacterial) Gene Expression. AP Biology

Control of Prokaryotic (Bacterial) Gene Expression. AP Biology Control of Prokaryotic (Bacterial) Gene Expression Figure 18.1 How can this fish s eyes see equally well in both air and water? Aka. Quatro ojas Regulation of Gene Expression: Prokaryotes and eukaryotes

More information

The Making of the Fittest: Evolving Switches, Evolving Bodies

The Making of the Fittest: Evolving Switches, Evolving Bodies INTRODUCTION MODELING THE REGULATORY SWITCHES OF THE PITX1 GENE IN STICKLEBACK FISH The types and amounts of proteins produced by a given cell in the body are very important and carefully regulated. Transcribing

More information

GLOBEX Bioinformatics (Summer 2015) Genetic networks and gene expression data

GLOBEX Bioinformatics (Summer 2015) Genetic networks and gene expression data GLOBEX Bioinformatics (Summer 2015) Genetic networks and gene expression data 1 Gene Networks Definition: A gene network is a set of molecular components, such as genes and proteins, and interactions between

More information

Intrinsic Noise in Nonlinear Gene Regulation Inference

Intrinsic Noise in Nonlinear Gene Regulation Inference Intrinsic Noise in Nonlinear Gene Regulation Inference Chao Du Department of Statistics, University of Virginia Joint Work with Wing H. Wong, Department of Statistics, Stanford University Transcription

More information

A Synthetic Oscillatory Network of Transcriptional Regulators

A Synthetic Oscillatory Network of Transcriptional Regulators A Synthetic Oscillatory Network of Transcriptional Regulators Michael Elowitz & Stanislas Leibler Nature, 2000 Presented by Khaled A. Rahman Background Genetic Networks Gene X Operator Operator Gene Y

More information

Lecture 18 June 2 nd, Gene Expression Regulation Mutations

Lecture 18 June 2 nd, Gene Expression Regulation Mutations Lecture 18 June 2 nd, 2016 Gene Expression Regulation Mutations From Gene to Protein Central Dogma Replication DNA RNA PROTEIN Transcription Translation RNA Viruses: genome is RNA Reverse Transcriptase

More information

Lecture 2: Read about the yeast MAT locus in Molecular Biology of the Gene. Watson et al. Chapter 10. Plus section on yeast as a model system Read

Lecture 2: Read about the yeast MAT locus in Molecular Biology of the Gene. Watson et al. Chapter 10. Plus section on yeast as a model system Read Lecture 2: Read about the yeast MAT locus in Molecular Biology of the Gene. Watson et al. Chapter 10. Plus section on yeast as a model system Read chapter 22 and chapter 10 [section on MATing type gene

More information

Simulation of Gene Regulatory Networks

Simulation of Gene Regulatory Networks Simulation of Gene Regulatory Networks Overview I have been assisting Professor Jacques Cohen at Brandeis University to explore and compare the the many available representations and interpretations of

More information

A synthetic oscillatory network of transcriptional regulators

A synthetic oscillatory network of transcriptional regulators A synthetic oscillatory network of transcriptional regulators Michael B. Elowitz & Stanislas Leibler, Nature, 403, 2000 igem Team Heidelberg 2008 Journal Club Andreas Kühne Introduction Networks of interacting

More information

Testing the transition state theory in stochastic dynamics of a. genetic switch

Testing the transition state theory in stochastic dynamics of a. genetic switch Testing the transition state theory in stochastic dynamics of a genetic switch Tomohiro Ushikubo 1, Wataru Inoue, Mitsumasa Yoda 1 1,, 3, and Masaki Sasai 1 Department of Computational Science and Engineering,

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

step, the activation signal for protein X is removed. When X * falls below K xy and K xz, the

step, the activation signal for protein X is removed. When X * falls below K xy and K xz, the CHAPTER 3: RESULTS 3.1 Dynamics of C2-FFL with AND/OR gate Figure 3.1 shows the dynamics for C2-FFL with AND gate. At the ON step, transcription factor X is activated by its inducer, causing the concentration

More information

Regulation of Gene Expression

Regulation of Gene Expression Chapter 18 Regulation of Gene Expression Edited by Shawn Lester PowerPoint Lecture Presentations for Biology Eighth Edition Neil Campbell and Jane Reece Lectures by Chris Romero, updated by Erin Barley

More information

CHAPTER : Prokaryotic Genetics

CHAPTER : Prokaryotic Genetics CHAPTER 13.3 13.5: Prokaryotic Genetics 1. Most bacteria are not pathogenic. Identify several important roles they play in the ecosystem and human culture. 2. How do variations arise in bacteria considering

More information

Chemical and enzyme kinetics

Chemical and enzyme kinetics Chemical and enzyme kinetics D. Gonze & M. Kaufman November 22, 23 Master en Bioinformatique et Modélisation - 29-2 Contents Definitions 3. Reaction rate.................................. 3.2 Examples....................................

More information

Exercise_set7_programming_exercises

Exercise_set7_programming_exercises Exercise_set7_programming_exercises May 13, 2018 1 Part 1(d) We start by defining some function that will be useful: The functions defining the system, and the Hamiltonian and angular momentum. In [1]:

More information

Chapter 16 Lecture. Concepts Of Genetics. Tenth Edition. Regulation of Gene Expression in Prokaryotes

Chapter 16 Lecture. Concepts Of Genetics. Tenth Edition. Regulation of Gene Expression in Prokaryotes Chapter 16 Lecture Concepts Of Genetics Tenth Edition Regulation of Gene Expression in Prokaryotes Chapter Contents 16.1 Prokaryotes Regulate Gene Expression in Response to Environmental Conditions 16.2

More information

Chapter 5. Design Principles for Riboswitch Function. The text in this chapter is reprinted with permission from Chase L Beisel and Christina D

Chapter 5. Design Principles for Riboswitch Function. The text in this chapter is reprinted with permission from Chase L Beisel and Christina D 57 Chapter 5 Design Principles for Riboswitch Function The text in this chapter is reprinted with permission from Chase L Beisel and Christina D Smole. PLoS Comput Biol 2009, 5(4): e000363. doi:0.37/journal.pcbi.000363.

More information

Villa et al. (2005) Structural dynamics of the lac repressor-dna complex revealed by a multiscale simulation. PNAS 102:

Villa et al. (2005) Structural dynamics of the lac repressor-dna complex revealed by a multiscale simulation. PNAS 102: Villa et al. (2005) Structural dynamics of the lac repressor-dna complex revealed by a multiscale simulation. PNAS 102: 6783-6788. Background: The lac operon is a cluster of genes in the E. coli genome

More information

Slide 1 / 7. Free Response

Slide 1 / 7. Free Response Slide 1 / 7 Free Response Slide 2 / 7 Slide 3 / 7 1 The above diagrams illustrate the experiments carried out by Griffith and Hershey and Chaserespectively. Describe the hypothesis or conclusion that each

More information

The Research Plan. Functional Genomics Research Stream. Transcription Factors. Tuning In Is A Good Idea

The Research Plan. Functional Genomics Research Stream. Transcription Factors. Tuning In Is A Good Idea Functional Genomics Research Stream The Research Plan Tuning In Is A Good Idea Research Meeting: March 23, 2010 The Road to Publication Transcription Factors Protein that binds specific DNA sequences controlling

More information

After lectures by. disappearance of reactants or appearance of. measure a reaction rate we monitor the. Reaction Rates (reaction velocities): To

After lectures by. disappearance of reactants or appearance of. measure a reaction rate we monitor the. Reaction Rates (reaction velocities): To Revised 3/21/2017 After lectures by Dr. Loren Williams (GeorgiaTech) Protein Folding: 1 st order reaction DNA annealing: 2 nd order reaction Reaction Rates (reaction velocities): To measure a reaction

More information

Regulation of Transcription in Eukaryotes. Nelson Saibo

Regulation of Transcription in Eukaryotes. Nelson Saibo Regulation of Transcription in Eukaryotes Nelson Saibo saibo@itqb.unl.pt In eukaryotes gene expression is regulated at different levels 1 - Transcription 2 Post-transcriptional modifications 3 RNA transport

More information