SlideShare ist ein Scribd-Unternehmen logo
1 von 14
Created by: Claudia Neuhauser
Worksheet 10: Kinetics
Modeling Chemical Reactions
The law of mass action has its origin in modeling chemical reactions. Consider the
chemical reaction between the molecules of type A and B:
CBA k
→+
The quantities A and B on the left-hand side are called the reactants; the quantity C is
called the product. The parameter k is the rate constant. A macroscopic model of this
reaction assumes that the concentrations and reaction constants are well-defined.
Furthermore, the concentrations vary deterministically and continuously. This leads us to
describing the reaction by a differential equation. We model this reaction as
(1) ]][[
][
BAk
dt
Cd
=
where brackets denote concentrations. The idea behind this law is that this reaction rate
depends on how often the molecules A and B collide. In a well-mixed vessel, this
collision rate is proportional to the product of the concentrations of A and B, denoted by
[A] and [B], respectively. The law of mass action is not a law in the strict sense, but it is a
good approximation when the assumptions for the macroscopic model description hold.
To determine the units of the rate constant, we compare the left-hand side and the
right-hand side of Equation (1). The concentration of the reactants A and B and the
product C are measured in [moles/liter]. Hence, the unit on the left-hand side is
[moles/liter][time]-1
. On the right-hand side, the unit of [A][B] is [moles/liter]2
. Hence, the
unit of k must be [moles/liter]-1
[time]-1
.
Task 1
Consider the following chemical reaction
→
k
A B
(a) Use the macroscopic modeling approach and determine the differential equation that
describes how the concentration of B changes over time. (b) Use the macroscopic modeling
approach and determine the differential equation that describes how the concentration of
A changes over time. (c) What are the units of k if the concentrations of A and B are
measured in [moles/liter]?
Chemical reactions may be linked. For instance, consider the set of chemical reactions
1
2
3
2
k
k
k
A B C
C B D
D A
+ →
→ +
→
- 1 -
Worksheet 10: Kinetics
There are four types of molecules. To describe the changes in concentration of these four
molecules, we need four differential equations.
(2)
1 3
2
1 2
2
1 2
2
2 3
[ ]
[ ][ ] [ ]
[ ]
[ ][ ] [ ]
[ ]
[ ][ ] 2 [ ]
[ ]
[ ] [ ]
d A
k A B k D
dt
d B
k A B k C
dt
d C
k A B k C
dt
d D
k C k D
dt
= − +
= − +
= −
= −
Task 2
Determine the units of the rate constants 1k , 2k and 3k in Equation (2).
Task 3
Consider the following set of chemical reactions
1
2
3
3
2 2
4
k
k
k
A B
B A C
C A
→
→ +
→
Assume that the assumptions for the macroscopic modeling apply. Find the system of
differential equations that describes these chemical reactions. Determine the units of the
rate constants 1k , 2k and 3k .
Enzymatic Reactions
Many biochemical reactions utilize enzymes. An enzymatic reaction that transforms the
substrate S into a product P requires the formation of a complex C between the substrate
and the enzyme E. After formation of the product P, the enzyme E is released. This is
summarized in the reaction
1 2
1
k k
k
S E C P E
−
→+ → +¬ 
We assume that the reaction from substrate plus enzyme to substrate/enzyme complex
occurs at rate 1k and the reverse reaction at rate 1−k . The reaction from the
substrate/enzyme complex to the product plus enzyme occurs at rate 2k . Models for this
- 2 -
Worksheet 10: Kinetics
reaction were first studied by Michaelis and Menten (1913)1
under simplified
assumptions. A more realistic model was developed by Briggs and Haldane (1925)2
,
which is still the basis for models of more complicated enzymatic reactions.
If we use the notation ][],[],[ CcEeSs === , and ][Pp = , then an application
of the mass action law yields
( )
( )
ck
dt
dp
ckksek
dt
dc
sekckk
dt
de
sekck
dt
ds
2
121
121
11
=
+−=
−+=
−=
−
−
−
We see from this system of equations that 0=+
dt
dc
dt
de
. This implies that
constant,e c+ = and we say that ce + is a conserved quantity. At time 0, we assume
that ,0,, 00 === ceess and 0=p . This implies that the constant ce + is equal to 0e .
Since cee −= 0 , we no longer need an equation for the enzyme concentration e. This
reduces the system to three equations.
Using cee −= 0 , we can write the first two equations of the system of differential
equations so that they will only contain the variables s and c:
ckkcesk
dt
dc
ceskck
dt
ds
)()(
)(
1201
011
−
−
+−−=
−−=
Rearranging terms, the system of three equations can be written as
(3)
( )
( )
1 1 1 0
2 1 1 1 0
2
ds
k k s c k e s
dt
dc
k k k s c k e s
dt
dp
k c
dt
−
−
= + −
= − + + +
=
1
Michaelis, L. and M.I. Menten. 1913. Die Kinetik der Invertinwirkung. Biochem. Z. 49: 333-369.
2
Briggs, G.E. and J.B.S. Haldane. 1925. A note on the kinematics of enzyme actions.
Biochemical Journal 19: 338-339.
- 3 -
Worksheet 10: Kinetics
with initial conditions 0(0)s s= , 0(0)c c= , and 0(0)p p= . The following Matlab code
solves these three equations with the given initial condition and rate constants.
- 4 -
% Solving the Michaelis-Menten Model mm.m
k1=1e3;
km1=1;
k2=0.05;
e0=0.5e-3;
options=[];
[t,y]=ode23(@mmfunc,[0,1000],[1e-3 0 0],options,k1,km1,k2,e0);
s=y(:,1);
c=y(:,2);
e=e0-c;
p=y(:,3);
semilogx(t,s,'r',t,e,'b',t,c,'g',t,p,'c');
legend('[S]','[E]','[C]','[P]');
% Michaelis-Menten Function mmfunc.m
function dydt = f(t,y,k1,km1,k2,e0)
% s=y(1), c=y(2), p=y(3)
dydt=zeros(3,1);
dydt(1) = (km1+k1*y(1))*y(2)-k1*e0*y(1);
dydt(2) = -(k2+km1+k1*y(1))*y(2)+k1*e0*y(1);
dydt(3) = k2*y(2);
Worksheet 10: Kinetics
10
-1
10
0
10
1
10
2
10
3
-2
0
2
4
6
8
10
12
x 10
-4
time
concentration
[S]
[E]
[C]
[P]
Figure 1: Time dependence of the solution of the Michaelis-Menten model with parameters given in the
Matlab code.
We see that eventually all the substrate is used up and the reaction ceases. That is, as
t → ∞ , 0s c= = , 0e e= , and 0p s= .
Analytical Solution under Quasi-steady State Approximation
To analyze this system further, we will use the technique of non-dimensionalization. The
idea is to change the variables appropriately so that they are dimensionless. There is no
unique way of doing this and it takes experience and intuition on how to proceed. Segel
(1972)3
wrote an excellent article on the art of scaling and simplification.
We start by dividing the differential equations for s and c by 001 sek :
( )
( )
1 1
1 0 0 1 0 0 0
2 1 1
1 0 0 1 0 0 0
k k sds s
c
k e s dt k e s s
k k k sdc s
c
k e s dt k e s s
−
−
+
= −
+ +
= − +
3
Segel, L.A. 1972. Simplification and Scaling. SIAM Rev. 14: 547-571.
- 5 -
Worksheet 10: Kinetics
If we set
0s
s
=σ and
0e
c
x = , then
σσ
σσ
σ
+−
+
−=
−





+=
−
−
xx
sk
kk
dtsk
dx
x
sk
k
dtek
d
01
12
01
01
1
01
Let’s change the time scale and introduce tek 01=τ , then, with
0
0
s
e
=ε , we have
x
sk
kk
d
dx
x
sk
k
d
d






+
+
−=
−





+=
−
−
σσ
τ
ε
σσ
τ
σ
01
12
01
1
If we set
01
12
sk
kk −+
=κ and
01
1
sk
k−
=α , then
( )
( )x
d
dx
x
d
d
σκσ
τ
ε
σσα
τ
σ
+−=
−+=
Quasi-steady State Approximation
In biochemical reactions, typically, e0 is much smaller than s0, which makes ε a very
small quantity. It follows that
τ
ε
d
dx
is close to 0 and this insight was used by Briggs and
Haldane (1925) to justify the “quasi-steady state approximation” 0=
τ
ε
d
dx
. It follows that
σκ
σ
+
=x
and hence
σ
σκ
σ
σα
τ
σ
−
+
+= )(
d
d
- 6 -
Worksheet 10: Kinetics
or, after simplifying,
σκ
σακ
τ
σ
+
−
−=
)(
d
d
Now, 0
01
2
>=−
sk
k
ακ and we set ακ −=q . Then
σκ
σ
τ
σ
+
−=
q
d
d
Using the original variables, we find for the velocity of the reaction
(4)
sK
sv
dt
ds
dt
dp
V
m
m
+
=−==
where
1
21
k
kk
Km
+
= −
is the half-saturation constant and 02ekvm = is the maximal
reaction rate. Equation (4) is the classical Michaelis-Menten equation. This equation
models the initial rate at which substrate is converted into the product. During this initial
period, the formation and the break-up of the enzyme-substrate complex reaches a quasi-
steady state before product formation becomes noticeable.
Lineweaver-Burk transformation
The function
sK
sv
V
m
m
+
= is called the Michaelis-Menten function. It is an important
function and it is used to fit data to determine mv and mK .
To determine mv and mK , the Lineweaver-Burk transformation is frequently
applied. Writing
mm
m
vsv
K
V
111
+=
we see that in a graph where the horizontal axis is 1/s and the vertical axis is 1/V, the
relationship is a straight line. The intercepts allow us to estimate mv and mK .
Reading Assignment (due on _________________________)
Read the paper by Hasty et al. 2000.
- 7 -
Worksheet 10: Kinetics
Computer Lab (Homework due _________________________)
Step 1
The following data set describes the degradation of a substance with concentration s. The
velocity of the reaction V as a function of s was measured. Use the Lineweaver-Burk
transformation
mm
m
vsv
K
V
111
+= to find mv and mK . That is, plot 1/V as a function of
1/s and use a regression line to find the equation of the straight line fitted to this
transformed data. Use the equation to then find the two parameters mv and mK .
Velocity V
Substrate
Concentration s
0.025 0.04
0.033 0.07
0.042 0.12
0.081 0.25
0.11 0.42
0.175 0.8
0.17 0.92
0.2 1.7
0.21 2.9
0.22 4.3
Step 2
The half-saturation constant Km is called the affinity. We found
1
21
k
kk
Km
+
= −
Use EXCEL to graph Km as a function of k1 and use calculus to show that Km is a
decreasing function of k1, i.e., differentiate Km with respect to k1, and show that the
derivative is negative. (For the graph, set 1 0.05k− = and 2 0.5k = and let 1k vary between
0.3 and 5.0 in steps of 0.1.)
Step 3
(a) Set 0.2mv = , 0.3mK = , and (0) 1s = . Use the Euler method to numerically
approximate the solution of
sK
sv
dt
ds
m
m
+
−=
for [0,20]t ∈ (set the step size equal to 0.01).
- 8 -
Worksheet 10: Kinetics
(b) Now vary Km between 0.1 and 0.9 (stepsize equal to 0.2). For each value of Km, find
the time at which the concentration of the substrate is half its initial value (i.e., 0.5).
Graph this time as a function of Km and use a linear regression line to predict the time
when 1.3mK = . Check your prediction using the numerical approximation.
Step 4
Complete Tasks 1-3.
- 9 -
Worksheet 10: Kinetics
Gene Regulatory Networks
Cells control their functions through regulating gene expressions. Many of these
regulatory processes are at the level of gene transcription. A common framework for
modeling these interactions is biochemical reactions. This deterministic framework
ignores fluctuations and can be considered as describing the time evolution of the
means of various quantities of interest.
We will use the example given in Hasty et al. (2000)4
to introduce this kind of
modeling. Their work is motivated by the lysis-lysogeny decision of the bacterial phage
lambda. Their first model, which we will study, is a mutant system with two operators,
OR2 and OR3. The gene encodes for a repressor protein that dimerizes and binds to
either operator. The dimerized protein enhances transcription if it binds to OR2, and
represses transcription when it binds to OR3. We use the notation in Hasty et al. to
explain the dynamics. We denote by X the repressor, by X2 the dimerized repressor, and
by D the DNA promoter site. Then
(5)
1
2
3
4
2
2 2
*
2 2
2 2 2 2
2
K
K
K
K
X X
D X DX
D X DX
DX X DX X
→¬ 
→+ ¬ 
→+ ¬ 
→+ ¬ 
Here, 2DX and
*
2DX denote the dimerized proteins that bind to OR2 and OR3,
respectively. 2 2DX X denotes binding to both operators. The constants iK are forward
equilibrium constants. That is, if a biochemical reaction is described by
1
1
k
k
A B
−
→¬ 
then, the corresponding rate equation is
1 1
[ ]
[ ] [ ]
d A
k A k B
dt
−= − +
and at equilibrium,
1
1
[ ] [ ]
k
B A
k−
=
The forward equilibrium constant would be
1
1
1
k
K
k−
= .
4
Hasty, J., J. Pradines, M. Dolnik, and J.J. Collins. 2000. Noise-based switches and amplifiers for gene
expression. PNAS, 97(5): 2075-2080.
- 10 -
Worksheet 10: Kinetics
The reactions in (5) are fast compared to transcription and degradation, the slow
reactions. These are given by
(6) 2 2
t
d
k
k
DX P DX P nX
X A
+ → + +
→
where P is the concentration of RNA polymerase and n is the number of proteins per
mRNA transcript. Note that the arrows in these two reactions only point in one direction,
reflecting that these reactions are irreversible.
Hasty et al. (2000) considered an in vitro system where this small gene regulatory
network is contained in a plasmid and the whole system contains a large number of
plasmids to justify the rate equation approach. We define the following variables:
[ ]x X= , 2[ ]y X= , [ ]d D= , 2[ ]u DX= ,
*
2[ ]v DX= , and 2 2[ ]z DX X= . Then the
evolution of the repressor protein is given by
(7)
2
1 1 02 2 t d
dx
k x k y nk p u k x r
dt
−= − + + − +
where r is the expression rate of the gene in the absence of transcription factors.
Assuming that the reaction in (5) are fast compared to the ones in (6), we can again use a
quasi-steady state approach and assume that the reactions in (5) are at equilibrium. We
assume that 3 1 2K Kσ= and 3 2 2K Kσ= . This implies that
( )
2
1
2
2 1 2
2
1 2 1 1 2
2 4
2 2 2 1 2
y K x
u K dy K K dx
v K dy K K dx
z K uy K K dx
σ σ
σ σ
=
= =
= =
= =
It is further assumed that the total concentration of DNA promoter sites, denoted by Td ,
is constant. That is,
2 2 2 4
1 1 2 2 1 21 (1 )Td d u v z d K K x K K xσ σ = + + + = + + + 
It can be shown that Equation (7) simplifies to
(8)
2
2 4
1 2
1
1 (1 )
dx x
x
dt x x
α
γ
σ σ
= − +
+ + +
% %
%
% % %
- 11 -
Worksheet 10: Kinetics
where 1 2x x K K=% , 1 2( )t t r K K=% , 0 /t Tnk p d rα = , and 1 2/( )dk r K Kγ = .
To find equilibria, we set the right hand side of (8) equal to 0. that is,
{
2
2 4
1 2 ( )
( )
1
1 (1 ) g x
f x
x
x
x x
α
γ
σ σ
= −
+ + + %
%
%
%
% %
144424443
If we plot ( )f x and ( )g x in the same coordinate system, the points of intersection are
the respective equilibria.
The following Matlab program both solves the differential equation (6) and plots
the two functions ( )f x and ( )g x in the same coordinate system.
We will investigate this model for different values of γ to understand Figure 1 in Hasty
et al.
- 12 -
% Solving the Hasty Model hasty.m
alpha=50;
gamma=5;
sigma1=1;
sigma2=5;
options=[];
[t1,y1]=ode23(@hastyfunc,[0,10],[0],options,alpha,gamma,sigma1,sigma2);
[t2,y2]=ode23(@hastyfunc,[0,10],[1],options,alpha,gamma,sigma1,sigma2);
x=0:0.01:2;
f=alpha*x.^2./(1+(1+sigma1)*x.^2+sigma2*x.^4);
g=gamma*x-1;
subplot(1,2,1), plot(x,f,'k',x,g,':k');
xlabel('repressor concentration');ylabel('f(x) and
g(x)');legend('f(x)','g(x)');title('Equilibria');
subplot(1,2,2), plot(t1,y1,'--k',t2,y2,'k');
xlabel('time');ylabel('repressor
concentration');legend('x(0)=0','x(0)=1');title('Dynamics');
% Hasty Model hastyfunc.m
function dydt = f(t,y,alpha,gamma,sigma1,sigma2)
% x=y(1)
dydt=alpha*y(1)^2/(1+(1+sigma1)*y(1)^2+sigma2*y(1)^4)-gamma*y(1)+1;
Worksheet 10: Kinetics
Task 4
Use the Matlab code and simulate the model for 13γ = , 15, and 17. Relate the outcome of
your simulations to Figure 1B (mutant case).
Figure 2: Figure 1B from Hasty et al. 2000
Introducing Noise (Optional)
Hasty et al. introduce noise into this system. While we will not numerically solve the
dynamics of the other models in this paper, we will introduce the notion of noise. Noise is
often modeled using Brownian motion or the Wiener process. The standard Wiener
process is denoted by ( )W t . It is a stochastic process defined on the interval [0, ]T with
the following properties:
(1) (0) 0W =
(2) For 0 s t T≤ < ≤ ,
( ) ( ) (0,1)W t W s t sN− −:
where (0,1)N is a normal distribution with mean 0 and variance 1.
(3) For 0 s t u v T≤ < < < ≤ , ( ) ( )W t W s− and ( ) ( )W v W u− are independent.
To simulate this process in Matlab, note that randn generates a realization of the
distribution (0,1)N .
- 13 -
Worksheet 10: Kinetics
This noise process can be added to a deterministic differential equation in the following
way
2
2 4
1 2
1 ( )
1 (1 )
dx x
x t
dt x x
α
γ ξ
σ σ
= − + +
+ + +
where we dropped the “tilde” throughout. The term ( )tξ is white noise. Its mean is 0 and
its covariance is cov( ( ), ( ')) ( ')t t D t tξ ξ δ= − where D is proportional to the strength of
perturbation. We can also write formally
( )
dW
t D
dt
ξ =
(This is only a formal derivative since the derivative of the Wiener process does not exist
with probability 1.)
- 14 -
%Simulation of the Wiener process brown.m
T=1;
n=500;
dt=T/n;
randn('state',100); %initializing random number generator
dW=sqrt(dt)*randn(1,n); %generating increments
W=cumsum(dW); %computing cumulative sum
plot([0:dt:T],[0,W],'-k');
xlabel('Time t'); ylabel('W(t)');

Weitere ähnliche Inhalte

Was ist angesagt?

Nonlinear Electromagnetic Response in Quark-Gluon Plasma
Nonlinear Electromagnetic Response in Quark-Gluon PlasmaNonlinear Electromagnetic Response in Quark-Gluon Plasma
Nonlinear Electromagnetic Response in Quark-Gluon PlasmaDaisuke Satow
 
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...ijrap
 
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...IOSR Journals
 
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...ijrap
 
SU2_covariant_Dirac_eqn_invert
SU2_covariant_Dirac_eqn_invertSU2_covariant_Dirac_eqn_invert
SU2_covariant_Dirac_eqn_invertShaun Inglis
 
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...Lumen Learning
 
AP Chemistry Chapter 14 Sample Exercises
AP Chemistry Chapter 14 Sample ExercisesAP Chemistry Chapter 14 Sample Exercises
AP Chemistry Chapter 14 Sample ExercisesJane Hamze
 
Research paper 1
Research paper 1Research paper 1
Research paper 1anissa098
 
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...SEENET-MTP
 
Stringhighlights2015
Stringhighlights2015Stringhighlights2015
Stringhighlights2015foxtrot jp R
 
Casimir energy for a double spherical shell: A global mode sum approach
Casimir energy for a double spherical shell: A global mode sum approachCasimir energy for a double spherical shell: A global mode sum approach
Casimir energy for a double spherical shell: A global mode sum approachMiltão Ribeiro
 
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...ijrap
 
Investigation of mgx sr1 xo mixed alloy under high pressure
Investigation of mgx sr1 xo mixed alloy under high pressureInvestigation of mgx sr1 xo mixed alloy under high pressure
Investigation of mgx sr1 xo mixed alloy under high pressureAlexander Decker
 
Dealinggreensfncsolft sqrdb
Dealinggreensfncsolft sqrdbDealinggreensfncsolft sqrdb
Dealinggreensfncsolft sqrdbfoxtrot jp R
 

Was ist angesagt? (20)

Nonlinear Electromagnetic Response in Quark-Gluon Plasma
Nonlinear Electromagnetic Response in Quark-Gluon PlasmaNonlinear Electromagnetic Response in Quark-Gluon Plasma
Nonlinear Electromagnetic Response in Quark-Gluon Plasma
 
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...
Bound- State Solution of Schrodinger Equation with Hulthen Plus Generalized E...
 
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...
The characteristics of SecondaryCharged Particlesproduced in 4.5 A GeV/c 28Si...
 
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...
Exact Solutions of the Klein-Gordon Equation for the Q-Deformed Morse Potenti...
 
SU2_covariant_Dirac_eqn_invert
SU2_covariant_Dirac_eqn_invertSU2_covariant_Dirac_eqn_invert
SU2_covariant_Dirac_eqn_invert
 
Powder
PowderPowder
Powder
 
Acoustics ans
Acoustics ansAcoustics ans
Acoustics ans
 
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...
Chem 2 - Chemical Equilibrium III: The Equilibrium Constant Expression and th...
 
AP Chemistry Chapter 14 Sample Exercises
AP Chemistry Chapter 14 Sample ExercisesAP Chemistry Chapter 14 Sample Exercises
AP Chemistry Chapter 14 Sample Exercises
 
Research paper 1
Research paper 1Research paper 1
Research paper 1
 
en_qu_sch
en_qu_schen_qu_sch
en_qu_sch
 
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...
I. Cotaescu - "Canonical quantization of the covariant fields: the Dirac fiel...
 
Stringhighlights2015
Stringhighlights2015Stringhighlights2015
Stringhighlights2015
 
Casimir energy for a double spherical shell: A global mode sum approach
Casimir energy for a double spherical shell: A global mode sum approachCasimir energy for a double spherical shell: A global mode sum approach
Casimir energy for a double spherical shell: A global mode sum approach
 
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...
ANALYTICAL SOLUTIONS OF THE MODIFIED COULOMB POTENTIAL USING THE FACTORIZATIO...
 
Investigation of mgx sr1 xo mixed alloy under high pressure
Investigation of mgx sr1 xo mixed alloy under high pressureInvestigation of mgx sr1 xo mixed alloy under high pressure
Investigation of mgx sr1 xo mixed alloy under high pressure
 
Solutions manual
Solutions manualSolutions manual
Solutions manual
 
HashiamKadhimFNLHD
HashiamKadhimFNLHDHashiamKadhimFNLHD
HashiamKadhimFNLHD
 
Dealinggreensfncsolft sqrdb
Dealinggreensfncsolft sqrdbDealinggreensfncsolft sqrdb
Dealinggreensfncsolft sqrdb
 
DL_FinalProposal
DL_FinalProposalDL_FinalProposal
DL_FinalProposal
 

Ähnlich wie 33208 10 modeling_biochemical_networks

Mathematical models for a chemical reactor
Mathematical models for a chemical reactorMathematical models for a chemical reactor
Mathematical models for a chemical reactorLuis Rodríguez
 
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...Crimsonpublishers-Mechanicalengineering
 
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONS
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONSAPPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONS
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONSAYESHA JAVED
 
2 classical field theories
2 classical field theories2 classical field theories
2 classical field theoriesSolo Hermelin
 
Linear regression [Theory and Application (In physics point of view) using py...
Linear regression [Theory and Application (In physics point of view) using py...Linear regression [Theory and Application (In physics point of view) using py...
Linear regression [Theory and Application (In physics point of view) using py...ANIRBANMAJUMDAR18
 
Reaction Kinetics
Reaction KineticsReaction Kinetics
Reaction Kineticsmiss j
 
11 - 3 Experiment 11 Simple Harmonic Motio.docx
11  -  3       Experiment 11 Simple Harmonic Motio.docx11  -  3       Experiment 11 Simple Harmonic Motio.docx
11 - 3 Experiment 11 Simple Harmonic Motio.docxtarifarmarie
 
determinants-160504230830_repaired.pdf
determinants-160504230830_repaired.pdfdeterminants-160504230830_repaired.pdf
determinants-160504230830_repaired.pdfTGBSmile
 
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTOR
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTORADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTOR
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTORijcseit
 
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhg
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhgDigital Logic.pptxghuuhhhhhhuu7ffghhhhhg
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhgAnujyotiDe
 

Ähnlich wie 33208 10 modeling_biochemical_networks (20)

Mathematical models for a chemical reactor
Mathematical models for a chemical reactorMathematical models for a chemical reactor
Mathematical models for a chemical reactor
 
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...
Anomalous Diffusion Through Homopolar Membrane: One-Dimensional Model_ Crimso...
 
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONS
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONSAPPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONS
APPLICATION OF HIGHER ORDER DIFFERENTIAL EQUATIONS
 
Chemical kinetics
Chemical kineticsChemical kinetics
Chemical kinetics
 
2 classical field theories
2 classical field theories2 classical field theories
2 classical field theories
 
Artigo woodward hoffman
Artigo woodward hoffmanArtigo woodward hoffman
Artigo woodward hoffman
 
Linear regression [Theory and Application (In physics point of view) using py...
Linear regression [Theory and Application (In physics point of view) using py...Linear regression [Theory and Application (In physics point of view) using py...
Linear regression [Theory and Application (In physics point of view) using py...
 
Ch 15 Web
Ch 15 WebCh 15 Web
Ch 15 Web
 
Reaction Kinetics
Reaction KineticsReaction Kinetics
Reaction Kinetics
 
1 s2.0-0378381289800731-main
1 s2.0-0378381289800731-main1 s2.0-0378381289800731-main
1 s2.0-0378381289800731-main
 
11 - 3 Experiment 11 Simple Harmonic Motio.docx
11  -  3       Experiment 11 Simple Harmonic Motio.docx11  -  3       Experiment 11 Simple Harmonic Motio.docx
11 - 3 Experiment 11 Simple Harmonic Motio.docx
 
determinants-160504230830_repaired.pdf
determinants-160504230830_repaired.pdfdeterminants-160504230830_repaired.pdf
determinants-160504230830_repaired.pdf
 
determinants-160504230830.pdf
determinants-160504230830.pdfdeterminants-160504230830.pdf
determinants-160504230830.pdf
 
Determinants
DeterminantsDeterminants
Determinants
 
Ijciet 10 01_093
Ijciet 10 01_093Ijciet 10 01_093
Ijciet 10 01_093
 
PosterDinius
PosterDiniusPosterDinius
PosterDinius
 
Kalman_Filter_Report
Kalman_Filter_ReportKalman_Filter_Report
Kalman_Filter_Report
 
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTOR
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTORADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTOR
ADAPTIVE STABILIZATION AND SYNCHRONIZATION OF LÜ-LIKE ATTRACTOR
 
10 slides
10 slides10 slides
10 slides
 
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhg
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhgDigital Logic.pptxghuuhhhhhhuu7ffghhhhhg
Digital Logic.pptxghuuhhhhhhuu7ffghhhhhg
 

Kürzlich hochgeladen

Computer Lecture 01.pptxIntroduction to Computers
Computer Lecture 01.pptxIntroduction to ComputersComputer Lecture 01.pptxIntroduction to Computers
Computer Lecture 01.pptxIntroduction to ComputersMairaAshraf6
 
DeepFakes presentation : brief idea of DeepFakes
DeepFakes presentation : brief idea of DeepFakesDeepFakes presentation : brief idea of DeepFakes
DeepFakes presentation : brief idea of DeepFakesMayuraD1
 
Standard vs Custom Battery Packs - Decoding the Power Play
Standard vs Custom Battery Packs - Decoding the Power PlayStandard vs Custom Battery Packs - Decoding the Power Play
Standard vs Custom Battery Packs - Decoding the Power PlayEpec Engineered Technologies
 
Online food ordering system project report.pdf
Online food ordering system project report.pdfOnline food ordering system project report.pdf
Online food ordering system project report.pdfKamal Acharya
 
Introduction to Serverless with AWS Lambda
Introduction to Serverless with AWS LambdaIntroduction to Serverless with AWS Lambda
Introduction to Serverless with AWS LambdaOmar Fathy
 
Online electricity billing project report..pdf
Online electricity billing project report..pdfOnline electricity billing project report..pdf
Online electricity billing project report..pdfKamal Acharya
 
Hospital management system project report.pdf
Hospital management system project report.pdfHospital management system project report.pdf
Hospital management system project report.pdfKamal Acharya
 
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...Call Girls Mumbai
 
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...drmkjayanthikannan
 
Work-Permit-Receiver-in-Saudi-Aramco.pptx
Work-Permit-Receiver-in-Saudi-Aramco.pptxWork-Permit-Receiver-in-Saudi-Aramco.pptx
Work-Permit-Receiver-in-Saudi-Aramco.pptxJuliansyahHarahap1
 
PE 459 LECTURE 2- natural gas basic concepts and properties
PE 459 LECTURE 2- natural gas basic concepts and propertiesPE 459 LECTURE 2- natural gas basic concepts and properties
PE 459 LECTURE 2- natural gas basic concepts and propertiessarkmank1
 
Thermal Engineering -unit - III & IV.ppt
Thermal Engineering -unit - III & IV.pptThermal Engineering -unit - III & IV.ppt
Thermal Engineering -unit - III & IV.pptDineshKumar4165
 
Thermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VThermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VDineshKumar4165
 
School management system project Report.pdf
School management system project Report.pdfSchool management system project Report.pdf
School management system project Report.pdfKamal Acharya
 
Moment Distribution Method For Btech Civil
Moment Distribution Method For Btech CivilMoment Distribution Method For Btech Civil
Moment Distribution Method For Btech CivilVinayVitekari
 
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdfAldoGarca30
 

Kürzlich hochgeladen (20)

Integrated Test Rig For HTFE-25 - Neometrix
Integrated Test Rig For HTFE-25 - NeometrixIntegrated Test Rig For HTFE-25 - Neometrix
Integrated Test Rig For HTFE-25 - Neometrix
 
Computer Lecture 01.pptxIntroduction to Computers
Computer Lecture 01.pptxIntroduction to ComputersComputer Lecture 01.pptxIntroduction to Computers
Computer Lecture 01.pptxIntroduction to Computers
 
DeepFakes presentation : brief idea of DeepFakes
DeepFakes presentation : brief idea of DeepFakesDeepFakes presentation : brief idea of DeepFakes
DeepFakes presentation : brief idea of DeepFakes
 
Standard vs Custom Battery Packs - Decoding the Power Play
Standard vs Custom Battery Packs - Decoding the Power PlayStandard vs Custom Battery Packs - Decoding the Power Play
Standard vs Custom Battery Packs - Decoding the Power Play
 
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak HamilCara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
Cara Menggugurkan Sperma Yang Masuk Rahim Biyar Tidak Hamil
 
Online food ordering system project report.pdf
Online food ordering system project report.pdfOnline food ordering system project report.pdf
Online food ordering system project report.pdf
 
Introduction to Serverless with AWS Lambda
Introduction to Serverless with AWS LambdaIntroduction to Serverless with AWS Lambda
Introduction to Serverless with AWS Lambda
 
Online electricity billing project report..pdf
Online electricity billing project report..pdfOnline electricity billing project report..pdf
Online electricity billing project report..pdf
 
FEA Based Level 3 Assessment of Deformed Tanks with Fluid Induced Loads
FEA Based Level 3 Assessment of Deformed Tanks with Fluid Induced LoadsFEA Based Level 3 Assessment of Deformed Tanks with Fluid Induced Loads
FEA Based Level 3 Assessment of Deformed Tanks with Fluid Induced Loads
 
Call Girls in South Ex (delhi) call me [🔝9953056974🔝] escort service 24X7
Call Girls in South Ex (delhi) call me [🔝9953056974🔝] escort service 24X7Call Girls in South Ex (delhi) call me [🔝9953056974🔝] escort service 24X7
Call Girls in South Ex (delhi) call me [🔝9953056974🔝] escort service 24X7
 
Hospital management system project report.pdf
Hospital management system project report.pdfHospital management system project report.pdf
Hospital management system project report.pdf
 
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...
Bhubaneswar🌹Call Girls Bhubaneswar ❤Komal 9777949614 💟 Full Trusted CALL GIRL...
 
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...
Unit 4_Part 1 CSE2001 Exception Handling and Function Template and Class Temp...
 
Work-Permit-Receiver-in-Saudi-Aramco.pptx
Work-Permit-Receiver-in-Saudi-Aramco.pptxWork-Permit-Receiver-in-Saudi-Aramco.pptx
Work-Permit-Receiver-in-Saudi-Aramco.pptx
 
PE 459 LECTURE 2- natural gas basic concepts and properties
PE 459 LECTURE 2- natural gas basic concepts and propertiesPE 459 LECTURE 2- natural gas basic concepts and properties
PE 459 LECTURE 2- natural gas basic concepts and properties
 
Thermal Engineering -unit - III & IV.ppt
Thermal Engineering -unit - III & IV.pptThermal Engineering -unit - III & IV.ppt
Thermal Engineering -unit - III & IV.ppt
 
Thermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - VThermal Engineering-R & A / C - unit - V
Thermal Engineering-R & A / C - unit - V
 
School management system project Report.pdf
School management system project Report.pdfSchool management system project Report.pdf
School management system project Report.pdf
 
Moment Distribution Method For Btech Civil
Moment Distribution Method For Btech CivilMoment Distribution Method For Btech Civil
Moment Distribution Method For Btech Civil
 
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
1_Introduction + EAM Vocabulary + how to navigate in EAM.pdf
 

33208 10 modeling_biochemical_networks

  • 1. Created by: Claudia Neuhauser Worksheet 10: Kinetics Modeling Chemical Reactions The law of mass action has its origin in modeling chemical reactions. Consider the chemical reaction between the molecules of type A and B: CBA k →+ The quantities A and B on the left-hand side are called the reactants; the quantity C is called the product. The parameter k is the rate constant. A macroscopic model of this reaction assumes that the concentrations and reaction constants are well-defined. Furthermore, the concentrations vary deterministically and continuously. This leads us to describing the reaction by a differential equation. We model this reaction as (1) ]][[ ][ BAk dt Cd = where brackets denote concentrations. The idea behind this law is that this reaction rate depends on how often the molecules A and B collide. In a well-mixed vessel, this collision rate is proportional to the product of the concentrations of A and B, denoted by [A] and [B], respectively. The law of mass action is not a law in the strict sense, but it is a good approximation when the assumptions for the macroscopic model description hold. To determine the units of the rate constant, we compare the left-hand side and the right-hand side of Equation (1). The concentration of the reactants A and B and the product C are measured in [moles/liter]. Hence, the unit on the left-hand side is [moles/liter][time]-1 . On the right-hand side, the unit of [A][B] is [moles/liter]2 . Hence, the unit of k must be [moles/liter]-1 [time]-1 . Task 1 Consider the following chemical reaction → k A B (a) Use the macroscopic modeling approach and determine the differential equation that describes how the concentration of B changes over time. (b) Use the macroscopic modeling approach and determine the differential equation that describes how the concentration of A changes over time. (c) What are the units of k if the concentrations of A and B are measured in [moles/liter]? Chemical reactions may be linked. For instance, consider the set of chemical reactions 1 2 3 2 k k k A B C C B D D A + → → + → - 1 -
  • 2. Worksheet 10: Kinetics There are four types of molecules. To describe the changes in concentration of these four molecules, we need four differential equations. (2) 1 3 2 1 2 2 1 2 2 2 3 [ ] [ ][ ] [ ] [ ] [ ][ ] [ ] [ ] [ ][ ] 2 [ ] [ ] [ ] [ ] d A k A B k D dt d B k A B k C dt d C k A B k C dt d D k C k D dt = − + = − + = − = − Task 2 Determine the units of the rate constants 1k , 2k and 3k in Equation (2). Task 3 Consider the following set of chemical reactions 1 2 3 3 2 2 4 k k k A B B A C C A → → + → Assume that the assumptions for the macroscopic modeling apply. Find the system of differential equations that describes these chemical reactions. Determine the units of the rate constants 1k , 2k and 3k . Enzymatic Reactions Many biochemical reactions utilize enzymes. An enzymatic reaction that transforms the substrate S into a product P requires the formation of a complex C between the substrate and the enzyme E. After formation of the product P, the enzyme E is released. This is summarized in the reaction 1 2 1 k k k S E C P E − →+ → +¬  We assume that the reaction from substrate plus enzyme to substrate/enzyme complex occurs at rate 1k and the reverse reaction at rate 1−k . The reaction from the substrate/enzyme complex to the product plus enzyme occurs at rate 2k . Models for this - 2 -
  • 3. Worksheet 10: Kinetics reaction were first studied by Michaelis and Menten (1913)1 under simplified assumptions. A more realistic model was developed by Briggs and Haldane (1925)2 , which is still the basis for models of more complicated enzymatic reactions. If we use the notation ][],[],[ CcEeSs === , and ][Pp = , then an application of the mass action law yields ( ) ( ) ck dt dp ckksek dt dc sekckk dt de sekck dt ds 2 121 121 11 = +−= −+= −= − − − We see from this system of equations that 0=+ dt dc dt de . This implies that constant,e c+ = and we say that ce + is a conserved quantity. At time 0, we assume that ,0,, 00 === ceess and 0=p . This implies that the constant ce + is equal to 0e . Since cee −= 0 , we no longer need an equation for the enzyme concentration e. This reduces the system to three equations. Using cee −= 0 , we can write the first two equations of the system of differential equations so that they will only contain the variables s and c: ckkcesk dt dc ceskck dt ds )()( )( 1201 011 − − +−−= −−= Rearranging terms, the system of three equations can be written as (3) ( ) ( ) 1 1 1 0 2 1 1 1 0 2 ds k k s c k e s dt dc k k k s c k e s dt dp k c dt − − = + − = − + + + = 1 Michaelis, L. and M.I. Menten. 1913. Die Kinetik der Invertinwirkung. Biochem. Z. 49: 333-369. 2 Briggs, G.E. and J.B.S. Haldane. 1925. A note on the kinematics of enzyme actions. Biochemical Journal 19: 338-339. - 3 -
  • 4. Worksheet 10: Kinetics with initial conditions 0(0)s s= , 0(0)c c= , and 0(0)p p= . The following Matlab code solves these three equations with the given initial condition and rate constants. - 4 - % Solving the Michaelis-Menten Model mm.m k1=1e3; km1=1; k2=0.05; e0=0.5e-3; options=[]; [t,y]=ode23(@mmfunc,[0,1000],[1e-3 0 0],options,k1,km1,k2,e0); s=y(:,1); c=y(:,2); e=e0-c; p=y(:,3); semilogx(t,s,'r',t,e,'b',t,c,'g',t,p,'c'); legend('[S]','[E]','[C]','[P]'); % Michaelis-Menten Function mmfunc.m function dydt = f(t,y,k1,km1,k2,e0) % s=y(1), c=y(2), p=y(3) dydt=zeros(3,1); dydt(1) = (km1+k1*y(1))*y(2)-k1*e0*y(1); dydt(2) = -(k2+km1+k1*y(1))*y(2)+k1*e0*y(1); dydt(3) = k2*y(2);
  • 5. Worksheet 10: Kinetics 10 -1 10 0 10 1 10 2 10 3 -2 0 2 4 6 8 10 12 x 10 -4 time concentration [S] [E] [C] [P] Figure 1: Time dependence of the solution of the Michaelis-Menten model with parameters given in the Matlab code. We see that eventually all the substrate is used up and the reaction ceases. That is, as t → ∞ , 0s c= = , 0e e= , and 0p s= . Analytical Solution under Quasi-steady State Approximation To analyze this system further, we will use the technique of non-dimensionalization. The idea is to change the variables appropriately so that they are dimensionless. There is no unique way of doing this and it takes experience and intuition on how to proceed. Segel (1972)3 wrote an excellent article on the art of scaling and simplification. We start by dividing the differential equations for s and c by 001 sek : ( ) ( ) 1 1 1 0 0 1 0 0 0 2 1 1 1 0 0 1 0 0 0 k k sds s c k e s dt k e s s k k k sdc s c k e s dt k e s s − − + = − + + = − + 3 Segel, L.A. 1972. Simplification and Scaling. SIAM Rev. 14: 547-571. - 5 -
  • 6. Worksheet 10: Kinetics If we set 0s s =σ and 0e c x = , then σσ σσ σ +− + −= −      += − − xx sk kk dtsk dx x sk k dtek d 01 12 01 01 1 01 Let’s change the time scale and introduce tek 01=τ , then, with 0 0 s e =ε , we have x sk kk d dx x sk k d d       + + −= −      += − − σσ τ ε σσ τ σ 01 12 01 1 If we set 01 12 sk kk −+ =κ and 01 1 sk k− =α , then ( ) ( )x d dx x d d σκσ τ ε σσα τ σ +−= −+= Quasi-steady State Approximation In biochemical reactions, typically, e0 is much smaller than s0, which makes ε a very small quantity. It follows that τ ε d dx is close to 0 and this insight was used by Briggs and Haldane (1925) to justify the “quasi-steady state approximation” 0= τ ε d dx . It follows that σκ σ + =x and hence σ σκ σ σα τ σ − + += )( d d - 6 -
  • 7. Worksheet 10: Kinetics or, after simplifying, σκ σακ τ σ + − −= )( d d Now, 0 01 2 >=− sk k ακ and we set ακ −=q . Then σκ σ τ σ + −= q d d Using the original variables, we find for the velocity of the reaction (4) sK sv dt ds dt dp V m m + =−== where 1 21 k kk Km + = − is the half-saturation constant and 02ekvm = is the maximal reaction rate. Equation (4) is the classical Michaelis-Menten equation. This equation models the initial rate at which substrate is converted into the product. During this initial period, the formation and the break-up of the enzyme-substrate complex reaches a quasi- steady state before product formation becomes noticeable. Lineweaver-Burk transformation The function sK sv V m m + = is called the Michaelis-Menten function. It is an important function and it is used to fit data to determine mv and mK . To determine mv and mK , the Lineweaver-Burk transformation is frequently applied. Writing mm m vsv K V 111 += we see that in a graph where the horizontal axis is 1/s and the vertical axis is 1/V, the relationship is a straight line. The intercepts allow us to estimate mv and mK . Reading Assignment (due on _________________________) Read the paper by Hasty et al. 2000. - 7 -
  • 8. Worksheet 10: Kinetics Computer Lab (Homework due _________________________) Step 1 The following data set describes the degradation of a substance with concentration s. The velocity of the reaction V as a function of s was measured. Use the Lineweaver-Burk transformation mm m vsv K V 111 += to find mv and mK . That is, plot 1/V as a function of 1/s and use a regression line to find the equation of the straight line fitted to this transformed data. Use the equation to then find the two parameters mv and mK . Velocity V Substrate Concentration s 0.025 0.04 0.033 0.07 0.042 0.12 0.081 0.25 0.11 0.42 0.175 0.8 0.17 0.92 0.2 1.7 0.21 2.9 0.22 4.3 Step 2 The half-saturation constant Km is called the affinity. We found 1 21 k kk Km + = − Use EXCEL to graph Km as a function of k1 and use calculus to show that Km is a decreasing function of k1, i.e., differentiate Km with respect to k1, and show that the derivative is negative. (For the graph, set 1 0.05k− = and 2 0.5k = and let 1k vary between 0.3 and 5.0 in steps of 0.1.) Step 3 (a) Set 0.2mv = , 0.3mK = , and (0) 1s = . Use the Euler method to numerically approximate the solution of sK sv dt ds m m + −= for [0,20]t ∈ (set the step size equal to 0.01). - 8 -
  • 9. Worksheet 10: Kinetics (b) Now vary Km between 0.1 and 0.9 (stepsize equal to 0.2). For each value of Km, find the time at which the concentration of the substrate is half its initial value (i.e., 0.5). Graph this time as a function of Km and use a linear regression line to predict the time when 1.3mK = . Check your prediction using the numerical approximation. Step 4 Complete Tasks 1-3. - 9 -
  • 10. Worksheet 10: Kinetics Gene Regulatory Networks Cells control their functions through regulating gene expressions. Many of these regulatory processes are at the level of gene transcription. A common framework for modeling these interactions is biochemical reactions. This deterministic framework ignores fluctuations and can be considered as describing the time evolution of the means of various quantities of interest. We will use the example given in Hasty et al. (2000)4 to introduce this kind of modeling. Their work is motivated by the lysis-lysogeny decision of the bacterial phage lambda. Their first model, which we will study, is a mutant system with two operators, OR2 and OR3. The gene encodes for a repressor protein that dimerizes and binds to either operator. The dimerized protein enhances transcription if it binds to OR2, and represses transcription when it binds to OR3. We use the notation in Hasty et al. to explain the dynamics. We denote by X the repressor, by X2 the dimerized repressor, and by D the DNA promoter site. Then (5) 1 2 3 4 2 2 2 * 2 2 2 2 2 2 2 K K K K X X D X DX D X DX DX X DX X →¬  →+ ¬  →+ ¬  →+ ¬  Here, 2DX and * 2DX denote the dimerized proteins that bind to OR2 and OR3, respectively. 2 2DX X denotes binding to both operators. The constants iK are forward equilibrium constants. That is, if a biochemical reaction is described by 1 1 k k A B − →¬  then, the corresponding rate equation is 1 1 [ ] [ ] [ ] d A k A k B dt −= − + and at equilibrium, 1 1 [ ] [ ] k B A k− = The forward equilibrium constant would be 1 1 1 k K k− = . 4 Hasty, J., J. Pradines, M. Dolnik, and J.J. Collins. 2000. Noise-based switches and amplifiers for gene expression. PNAS, 97(5): 2075-2080. - 10 -
  • 11. Worksheet 10: Kinetics The reactions in (5) are fast compared to transcription and degradation, the slow reactions. These are given by (6) 2 2 t d k k DX P DX P nX X A + → + + → where P is the concentration of RNA polymerase and n is the number of proteins per mRNA transcript. Note that the arrows in these two reactions only point in one direction, reflecting that these reactions are irreversible. Hasty et al. (2000) considered an in vitro system where this small gene regulatory network is contained in a plasmid and the whole system contains a large number of plasmids to justify the rate equation approach. We define the following variables: [ ]x X= , 2[ ]y X= , [ ]d D= , 2[ ]u DX= , * 2[ ]v DX= , and 2 2[ ]z DX X= . Then the evolution of the repressor protein is given by (7) 2 1 1 02 2 t d dx k x k y nk p u k x r dt −= − + + − + where r is the expression rate of the gene in the absence of transcription factors. Assuming that the reaction in (5) are fast compared to the ones in (6), we can again use a quasi-steady state approach and assume that the reactions in (5) are at equilibrium. We assume that 3 1 2K Kσ= and 3 2 2K Kσ= . This implies that ( ) 2 1 2 2 1 2 2 1 2 1 1 2 2 4 2 2 2 1 2 y K x u K dy K K dx v K dy K K dx z K uy K K dx σ σ σ σ = = = = = = = It is further assumed that the total concentration of DNA promoter sites, denoted by Td , is constant. That is, 2 2 2 4 1 1 2 2 1 21 (1 )Td d u v z d K K x K K xσ σ = + + + = + + +  It can be shown that Equation (7) simplifies to (8) 2 2 4 1 2 1 1 (1 ) dx x x dt x x α γ σ σ = − + + + + % % % % % % - 11 -
  • 12. Worksheet 10: Kinetics where 1 2x x K K=% , 1 2( )t t r K K=% , 0 /t Tnk p d rα = , and 1 2/( )dk r K Kγ = . To find equilibria, we set the right hand side of (8) equal to 0. that is, { 2 2 4 1 2 ( ) ( ) 1 1 (1 ) g x f x x x x x α γ σ σ = − + + + % % % % % % 144424443 If we plot ( )f x and ( )g x in the same coordinate system, the points of intersection are the respective equilibria. The following Matlab program both solves the differential equation (6) and plots the two functions ( )f x and ( )g x in the same coordinate system. We will investigate this model for different values of γ to understand Figure 1 in Hasty et al. - 12 - % Solving the Hasty Model hasty.m alpha=50; gamma=5; sigma1=1; sigma2=5; options=[]; [t1,y1]=ode23(@hastyfunc,[0,10],[0],options,alpha,gamma,sigma1,sigma2); [t2,y2]=ode23(@hastyfunc,[0,10],[1],options,alpha,gamma,sigma1,sigma2); x=0:0.01:2; f=alpha*x.^2./(1+(1+sigma1)*x.^2+sigma2*x.^4); g=gamma*x-1; subplot(1,2,1), plot(x,f,'k',x,g,':k'); xlabel('repressor concentration');ylabel('f(x) and g(x)');legend('f(x)','g(x)');title('Equilibria'); subplot(1,2,2), plot(t1,y1,'--k',t2,y2,'k'); xlabel('time');ylabel('repressor concentration');legend('x(0)=0','x(0)=1');title('Dynamics'); % Hasty Model hastyfunc.m function dydt = f(t,y,alpha,gamma,sigma1,sigma2) % x=y(1) dydt=alpha*y(1)^2/(1+(1+sigma1)*y(1)^2+sigma2*y(1)^4)-gamma*y(1)+1;
  • 13. Worksheet 10: Kinetics Task 4 Use the Matlab code and simulate the model for 13γ = , 15, and 17. Relate the outcome of your simulations to Figure 1B (mutant case). Figure 2: Figure 1B from Hasty et al. 2000 Introducing Noise (Optional) Hasty et al. introduce noise into this system. While we will not numerically solve the dynamics of the other models in this paper, we will introduce the notion of noise. Noise is often modeled using Brownian motion or the Wiener process. The standard Wiener process is denoted by ( )W t . It is a stochastic process defined on the interval [0, ]T with the following properties: (1) (0) 0W = (2) For 0 s t T≤ < ≤ , ( ) ( ) (0,1)W t W s t sN− −: where (0,1)N is a normal distribution with mean 0 and variance 1. (3) For 0 s t u v T≤ < < < ≤ , ( ) ( )W t W s− and ( ) ( )W v W u− are independent. To simulate this process in Matlab, note that randn generates a realization of the distribution (0,1)N . - 13 -
  • 14. Worksheet 10: Kinetics This noise process can be added to a deterministic differential equation in the following way 2 2 4 1 2 1 ( ) 1 (1 ) dx x x t dt x x α γ ξ σ σ = − + + + + + where we dropped the “tilde” throughout. The term ( )tξ is white noise. Its mean is 0 and its covariance is cov( ( ), ( ')) ( ')t t D t tξ ξ δ= − where D is proportional to the strength of perturbation. We can also write formally ( ) dW t D dt ξ = (This is only a formal derivative since the derivative of the Wiener process does not exist with probability 1.) - 14 - %Simulation of the Wiener process brown.m T=1; n=500; dt=T/n; randn('state',100); %initializing random number generator dW=sqrt(dt)*randn(1,n); %generating increments W=cumsum(dW); %computing cumulative sum plot([0:dt:T],[0,W],'-k'); xlabel('Time t'); ylabel('W(t)');