Modeling Addiction with SIR Models and Di usion. David Zimmerman

Size: px
Start display at page:

Download "Modeling Addiction with SIR Models and Di usion. David Zimmerman"

Transcription

1 Modeling Addiction with SIR Models and Di usion David Zimmerman MTH 496: Senior Project Advisor: Dr. Shawn Ryan Spring

2 Abstract Contents 1 Introduction SIR Models Modeling Addiction Wangari-Stone Model Saturation Treatment Function Calculating Rate of Spread Qualitative Behavior Boundedness Fixed Points Bifurcations Bifurcations in Wangari-Stone Model Stability Modeling Spatial Interaction with Di usion Adding A Spatial Element to Our Model Reaction-Di usion Model Numerical Solution to Di usion Model Numerical Example Code Density Map Introduction 1.1 SIR Models A SIR Model is a compartmental ODE model for the spreading of disease. It compartmentalizes a population into three basic groups: S for those who are susceptible to a disease, I for those who are infected, R for those who are recovered, and N to represent the population. The transition rate from S to I is proportional to the product of the values of each. This is e ectively the law of mass action. 8 Ṡ = IS >< İ = IS I >: Ṙ = I It is assumed that each member of the population always transitions from S to I to R. Also, once you are recovered you cannot become susceptible again. 2

3 S I R The most basic SIR model is said to lack vital dynamics, meaning that births and deaths in the population are not considered. This is an example of a conservative system. Mathematically, we would say that the population N does not change in time and that dn = ds dt dt + di dt + dr dt = 0. We can easily modify this model to fit a di erent situation. What if, for example, once you are recovered you could become susceptible again? This situation assumes no immunity is obtained after infection and is modeled 8 Ṡ = IS + R >< İ = IS I. >: Ṙ = I R If we allow those who are recovered to become susceptible again our flow chart is cyclic. This modified version is often called an SIRS model. S R I We can also consider vital dynamics. If we enforce that the rate at which the population becomes susceptible (this could be the same the rate of birth) is equal to the mortality rate then we preserve the conservative nature of the system. 1.2 Modeling Addiction We can use a compartmental model of ODEs to describe the dynamics of substance addiction. It is reasonable to assume that the law of mass action still applies to the spread of addiction; someone must come into contact with an addict before they assume addiction. Addicts can die from overdosing, natural causese, or from other complications involving drug abuse and they can also recover. An interesting question would be if recovered addicts can become susceptible again or even more susceptible than they were before they became addicted. The model considered in the next section assumes that once you are recovered you cannot be susceptible again but can resume heroin use before the end of a treatment period. This situation is described with another modified SIR model where vital dynamics are considered. 3

4 1.3 Wangari-Stone Model The heroin epidemic model formulated by Wangari/Stone is considered here without alteration. The population is separated into four classes: S, susceptibles, U 1, heroin users not receiving treatment, U 2, heroin uses receiving treatment, and U 3, those successfully treated from heroin use. The following is assumed: 1. Individuals in all classes freely interact with one another 2. Addicts in treatment may or may not still be using heroin 3. Herion users in treatment relapse to heroin users not in treatment due to a decision to selfterminate treatment 4. Heroin users are separated from the population (e.g., treatment facility) and do not a ect susceptibles. Below is our model reflecting these assumptions: 8 Ṡ = U 1 S µs >< U 1 = U 1 S + U 2 (µ )U 1 T(U 1 ) U 2 = T(U 1 ) ( µ)u 2 >: U 3 = U 2 + U 1 µu 3 (1) The parameters and key quantities of system (1) are defined in the following table Parameter Description The rate at which individuals in a general population enter the system via the susceptible population (e.g., Births, coming of age) Contact rate between susceptibles and heroin users not receving treatment µ Death rate due to natural causes Rate at which those undergoing treatment relapse to heroin use Self-cure rate. Rate at which users recover without receiving treatment 1 Heroin related death rate of heroin users not in treatment 2 Heroin related death rate of heroin users in treatment Rate at which heroin users in treatment are successfully detoxified and cured from heroin use Rate at which heroin users are treated! The extent of saturation of heroin users within the community 4

5 Figure 1: Wangari-Stone Model 1.4 Saturation Treatment Function We have not yet defined the function T(U 1 ). This is the treatment function, or the rate at which users receive treatment. T(U 1 ) U 1 1 +!U 1 and we call this the saturation treatment function. This function is formulated by borrowing an idea from Michaelis-Menten kinetics. The rate that users are treated should depend on the availability of treatment and that rate should decrease as more resources are in use. When U 1 is small, treatment is approximately linear. T(U 1 ) U 1. When U 1 >> 1, T(U 1 )!, indicating that treatment centers are at capacity and the rate of treatment does not increase with the number of drug users. This feature is called saturation. 1.5 Calculating Rate of Spread Epidemiologists denote the number of secondary infections brought on by a single infective person by R 0 and call this the Basic Reproduction Number. In this context, we will interpret this as the expected value of secondary individuals infected by a single infected person. If this number is less than one, meaning you are unlikely to infect even one person, the disease (or addiction in our case) in the population is eradicated. Otherwise, the disease will spread. We can begin to calculate this number by observing that the average time an individual uses heroin is given by the formula 5

6 1 T 0 = µ The parameters µ, 1,, and all describe rates at which one exits the phase of untreated heroin use and have units 1. Hence this formula is the harmonic mean of these rates. Next, the probability time of surviving this period and receiving treatment is given by T 1 = T 0. The probability of surviving the heroin users in treatment phase and relapsing to heroin use is given by the rate at which heroin users stop receiving treatment (the harmonic mean of all the coe cients describing rates which members of the population cease receiving treatment) multiplied by the rate of relapse,. T 2 = µ Now, we can observe that total average time spent by users not in treatment on multiple passes is given by T = T 0 (1 + T 1 T 2 + (T 1 T 2 ) 2 + (T 1 T 2 ) ) which is a geometric series with ratio T 1 T 2 and T 1 T 2 < 1 since all parameters of (1) are nonnegative. This series is convergent and its sum can be calculated by the usual formula a where 1 r a = T 0. After some simplification this time can be written as ( µ) T = (µ )( µ) + ( µ)bf Next we multiply by the contact rate and average rate of recruitment /µ and we finally yield R 0 = 2 Qualitative Behavior ( µ) µ(µ )( µ) + µ ( µ). (2) Since (1) is a non-linear system we are restricted in the amount of quantitative information we can find and instead must focus on the qualitative behavior as parameters are varied. 2.1 Boundedness Proposition 2.1. The solutions of (1) are biologically feasible and are bounded from above and below: (a) Given S (0) > 0, U 1 (0) > 0, U 2 (0) > 0, U 3 (0) > 0, the trajectories (S (t), U 1 (t), U 2 (t), U 3 (t)) will remain positive for all time t. (b) If N(0) apple µ then N(t) apple µ for all time t where N = S + U 1 + U 2 + U 3. Proof. We will first prove (a). The solution to Equation 1 of (1) can be found by use of the integrating factor technique: S = S (0) exp h Z µt U 1 dt i + exp h Z µt U 1 dt i Z s exp h Z µs + U 1 ds i ds 0 6 0

7 U 2 and U 3 can be found in a similar way: 8 >< U 2 = U 2 (0)e ( µ)t + R t T(U 0 1(s))e ( µ)(s t) ds >: U 3 = U 3 (0)e µt + e R µt t ( U 0 2(s) + U 1 (s))ds Notice that if U 1 0, Then U 2 and U 3 will be greater than 0. If U 1 (0) > 0 and there exists a time t where U(t) < 0 then there must exist some time interval [0, t 0 ) where U 1 (t) > 0 and U 1 (t 0 ) = 0. If U 1 (t) < 0 for t > t 0 then U 1 (t 0 ) apple 0. However, U 1 (t 0 ) = U 2 (t 0 ) > 0, so t 0 does not exist. Thus, the trajectories are strictly positive for all time t. For (b) we observe that if we add all equations from (1) we get Ṅ = µn 1 U 1 2 U 2 < µn since 1, 2, U 1, and U 2 are non-negative. If we solve the inequality Ṅ < µn we get that N < N(0)e µt + (1 e µt ). It is clear that if N(0) < then N(t) < for all t. Moreover, if µ µ µ N(0) > then N(t) will enter the region (0, ) in finite time. µ µ 2.2 Fixed Points System (1) has fixed points that refer to addiction eradiction or sustained addiction over time. We obtain these points by setting the equations of (1) to 0, S? = U? 1 + µ, U? 2 = U? 1 ( µ)(1 +!U? (3) 1 ), U? 3 = U? 1 + ( µ)(1 +!U? 1 )U? 1 µ( µ)(1 +!U? 1 ). If we plug these in to equation 2 of (1) we get the expression for U? 1 where f (U? 1 ) = AU? BU? CU? 1 A = (µ )( µ)!, B = (µ )( µ) + µ!(µ )( µ) + ( µ) (4)!( µ), C = [(µ )( µ)µ + µ( µ)](1 R 0 ). U? 1 = 0 is always a fixed point which represents addiction eradication. To find other fixed points we can consider the equation 7

8 which has roots Notice that if! = 0, f (U? 1 ) = AU? BU? 1 + C = 0 (5) U? 1 1,2 = B ± p B 2 4AC. (6) 2A U? 1 = C (µ )( µ) + ( µ) which is only positive when R 0 > 1. For!>0, there are four interesting cases for U? 1 : (7) (i) B < 0 and (a) C = 0(R 0 = 1) or (b) B 2 4AC = 0. Both of these instances result in a root at U? 1 endemic equilibrium point. = 0 and a root at B 2A which is a unique positive (ii) C < 0(R 0 > 1) and B < 0. In this case p B 2 4AC > B, so there exists a biologically unfeasible negative equilibrium, a root at U? 1 = 0 and a positive endemic equilibrium. (iii) C > 0, B < 0, and B 2 4AC > 0. In this case p B 2 4AC < B, so there are two positive endemic equilbria. (iv) B > 0 and either (a) C > 0 or (b) B 2 < 4AC. This cases has no biologically feasible equilibrium points. 8

9 Figure 2: Cases (i)-(iv). Only the region to the right of the y-axis represents biologically feasible solutions to (1). 2.3 Bifurcations We can define a bifurcation of a dynamical system such as (1) as a smooth change in parameters that cause the system to suddenly change its qualitative or topological behavior. A simple example of this is the one dimensional system ẋ = x 2 + r Figure 3: The three behaviors of x 2 + r as r is varied This is an example of a saddle-node bifurcation. 9

10 Definition 1 (Saddle-Node Bifurcation). A saddle-node bifurcation occurs when, as a parameter is varied,two fixed points approach one another, collide, and mutually annihilate [6]. 2.4 Bifurcations in Wangari-Stone Model Our model has several bifurcation points as the composite parameters A, B, and C are varied. This results in the six di erent behaviors shown in Figure 2. It is straightforward to see that one of these points is when B < 0 and C = 0(R 0 = 1). As R 0 goes from being less than one to greater than one. The behavior of U 1 transitions from case (iii) to case (i.a) to case (ii). This is commonly called a backwards bifurcation and its behavior resembles that of a saddle-node bifurcation. It is preferable to think about this change in terms of the original model parameters. To do this for a system with multiple parameters we must choose a parameter to vary while holding others constant. Notice from (5) that when R 0 = 1 and when B < 0 (µ )( µ)µ + µ(µ ) = ( µ)!( µ) > (µ )( µ) + µ!(µ )( µ) + ( µ), which implies!> ( + µ!)(µ )( µ) + ( µ) ( µ) Together with the condition on C give us a critical value for!:.!> ( + µ!)(µ )( µ) + ( µ) µ ( µ) = (µ )( µ) + ( µ) µ ( µ) (8) :=! C This condition is necessary for the backwards bifurcation at R 0 = 1 to occur. Note that this parameter accounts for the extent of saturation of heroin users, so we can say that when this exceeds a certain threshold we will observe this bifurcation. 2.5 Stability Let s consider the heroin-free equilibrium (HFE). It is hard to compute and analyze the eigenvalues of the Jacobian of (1). It would make physical sense for the stability of the HFE to depend 10

11 on R 0. In particular it would make sense that this point would be stable for R 0 < 1 and unstable otherwise. However, R 0 is independent of our bifurcation parameter! so this is only the case when!<! c. If! 0 our saturated treatment function approximates a linear treatment function and heroin users are treated at a near constant rate making a endemic less likely. Theorem 2.1. The HFE is globally asymptotically stable i R 0 < 1 and!<! c, where R 0 is given by (2), and unstable otherwise. A rigorous proof is given in [1]. When!>! c it is not so straightforward. Case (iii) shows that two positive endemic equilibrium points can exist when R 0 < 1. Figure 4: R 0 = ,! = 0.3,! c = The above graph suggests stability of one of the endemic equilibrium points given in (6). The implication of this is that it is not enough to reduce R 0 below one to eradicate addiction in a population. Instead, R 0 must be reduced further to some value we denote R C 0. A full derivation of this is provided in [8]. 3 Modeling Spatial Interaction with Di usion 3.1 Adding A Spatial Element to Our Model So far our model has applied only to closed populations. Lets consider each population a subset of a larger population. Then it becomes natural to wonder how each population interacts with 11

12 another geographically given the freedom to cross spatial boundaries. Some questions we might ask ourselves are: 1. Do heroin users immigrate to regions where there are other heroin users? 2. Do those that are receiving treatment or those who are recovered move out of regions where there are high concentrations of heroin users? 3. If those in treatment move to a region where there is a low concentration of heroin users does it decrease the chance of relapse? 4. Instead of the above, are movements in and out of regions completely random? Does entropy play a role? We investigate at least a few of the questions in subsequent sections and how we might model these phenomena. 3.2 Reaction-Di usion Model It seems plausible that heroin users cluster together. Drug users tend to come from low income backgrounds which historically have higher concentrations of drug users. If a heroin user is among a low-income population it is unlikely for them to leave that population. If we make these assumptions then we can model this deterministic process by appending a term to (1) that satisfies a two-dimensional heat equation with Neumann boundary conditions. This requires that the region in which we solve the problem be a simply connected region in R 2 and our boundary to be piece-wise smooth. There is a subtlety here: If our region must be simply connected then how can we apply this model to places like Hawaii or Japan whose citizens freely travel across a network of islands? Or those who live in Manhattan and regularly commute to other areas in New York? It might possible to include travel routes as a part of our domain thus eliminating this problem. For now, we will ignore it. Lets consider only that regions with large concentrations of heroin users are attractors for heroin users in other regions. Our spatial model: 8 Ṡ = U 1 S µs >< U 1 = U 1 S + U 2 (µ )U 1 T(U 1 ) U 1 U 2 = T(U 1 ) ( µ)u 2 >: U 3 = U 2 + U 1 µu 3 where k, our di usion constant, is non-negative. 3.3 Numerical Solution to Di usion Model U 2 This section will explore how we might numerically solve (8). For the sake of simplicity a rectangular domain is chosen which contains all (and only) sub-populations of interest, is simply connected and piece-wise smooth. We will call this region. The strategy will be to solve (1) for 12 (9)

13 each sub-population using any suitable numerical method (Runge-Kutta, Forward-Euler, etc) for each sub-population, and then solve the di usion equation at each sub-population using forward Euler where the derivatives at each point will be approximated by finite di erence methods. We do not wish for members of any population to leave the domain, so we must enforce that the outward normal derivative at the boundary points is zero. Figure 5: Boundary Diagram A full system to solve the heat equation is given by: 1 = U 1 2 U 1 (x, y, 0) = A, an M N matrix containing [S (0), U 1 (0), U 2 (0), U 3 (0)] T ij >< for 0 apple i apple M, 0apple j apple 1 (0, y, t) 1(N, y, t) @U 1 (x, 0, t) >: 1(x, M, t) The di usion equation can be solved in the interior of A by discretizing the time domain and using the second order central di erence formula for the second derivative (10) U 1 U 1 k U 1(x x, y) 2U 1 (x, y) + U 1 (x + x, 2 ( x) 2 k U 1(x, y y) 2U 1 (x, y) + U 1 (x, y + y) ( y) 2 13

14 where x and y are the horizontal and vertical distances between sub-regions in and are represented by a single horizontal or vertical position in A. If we use forward Euler to solve (8) and denote system (1) by f the solution of the interior points in A is given by ~a ij, = ~a ij + tf(~a ij ) k t ( x) 2 (~a i 1, j 2~a i, j + ~a i+1, j ) k t ( y) 2 (~a i, j 1 2~a i, j + ~a i, j+1 ) (11) To guarantee that the solution will be stable over multiple time steps k t and k t must satisfy ( x) 2 ( y) 2 the Courant-Friedrichs-Lewy condition k t ( x i ) 2 < 1 2. Since the boundaries are defined piece-wise, we must enforce each boundary condition separately and we will have to be cautious with the corners of A since they lie on two boundaries. All the boundaries must satisfy the heat equation and have an outward derivative of zero. To do this we must use backwards/forwards di erence approximations using the values from the interior of A and set them equal to zero. The second order forward and backward di erence formulas are given by Forward Di erence: Backward Di 1 = 3U 1(x i ) 4U 1 (x i + x i ) + U 1 (x i + 2 x i i 2 x 1 = 3U 1(x i ) + 4U 1 (x i x i ) U 1 (x i 2 x i i 2 x i We can set these equations equal to zero and solve for U 1 (x i ) to compute the boundaries of A excluding the corners: Left Boundary: Right Boundary: Top Boundary: Bottom Boundary: ~a, i,1 = 4, ~a i,2 3 ~a, i,n = 4 ~a i,n 1 3 ~a 1, j = 4 ~a 2, j 3 ~a M, j = 4 ~a M 1, j ~a, i,3 ~a i,n 2 ~a 3, j 1 ~a M 2, j 3 Since the corners are on two boundaries, we must enforce that the directional derivatives are equal to zero. That is, 14

15 " # 1 Top Left Corner: ru 1 (0, 0) = 0 1 " 1 Top Right Corner: ru 1 (N, 0) = 0 1# " 1 Bottom Left Corner: ru 1 (0, M) = 0 1# " 1 Bottom Right Corner: ru 1 (N, M) = 0 1# The top right and bottom left corner can be computed using the forward and backward di erence methods previously described since each element in the direction vector has the same sign. The other two corners pose a problem as, when this method is employed, the point we are interested in end up canceling out. For the top left corner we can deal with this by 1 (0, 1( Similarly for the bottom right corner we 1 (N, 1(N Now we can compute the directional derivative by using a first order central di erence formula for the derivative of 1 = U 1(x i x i ) U 1 (x i + x i i 2 x i and a second order central di erence for the derivative of y. Now we can state the corners of A as Top Left Corner: Top Right Corner: Bottom Left Corner: Bottom Right Corner: ~a 1,1 = ~a 1,N ~a M,1 ~a M.N = x(4~a = 4( y~a 1,N 1 4( y~a M,2 = 2,1 ~a 3,1 x(4~a M 1,N 3 x y + x~a 2,N ) y~a 1,3 ) ( x~a 1,N 2 3( x + y) + x~a ( x~a M 1,1 ) 3( x + y) ~a M 2,N ) + 3 x + y M 2,1 + y~a M,N 2 + y~a 3,N ) y~a M,3 ) 3.4 Numerical Example Matplotlib has a built in function for turning matrices into color maps. This is a nice way to visualize how Equation 2 of (8) evolves in time. 15

16 4 Code Figure 6: Left: Colormap of initial conditions. Right: Forwad 10 units of time. All numerical computations and simulations where done using Python with the Numpy and Matplotlib packages. 4.1 Density Map import matplotlib.pyplot as plt import numpy as np Lambda=1.6; beta=0.001; delta_1=0.002; delta_2=0.001; mu=0.01; alpha=0.9;,! rhe=0.467; sigma=0.1; xi=0.015; omega=0.11 A = np.zeros([10,10,4]) for i in range(a.shape[0]): for j in range(a.shape[1]): A[i,j,0] = *np.random.normal(0,1) A[i,j,1] = *np.random.normal(0,1) A[i,j,2] = 15 + np.random.normal(0,1) A[i,j,3] = 10 + np.random.normal(0,1) def Heat_Map(A, dx, dy, D): def f(x_vec): S, U1, U2, U3 = x_vec return [Lambda - beta*u1*s - mu*s, beta*u1*s + rho*u2 - (mu + delta_1 + xi)*u1 - alpha*u1/(1 + omega*u1),,! alpha*u1/(1 + omega*u1) - M = A.shape[0] N = A.shape[1] (rho + sigma + delta_2 + mu)*u2, sigma*u2 + xi*u1 -,! mu*u3] 16

17 A_ = np.zeros([m, N, 4]) A_2d = np.zeros([m, N]) A_diff = np.zeros([m, N, 4]) time_steps = 100 time_length = 10 dt = time_length/time_steps rx = dt*d/dx**2 ry = dt*d/dy**2 for h in range(time_steps): for i in range(m): for j in range(n): eval = f(a[i,j]) for k in range(4): A_[i,j,k] = A[i,j,k] + dt*eval[k] for i in range(1,m-1): for j in range(1,n-1): A_diff[i,j,1] = A_[i,j,1] - rx*(a_[i-1,j,1],! -2*A_[i,j,1] + A_[i+1,j,1]) - ry*(a_[i,j-1,1],! -2*A_[i,j,1] + A_[i,j+1,1]) A_diff[i,j,0] = A_[i,j,0] A_diff[i,j,2] = A_[i,j,2] A_diff[i,j,3] = A_[i,j,3] #### BOUNDARY CONDITIONS #### for i in range(1,m-1): #Left column boundary condition A_diff[i,0,1] = (4/3)*A_diff[i,1,1] - (1/3)*A_diff[i,2,1] #Right column boundary condition A_diff[i,N-1,1] = (4/3)*A_diff[i,N-2,1] -,! (1/3)*A_diff[i,N-3,1] for j in range(1,n-1): #Top row boundary condition A_diff[0,j,1] = (4/3)*A_diff[1,j,1] - (1/3)*A_diff[2,j,1] #Bottom row boundary condition A_diff[M-1,j,1] = (4/3)*A_diff[M-2,j,1] -,! (1/3)*A_diff[M-3,j,1] #Corner boundary conditions for k in range(4): A_diff[0,0,k] = (dx*(4*a_diff[1,0,k] - A_diff[2,0,k]) -,! dy*a_diff[0,2,k])/(3*dx - dy) A_diff[0,N-1,k] = (4*(dy*A_diff[0,N-2,k] - dx*a_diff[1,n-1,k]),! - (dx*a_diff[0,n-3,k] + dy*a_diff[2,n-1,k]))/(3*(dx + dy)) A_diff[M-1,0,k] = (4*(dy*A_diff[M-1,1,k] - dx*a_diff[m-2,0,k]),! - (dx*a_diff[m-3,0,k] + dy*a_diff[m-1,2,k]))/(3*(dx + dy)) A_diff[M-1,N-1,k] = (dx*(4*a_diff[m-2,n-1,k] -,! A_diff[M-3,N-1,k]) + dy*a_diff[m-1,n-3,k])/(3*dx + dy) 17

18 A = A_diff for i in range(m): for j in range(n): A_2d[i,j] = A_diff[i,j,1] plt.imshow(a_2d, cmap = 'hot', interpolation = 'bilinear') plt.colorbar() Heat_Map(A, 1, 1, 0.01) 18

19 References [1] P. van den Driessche and James Watmough. Reproduction numbers and sub-threshold endemic equilibria for compartmental models of disease transmission. In: Math. Biosci. 180 (2002). John A. Jacquez memorial volume, pp issn: doi: / S (02) url: [2] Leah Edelstein-Keshet. 4. An Introduction to Continuous Models. In: Mathematical Models in Biology. Chap. 4, pp [3] Leah Edelstein-Keshet. 6. Applications of Continuous Models to Population Dynamics. In: Mathematical Models in Biology. Chap. 6, pp [4] Leah Edelstein-Keshet. 9. An Introduction to Partial Di erential Equations and Di usion in Biological Settings. In: Mathematical Models in Biology. Chap. 9, pp [5] Maia Martcheva. 2. Introduction to Epidemic Modeling. In: An Introduction to Mathematical Epidemiology. Springer Publishing Company, Chap. 2. [6] Stephen Strogatz. Nonlinear Dynamics And Chaos: With Applications To Physics, Biology, Chemistry, And Engineering (Studies in Nonlinearity). Westview Press, [7] Jinliang Wang et al. Qualitative and bifurcation analysis using an SIR model with a saturated treatment function. In: Math. Comput. Modelling (2012), pp issn: doi: /j.mcm url: [8] Isaac Mwangi Wangari and Lewi Stone. Analysis of a heroin epidemic model with saturated treatment function. In: J. Appl. Math. (2017), Art. ID , 21. issn: X. doi: /2017/ url: [9] Xu Zhang and Xianning Liu. Backward bifurcation of an epidemic model with saturated treatment function. In: J. Math. Anal. Appl (2008), pp issn: X. doi: /j.jmaa url:

Global Analysis of an Epidemic Model with Nonmonotone Incidence Rate

Global Analysis of an Epidemic Model with Nonmonotone Incidence Rate Global Analysis of an Epidemic Model with Nonmonotone Incidence Rate Dongmei Xiao Department of Mathematics, Shanghai Jiaotong University, Shanghai 00030, China E-mail: xiaodm@sjtu.edu.cn and Shigui Ruan

More information

Qualitative Analysis of a Discrete SIR Epidemic Model

Qualitative Analysis of a Discrete SIR Epidemic Model ISSN (e): 2250 3005 Volume, 05 Issue, 03 March 2015 International Journal of Computational Engineering Research (IJCER) Qualitative Analysis of a Discrete SIR Epidemic Model A. George Maria Selvam 1, D.

More information

Thursday. Threshold and Sensitivity Analysis

Thursday. Threshold and Sensitivity Analysis Thursday Threshold and Sensitivity Analysis SIR Model without Demography ds dt di dt dr dt = βsi (2.1) = βsi γi (2.2) = γi (2.3) With initial conditions S(0) > 0, I(0) > 0, and R(0) = 0. This model can

More information

STABILITY ANALYSIS OF A GENERAL SIR EPIDEMIC MODEL

STABILITY ANALYSIS OF A GENERAL SIR EPIDEMIC MODEL VFAST Transactions on Mathematics http://vfast.org/index.php/vtm@ 2013 ISSN: 2309-0022 Volume 1, Number 1, May-June, 2013 pp. 16 20 STABILITY ANALYSIS OF A GENERAL SIR EPIDEMIC MODEL Roman Ullah 1, Gul

More information

GLOBAL STABILITY OF SIR MODELS WITH NONLINEAR INCIDENCE AND DISCONTINUOUS TREATMENT

GLOBAL STABILITY OF SIR MODELS WITH NONLINEAR INCIDENCE AND DISCONTINUOUS TREATMENT Electronic Journal of Differential Equations, Vol. 2015 (2015), No. 304, pp. 1 8. SSN: 1072-6691. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu ftp ejde.math.txstate.edu GLOBAL STABLTY

More information

Stability of SEIR Model of Infectious Diseases with Human Immunity

Stability of SEIR Model of Infectious Diseases with Human Immunity Global Journal of Pure and Applied Mathematics. ISSN 0973-1768 Volume 13, Number 6 (2017), pp. 1811 1819 Research India Publications http://www.ripublication.com/gjpam.htm Stability of SEIR Model of Infectious

More information

Global Stability of a Computer Virus Model with Cure and Vertical Transmission

Global Stability of a Computer Virus Model with Cure and Vertical Transmission International Journal of Research Studies in Computer Science and Engineering (IJRSCSE) Volume 3, Issue 1, January 016, PP 16-4 ISSN 349-4840 (Print) & ISSN 349-4859 (Online) www.arcjournals.org Global

More information

Smoking as Epidemic: Modeling and Simulation Study

Smoking as Epidemic: Modeling and Simulation Study American Journal of Applied Mathematics 2017; 5(1): 31-38 http://www.sciencepublishinggroup.com/j/ajam doi: 10.11648/j.ajam.20170501.14 ISSN: 2330-0043 (Print); ISSN: 2330-006X (Online) Smoking as Epidemic:

More information

Introduction to SEIR Models

Introduction to SEIR Models Department of Epidemiology and Public Health Health Systems Research and Dynamical Modelling Unit Introduction to SEIR Models Nakul Chitnis Workshop on Mathematical Models of Climate Variability, Environmental

More information

Australian Journal of Basic and Applied Sciences

Australian Journal of Basic and Applied Sciences AENSI Journals Australian Journal of Basic and Applied Sciences ISSN:1991-8178 Journal home page: www.ajbasweb.com A SIR Transmission Model of Political Figure Fever 1 Benny Yong and 2 Nor Azah Samat 1

More information

Project 1 Modeling of Epidemics

Project 1 Modeling of Epidemics 532 Chapter 7 Nonlinear Differential Equations and tability ection 7.5 Nonlinear systems, unlike linear systems, sometimes have periodic solutions, or limit cycles, that attract other nearby solutions.

More information

GLOBAL STABILITY OF A VACCINATION MODEL WITH IMMIGRATION

GLOBAL STABILITY OF A VACCINATION MODEL WITH IMMIGRATION Electronic Journal of Differential Equations, Vol. 2015 (2015), No. 92, pp. 1 10. SSN: 1072-6691. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu ftp ejde.math.txstate.edu GLOBAL STABLTY

More information

Mathematical Analysis of Epidemiological Models: Introduction

Mathematical Analysis of Epidemiological Models: Introduction Mathematical Analysis of Epidemiological Models: Introduction Jan Medlock Clemson University Department of Mathematical Sciences 8 February 2010 1. Introduction. The effectiveness of improved sanitation,

More information

Applications in Biology

Applications in Biology 11 Applications in Biology In this chapter we make use of the techniques developed in the previous few chapters to examine some nonlinear systems that have been used as mathematical models for a variety

More information

Stability Analysis of an HIV/AIDS Epidemic Model with Screening

Stability Analysis of an HIV/AIDS Epidemic Model with Screening International Mathematical Forum, Vol. 6, 11, no. 66, 351-373 Stability Analysis of an HIV/AIDS Epidemic Model with Screening Sarah Al-Sheikh Department of Mathematics King Abdulaziz University Jeddah,

More information

Behavior Stability in two SIR-Style. Models for HIV

Behavior Stability in two SIR-Style. Models for HIV Int. Journal of Math. Analysis, Vol. 4, 2010, no. 9, 427-434 Behavior Stability in two SIR-Style Models for HIV S. Seddighi Chaharborj 2,1, M. R. Abu Bakar 2, I. Fudziah 2 I. Noor Akma 2, A. H. Malik 2,

More information

Dynamics of Disease Spread. in a Predator-Prey System

Dynamics of Disease Spread. in a Predator-Prey System Advanced Studies in Biology, vol. 6, 2014, no. 4, 169-179 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/asb.2014.4845 Dynamics of Disease Spread in a Predator-Prey System Asrul Sani 1, Edi Cahyono

More information

Dynamical models of HIV-AIDS e ect on population growth

Dynamical models of HIV-AIDS e ect on population growth Dynamical models of HV-ADS e ect on population growth David Gurarie May 11, 2005 Abstract We review some known dynamical models of epidemics, given by coupled systems of di erential equations, and propose

More information

Analysis of SIR Mathematical Model for Malaria disease with the inclusion of Infected Immigrants

Analysis of SIR Mathematical Model for Malaria disease with the inclusion of Infected Immigrants IOSR Journal of Mathematics (IOSR-JM) e-issn: 2278-5728, p-issn: 2319-765X. Volume 14, Issue 5 Ver. I (Sep - Oct 218), PP 1-21 www.iosrjournals.org Analysis of SIR Mathematical Model for Malaria disease

More information

Bifurcation Analysis in Simple SIS Epidemic Model Involving Immigrations with Treatment

Bifurcation Analysis in Simple SIS Epidemic Model Involving Immigrations with Treatment Appl. Math. Inf. Sci. Lett. 3, No. 3, 97-10 015) 97 Applied Mathematics & Information Sciences Letters An International Journal http://dx.doi.org/10.1785/amisl/03030 Bifurcation Analysis in Simple SIS

More information

LAW OF LARGE NUMBERS FOR THE SIRS EPIDEMIC

LAW OF LARGE NUMBERS FOR THE SIRS EPIDEMIC LAW OF LARGE NUMBERS FOR THE SIRS EPIDEMIC R. G. DOLGOARSHINNYKH Abstract. We establish law of large numbers for SIRS stochastic epidemic processes: as the population size increases the paths of SIRS epidemic

More information

The E ect of Occasional Smokers on the Dynamics of a Smoking Model

The E ect of Occasional Smokers on the Dynamics of a Smoking Model International Mathematical Forum, Vol. 9, 2014, no. 25, 1207-1222 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/imf.2014.46120 The E ect of Occasional Smokers on the Dynamics of a Smoking Model

More information

Global Analysis of an SEIRS Model with Saturating Contact Rate 1

Global Analysis of an SEIRS Model with Saturating Contact Rate 1 Applied Mathematical Sciences, Vol. 6, 2012, no. 80, 3991-4003 Global Analysis of an SEIRS Model with Saturating Contact Rate 1 Shulin Sun a, Cuihua Guo b, and Chengmin Li a a School of Mathematics and

More information

Mathematical Model of Tuberculosis Spread within Two Groups of Infected Population

Mathematical Model of Tuberculosis Spread within Two Groups of Infected Population Applied Mathematical Sciences, Vol. 10, 2016, no. 43, 2131-2140 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2016.63130 Mathematical Model of Tuberculosis Spread within Two Groups of Infected

More information

MODELING AND ANALYSIS OF THE SPREAD OF CARRIER DEPENDENT INFECTIOUS DISEASES WITH ENVIRONMENTAL EFFECTS

MODELING AND ANALYSIS OF THE SPREAD OF CARRIER DEPENDENT INFECTIOUS DISEASES WITH ENVIRONMENTAL EFFECTS Journal of Biological Systems, Vol. 11, No. 3 2003 325 335 c World Scientific Publishing Company MODELING AND ANALYSIS OF THE SPREAD OF CARRIER DEPENDENT INFECTIOUS DISEASES WITH ENVIRONMENTAL EFFECTS

More information

Australian Journal of Basic and Applied Sciences. Effect of Personal Hygiene Campaign on the Transmission Model of Hepatitis A

Australian Journal of Basic and Applied Sciences. Effect of Personal Hygiene Campaign on the Transmission Model of Hepatitis A Australian Journal of Basic and Applied Sciences, 9(13) Special 15, Pages: 67-73 ISSN:1991-8178 Australian Journal of Basic and Applied Sciences Journal home page: wwwajbaswebcom Effect of Personal Hygiene

More information

Section 8.1 Def. and Examp. Systems

Section 8.1 Def. and Examp. Systems Section 8.1 Def. and Examp. Systems Key Terms: SIR Model of an epidemic o Nonlinear o Autonomous Vector functions o Derivative of vector functions Order of a DE system Planar systems Dimension of a system

More information

Mathematical Analysis of Epidemiological Models III

Mathematical Analysis of Epidemiological Models III Intro Computing R Complex models Mathematical Analysis of Epidemiological Models III Jan Medlock Clemson University Department of Mathematical Sciences 27 July 29 Intro Computing R Complex models What

More information

APPPHYS217 Tuesday 25 May 2010

APPPHYS217 Tuesday 25 May 2010 APPPHYS7 Tuesday 5 May Our aim today is to take a brief tour of some topics in nonlinear dynamics. Some good references include: [Perko] Lawrence Perko Differential Equations and Dynamical Systems (Springer-Verlag

More information

Sensitivity and Stability Analysis of Hepatitis B Virus Model with Non-Cytolytic Cure Process and Logistic Hepatocyte Growth

Sensitivity and Stability Analysis of Hepatitis B Virus Model with Non-Cytolytic Cure Process and Logistic Hepatocyte Growth Global Journal of Pure and Applied Mathematics. ISSN 0973-1768 Volume 12, Number 3 2016), pp. 2297 2312 Research India Publications http://www.ripublication.com/gjpam.htm Sensitivity and Stability Analysis

More information

We have two possible solutions (intersections of null-clines. dt = bv + muv = g(u, v). du = au nuv = f (u, v),

We have two possible solutions (intersections of null-clines. dt = bv + muv = g(u, v). du = au nuv = f (u, v), Let us apply the approach presented above to the analysis of population dynamics models. 9. Lotka-Volterra predator-prey model: phase plane analysis. Earlier we introduced the system of equations for prey

More information

Dynamics of Modified Leslie-Gower Predator-Prey Model with Predator Harvesting

Dynamics of Modified Leslie-Gower Predator-Prey Model with Predator Harvesting International Journal of Basic & Applied Sciences IJBAS-IJENS Vol:13 No:05 55 Dynamics of Modified Leslie-Gower Predator-Prey Model with Predator Harvesting K. Saleh Department of Mathematics, King Fahd

More information

Hysteresis. Lab 6. Recall that any ordinary differential equation can be written as a first order system of ODEs,

Hysteresis. Lab 6. Recall that any ordinary differential equation can be written as a first order system of ODEs, Lab 6 Hysteresis Recall that any ordinary differential equation can be written as a first order system of ODEs, ẋ = F (x), ẋ := d x(t). (6.1) dt Many interesting applications and physical phenomena can

More information

Introduction: What one must do to analyze any model Prove the positivity and boundedness of the solutions Determine the disease free equilibrium

Introduction: What one must do to analyze any model Prove the positivity and boundedness of the solutions Determine the disease free equilibrium Introduction: What one must do to analyze any model Prove the positivity and boundedness of the solutions Determine the disease free equilibrium point and the model reproduction number Prove the stability

More information

TMA 4195 Mathematical Modelling December 12, 2007 Solution with additional comments

TMA 4195 Mathematical Modelling December 12, 2007 Solution with additional comments Problem TMA 495 Mathematical Modelling December, 007 Solution with additional comments The air resistance, F, of a car depends on its length, L, cross sectional area, A, its speed relative to the air,

More information

HETEROGENEOUS MIXING IN EPIDEMIC MODELS

HETEROGENEOUS MIXING IN EPIDEMIC MODELS CANADIAN APPLIED MATHEMATICS QUARTERLY Volume 2, Number 1, Spring 212 HETEROGENEOUS MIXING IN EPIDEMIC MODELS FRED BRAUER ABSTRACT. We extend the relation between the basic reproduction number and the

More information

Linearization of Differential Equation Models

Linearization of Differential Equation Models Linearization of Differential Equation Models 1 Motivation We cannot solve most nonlinear models, so we often instead try to get an overall feel for the way the model behaves: we sometimes talk about looking

More information

APPM 2360 Lab 3: Zombies! Due April 27, 2017 by 11:59 pm

APPM 2360 Lab 3: Zombies! Due April 27, 2017 by 11:59 pm APPM 2360 Lab 3: Zombies! Due April 27, 2017 by 11:59 pm 1 Introduction As you already know, in the past month, zombies have overrun much of North America, including all major cities on both the East and

More information

Simple Mathematical Model for Malaria Transmission

Simple Mathematical Model for Malaria Transmission Journal of Advances in Mathematics and Computer Science 25(6): 1-24, 217; Article no.jamcs.37843 ISSN: 2456-9968 (Past name: British Journal of Mathematics & Computer Science, Past ISSN: 2231-851) Simple

More information

Applied Mathematics Letters. Global behaviour of a heroin epidemic model with distributed delays

Applied Mathematics Letters. Global behaviour of a heroin epidemic model with distributed delays Applied Mathematics Letters 4 () 685 69 Contents lists available at ScienceDirect Applied Mathematics Letters journal homepage: www.elsevier.com/locate/aml Global behaviour of a heroin epidemic model with

More information

SIR Epidemic Model with total Population size

SIR Epidemic Model with total Population size Advances in Applied Mathematical Biosciences. ISSN 2248-9983 Volume 7, Number 1 (2016), pp. 33-39 International Research Publication House http://www.irphouse.com SIR Epidemic Model with total Population

More information

Stability Analysis of a SIS Epidemic Model with Standard Incidence

Stability Analysis of a SIS Epidemic Model with Standard Incidence tability Analysis of a I Epidemic Model with tandard Incidence Cruz Vargas-De-León Received 19 April 2011; Accepted 19 Octuber 2011 leoncruz82@yahoo.com.mx Abstract In this paper, we study the global properties

More information

A Mathematical Analysis on the Transmission Dynamics of Neisseria gonorrhoeae. Yk j N k j

A Mathematical Analysis on the Transmission Dynamics of Neisseria gonorrhoeae. Yk j N k j North Carolina Journal of Mathematics and Statistics Volume 3, Pages 7 20 (Accepted June 23, 2017, published June 30, 2017 ISSN 2380-7539 A Mathematical Analysis on the Transmission Dynamics of Neisseria

More information

The dynamics of disease transmission in a Prey Predator System with harvesting of prey

The dynamics of disease transmission in a Prey Predator System with harvesting of prey ISSN: 78 Volume, Issue, April The dynamics of disease transmission in a Prey Predator System with harvesting of prey, Kul Bhushan Agnihotri* Department of Applied Sciences and Humanties Shaheed Bhagat

More information

Systems of Ordinary Differential Equations

Systems of Ordinary Differential Equations Systems of Ordinary Differential Equations Scott A. McKinley October 22, 2013 In these notes, which replace the material in your textbook, we will learn a modern view of analyzing systems of differential

More information

Modelling of the Hand-Foot-Mouth-Disease with the Carrier Population

Modelling of the Hand-Foot-Mouth-Disease with the Carrier Population Modelling of the Hand-Foot-Mouth-Disease with the Carrier Population Ruzhang Zhao, Lijun Yang Department of Mathematical Science, Tsinghua University, China. Corresponding author. Email: lyang@math.tsinghua.edu.cn,

More information

A comparison of delayed SIR and SEIR epidemic models

A comparison of delayed SIR and SEIR epidemic models Nonlinear Analysis: Modelling and Control, 2011, Vol. 16, No. 2, 181 190 181 A comparison of delayed SIR and SEIR epidemic models Abdelilah Kaddar a, Abdelhadi Abta b, Hamad Talibi Alaoui b a Université

More information

Spotlight on Modeling: The Possum Plague

Spotlight on Modeling: The Possum Plague 70 Spotlight on Modeling: The Possum Plague Reference: Sections 2.6, 7.2 and 7.3. The ecological balance in New Zealand has been disturbed by the introduction of the Australian possum, a marsupial the

More information

3 Stability and Lyapunov Functions

3 Stability and Lyapunov Functions CDS140a Nonlinear Systems: Local Theory 02/01/2011 3 Stability and Lyapunov Functions 3.1 Lyapunov Stability Denition: An equilibrium point x 0 of (1) is stable if for all ɛ > 0, there exists a δ > 0 such

More information

Global Stability of SEIRS Models in Epidemiology

Global Stability of SEIRS Models in Epidemiology Global Stability of SRS Models in pidemiology M. Y. Li, J. S. Muldowney, and P. van den Driessche Department of Mathematics and Statistics Mississippi State University, Mississippi State, MS 39762 Department

More information

GLOBAL DYNAMICS OF A MATHEMATICAL MODEL OF TUBERCULOSIS

GLOBAL DYNAMICS OF A MATHEMATICAL MODEL OF TUBERCULOSIS CANADIAN APPIED MATHEMATICS QUARTERY Volume 13, Number 4, Winter 2005 GOBA DYNAMICS OF A MATHEMATICA MODE OF TUBERCUOSIS HONGBIN GUO ABSTRACT. Mathematical analysis is carried out for a mathematical model

More information

Models of Infectious Disease Formal Demography Stanford Summer Short Course James Holland Jones, Instructor. August 15, 2005

Models of Infectious Disease Formal Demography Stanford Summer Short Course James Holland Jones, Instructor. August 15, 2005 Models of Infectious Disease Formal Demography Stanford Summer Short Course James Holland Jones, Instructor August 15, 2005 1 Outline 1. Compartmental Thinking 2. Simple Epidemic (a) Epidemic Curve 1:

More information

Electronic appendices are refereed with the text. However, no attempt has been made to impose a uniform editorial style on the electronic appendices.

Electronic appendices are refereed with the text. However, no attempt has been made to impose a uniform editorial style on the electronic appendices. This is an electronic appendix to the paper by Alun L. Lloyd 2001 Destabilization of epidemic models with the inclusion of realistic distributions of infectious periods. Proc. R. Soc. Lond. B 268, 985-993.

More information

Stochastic modelling of epidemic spread

Stochastic modelling of epidemic spread Stochastic modelling of epidemic spread Julien Arino Department of Mathematics University of Manitoba Winnipeg Julien Arino@umanitoba.ca 19 May 2012 1 Introduction 2 Stochastic processes 3 The SIS model

More information

Available online at J. Math. Comput. Sci. 2 (2012), No. 6, ISSN:

Available online at   J. Math. Comput. Sci. 2 (2012), No. 6, ISSN: Available online at http://scik.org J. Math. Comput. Sci. 2 (2012), No. 6, 1671-1684 ISSN: 1927-5307 A MATHEMATICAL MODEL FOR THE TRANSMISSION DYNAMICS OF HIV/AIDS IN A TWO-SEX POPULATION CONSIDERING COUNSELING

More information

(e) Use Newton s method to find the x coordinate that satisfies this equation, and your graph in part (b) to show that this is an inflection point.

(e) Use Newton s method to find the x coordinate that satisfies this equation, and your graph in part (b) to show that this is an inflection point. Chapter 6 Review problems 6.1 A strange function Consider the function (x 2 ) x. (a) Show that this function can be expressed as f(x) = e x ln(x2). (b) Use the spreadsheet, and a fine subdivision of the

More information

SI j RS E-Epidemic Model With Multiple Groups of Infection In Computer Network. 1 Introduction. Bimal Kumar Mishra 1, Aditya Kumar Singh 2

SI j RS E-Epidemic Model With Multiple Groups of Infection In Computer Network. 1 Introduction. Bimal Kumar Mishra 1, Aditya Kumar Singh 2 ISSN 1749-3889 (print), 1749-3897 (online) International Journal of Nonlinear Science Vol.13(2012) No.3,pp.357-362 SI j RS E-Epidemic Model With Multiple Groups of Infection In Computer Network Bimal Kumar

More information

Delay SIR Model with Nonlinear Incident Rate and Varying Total Population

Delay SIR Model with Nonlinear Incident Rate and Varying Total Population Delay SIR Model with Nonlinear Incident Rate Varying Total Population Rujira Ouncharoen, Salinthip Daengkongkho, Thongchai Dumrongpokaphan, Yongwimon Lenbury Abstract Recently, models describing the behavior

More information

Hepatitis C Mathematical Model

Hepatitis C Mathematical Model Hepatitis C Mathematical Model Syed Ali Raza May 18, 2012 1 Introduction Hepatitis C is an infectious disease that really harms the liver. It is caused by the hepatitis C virus. The infection leads to

More information

GLOBAL ASYMPTOTIC STABILITY OF A DIFFUSIVE SVIR EPIDEMIC MODEL WITH IMMIGRATION OF INDIVIDUALS

GLOBAL ASYMPTOTIC STABILITY OF A DIFFUSIVE SVIR EPIDEMIC MODEL WITH IMMIGRATION OF INDIVIDUALS Electronic Journal of Differential Equations, Vol. 16 (16), No. 8, pp. 1 1. ISSN: 17-6691. URL: http://ejde.math.txstate.edu or http://ejde.math.unt.edu GLOBAL ASYMPTOTIC STABILITY OF A DIFFUSIVE SVIR

More information

Dynamics of a Population Model Controlling the Spread of Plague in Prairie Dogs

Dynamics of a Population Model Controlling the Spread of Plague in Prairie Dogs Dynamics of a opulation Model Controlling the Spread of lague in rairie Dogs Catalin Georgescu The University of South Dakota Department of Mathematical Sciences 414 East Clark Street, Vermillion, SD USA

More information

A NEW SOLUTION OF SIR MODEL BY USING THE DIFFERENTIAL FRACTIONAL TRANSFORMATION METHOD

A NEW SOLUTION OF SIR MODEL BY USING THE DIFFERENTIAL FRACTIONAL TRANSFORMATION METHOD April, 4. Vol. 4, No. - 4 EAAS & ARF. All rights reserved ISSN35-869 A NEW SOLUTION OF SIR MODEL BY USING THE DIFFERENTIAL FRACTIONAL TRANSFORMATION METHOD Ahmed A. M. Hassan, S. H. Hoda Ibrahim, Amr M.

More information

1.2 Derivation. d p f = d p f(x(p)) = x fd p x (= f x x p ). (1) Second, g x x p + g p = 0. d p f = f x g 1. The expression f x gx

1.2 Derivation. d p f = d p f(x(p)) = x fd p x (= f x x p ). (1) Second, g x x p + g p = 0. d p f = f x g 1. The expression f x gx PDE-constrained optimization and the adjoint method Andrew M. Bradley November 16, 21 PDE-constrained optimization and the adjoint method for solving these and related problems appear in a wide range of

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations Michael H. F. Wilkinson Institute for Mathematics and Computing Science University of Groningen The Netherlands December 2005 Overview What are Ordinary Differential Equations

More information

MODELING THE SPREAD OF DENGUE FEVER BY USING SIR MODEL. Hor Ming An, PM. Dr. Yudariah Mohammad Yusof

MODELING THE SPREAD OF DENGUE FEVER BY USING SIR MODEL. Hor Ming An, PM. Dr. Yudariah Mohammad Yusof MODELING THE SPREAD OF DENGUE FEVER BY USING SIR MODEL Hor Ming An, PM. Dr. Yudariah Mohammad Yusof Abstract The establishment and spread of dengue fever is a complex phenomenon with many factors that

More information

Research Article Propagation of Computer Virus under Human Intervention: A Dynamical Model

Research Article Propagation of Computer Virus under Human Intervention: A Dynamical Model Discrete Dynamics in Nature and ociety Volume 2012, Article ID 106950, 8 pages doi:10.1155/2012/106950 Research Article Propagation of Computer Virus under Human Intervention: A Dynamical Model Chenquan

More information

Australian Journal of Basic and Applied Sciences. Effect of Education Campaign on Transmission Model of Conjunctivitis

Australian Journal of Basic and Applied Sciences. Effect of Education Campaign on Transmission Model of Conjunctivitis ISSN:99-878 Australian Journal of Basic and Applied Sciences Journal home page: www.ajbasweb.com ffect of ducation Campaign on Transmission Model of Conjunctivitis Suratchata Sangthongjeen, Anake Sudchumnong

More information

New results on the existences of solutions of the Dirichlet problem with respect to the Schrödinger-prey operator and their applications

New results on the existences of solutions of the Dirichlet problem with respect to the Schrödinger-prey operator and their applications Chen Zhang Journal of Inequalities Applications 2017 2017:143 DOI 10.1186/s13660-017-1417-9 R E S E A R C H Open Access New results on the existences of solutions of the Dirichlet problem with respect

More information

Numerical Algorithms as Dynamical Systems

Numerical Algorithms as Dynamical Systems A Study on Numerical Algorithms as Dynamical Systems Moody Chu North Carolina State University What This Study Is About? To recast many numerical algorithms as special dynamical systems, whence to derive

More information

MATHEMATICAL MODELS Vol. III - Mathematical Models in Epidemiology - M. G. Roberts, J. A. P. Heesterbeek

MATHEMATICAL MODELS Vol. III - Mathematical Models in Epidemiology - M. G. Roberts, J. A. P. Heesterbeek MATHEMATICAL MODELS I EPIDEMIOLOGY M. G. Roberts Institute of Information and Mathematical Sciences, Massey University, Auckland, ew Zealand J. A. P. Heesterbeek Faculty of Veterinary Medicine, Utrecht

More information

Introduction to Dynamical Systems Basic Concepts of Dynamics

Introduction to Dynamical Systems Basic Concepts of Dynamics Introduction to Dynamical Systems Basic Concepts of Dynamics A dynamical system: Has a notion of state, which contains all the information upon which the dynamical system acts. A simple set of deterministic

More information

MA 777: Topics in Mathematical Biology

MA 777: Topics in Mathematical Biology MA 777: Topics in Mathematical Biology David Murrugarra Department of Mathematics, University of Kentucky http://www.math.uky.edu/~dmu228/ma777/ Spring 2018 David Murrugarra (University of Kentucky) Lecture

More information

The SIRS Model Approach to Host/Parasite Relationships

The SIRS Model Approach to Host/Parasite Relationships = B I + y (N I ) 1 8 6 4 2 I = B I v I N = 5 v = 25 The IR Model Approach to Host/Parasite Relationships Brianne Gill May 16, 28 5 1 15 2 The IR Model... Abstract In this paper, we shall explore examples

More information

MATH 250 Homework 4: Due May 4, 2017

MATH 250 Homework 4: Due May 4, 2017 Due May 4, 17 Answer the following questions to the best of your ability. Solutions should be typed. Any plots or graphs should be included with the question (please include the questions in your solutions).

More information

Bifurcation Analysis of a SIRS Epidemic Model with a Generalized Nonmonotone and Saturated Incidence Rate

Bifurcation Analysis of a SIRS Epidemic Model with a Generalized Nonmonotone and Saturated Incidence Rate Bifurcation Analysis of a SIRS Epidemic Model with a Generalized Nonmonotone and Saturated Incidence Rate Min Lu a, Jicai Huang a, Shigui Ruan b and Pei Yu c a School of Mathematics and Statistics, Central

More information

Stability Analysis of an SVIR Epidemic Model with Non-linear Saturated Incidence Rate

Stability Analysis of an SVIR Epidemic Model with Non-linear Saturated Incidence Rate Applied Mathematical Sciences, Vol. 9, 215, no. 23, 1145-1158 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/1.12988/ams.215.41164 Stability Analysis of an SVIR Epidemic Model with Non-linear Saturated

More information

NONSTANDARD NUMERICAL METHODS FOR A CLASS OF PREDATOR-PREY MODELS WITH PREDATOR INTERFERENCE

NONSTANDARD NUMERICAL METHODS FOR A CLASS OF PREDATOR-PREY MODELS WITH PREDATOR INTERFERENCE Sixth Mississippi State Conference on Differential Equations and Computational Simulations, Electronic Journal of Differential Equations, Conference 15 (2007), pp. 67 75. ISSN: 1072-6691. URL: http://ejde.math.txstate.edu

More information

SYMBIOTIC MODELS WITH AN SIR DISEASE

SYMBIOTIC MODELS WITH AN SIR DISEASE SYMBIOTIC MODELS WITH AN SIR DISEASE A Thesis Presented to the Faculty of California State Polytechnic University, Pomona In Partial Fulfillment Of the Requirements for the Degree Master of Science In

More information

BIFURCATION ANALYSIS OF A STAGE-STRUCTURED EPIDEMIC MODEL WITH A NONLINEAR INCIDENCE

BIFURCATION ANALYSIS OF A STAGE-STRUCTURED EPIDEMIC MODEL WITH A NONLINEAR INCIDENCE INTERNATIONAL JOURNAL OF INFORMATION AND SYSTEMS SCIENCES Volume 7, Number 1, Pages 61 72 c 2011 Institute for Scientific Computing and Information BIFURCATION ANALYSIS OF A STAGE-STRUCTURED EPIDEMIC MODEL

More information

PARAMETER ESTIMATION IN EPIDEMIC MODELS: SIMPLIFIED FORMULAS

PARAMETER ESTIMATION IN EPIDEMIC MODELS: SIMPLIFIED FORMULAS CANADIAN APPLIED MATHEMATICS QUARTERLY Volume 19, Number 4, Winter 211 PARAMETER ESTIMATION IN EPIDEMIC MODELS: SIMPLIFIED FORMULAS Dedicated to Herb Freedman on the occasion of his seventieth birthday

More information

The death of an epidemic

The death of an epidemic LECTURE 2 Equilibrium Stability Analysis & Next Generation Method The death of an epidemic In SIR equations, let s divide equation for dx/dt by dz/ dt:!! dx/dz = - (β X Y/N)/(γY)!!! = - R 0 X/N Integrate

More information

The Dynamic Properties of a Deterministic SIR Epidemic Model in Discrete-Time

The Dynamic Properties of a Deterministic SIR Epidemic Model in Discrete-Time Applied Mathematics, 05, 6, 665-675 Published Online September 05 in SciRes http://wwwscirporg/journal/am http://dxdoiorg/046/am056048 The Dynamic Properties of a Deterministic SIR Epidemic Model in Discrete-Time

More information

Preservation of local dynamics when applying central difference methods: application to SIR model

Preservation of local dynamics when applying central difference methods: application to SIR model Journal of Difference Equations and Applications, Vol., No. 4, April 2007, 40 Preservation of local dynamics when applying central difference methods application to SIR model LIH-ING W. ROEGER* and ROGER

More information

2D-Volterra-Lotka Modeling For 2 Species

2D-Volterra-Lotka Modeling For 2 Species Majalat Al-Ulum Al-Insaniya wat - Tatbiqiya 2D-Volterra-Lotka Modeling For 2 Species Alhashmi Darah 1 University of Almergeb Department of Mathematics Faculty of Science Zliten Libya. Abstract The purpose

More information

Qualitative Analysis of Tumor-Immune ODE System

Qualitative Analysis of Tumor-Immune ODE System of Tumor-Immune ODE System L.G. de Pillis and A.E. Radunskaya August 15, 2002 This work was supported in part by a grant from the W.M. Keck Foundation 0-0 QUALITATIVE ANALYSIS Overview 1. Simplified System

More information

Continuous Threshold Policy Harvesting in Predator-Prey Models

Continuous Threshold Policy Harvesting in Predator-Prey Models Continuous Threshold Policy Harvesting in Predator-Prey Models Jon Bohn and Kaitlin Speer Department of Mathematics, University of Wisconsin - Madison Department of Mathematics, Baylor University July

More information

Epidemics in Two Competing Species

Epidemics in Two Competing Species Epidemics in Two Competing Species Litao Han 1 School of Information, Renmin University of China, Beijing, 100872 P. R. China Andrea Pugliese 2 Department of Mathematics, University of Trento, Trento,

More information

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for COMPUTATIONAL BIOLOGY A. COURSE CODES: FFR 110, FIM740GU, PhD

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for COMPUTATIONAL BIOLOGY A. COURSE CODES: FFR 110, FIM740GU, PhD CHALMERS, GÖTEBORGS UNIVERSITET EXAM for COMPUTATIONAL BIOLOGY A COURSE CODES: FFR 110, FIM740GU, PhD Time: Place: Teachers: Allowed material: Not allowed: June 8, 2018, at 08 30 12 30 Johanneberg Kristian

More information

GEMF: GENERALIZED EPIDEMIC MODELING FRAMEWORK SOFTWARE IN PYTHON

GEMF: GENERALIZED EPIDEMIC MODELING FRAMEWORK SOFTWARE IN PYTHON GEMF: GENERALIZED EPIDEMIC MODELING FRAMEWORK SOFTWARE IN PYTHON HEMAN SHAKERI Network Science and Engineering Group (NetSE) Department of Electrical and Computer Engineering Kansas State University Manhattan,

More information

Math 1280 Notes 4 Last section revised, 1/31, 9:30 pm.

Math 1280 Notes 4 Last section revised, 1/31, 9:30 pm. 1 competing species Math 1280 Notes 4 Last section revised, 1/31, 9:30 pm. This section and the next deal with the subject of population biology. You will already have seen examples of this. Most calculus

More information

Dynamical Analysis of Plant Disease Model with Roguing, Replanting and Preventive Treatment

Dynamical Analysis of Plant Disease Model with Roguing, Replanting and Preventive Treatment 4 th ICRIEMS Proceedings Published by The Faculty Of Mathematics And Natural Sciences Yogyakarta State University, ISBN 978-62-74529-2-3 Dynamical Analysis of Plant Disease Model with Roguing, Replanting

More information

An Improved Computer Multi-Virus Propagation Model with User Awareness

An Improved Computer Multi-Virus Propagation Model with User Awareness Journal of Information & Computational Science 8: 16 (2011) 4301 4308 Available at http://www.joics.com An Improved Computer Multi-Virus Propagation Model with User Awareness Xiaoqin ZHANG a,, Shuyu CHEN

More information

The Effect of Stochastic Migration on an SIR Model for the Transmission of HIV. Jan P. Medlock

The Effect of Stochastic Migration on an SIR Model for the Transmission of HIV. Jan P. Medlock The Effect of Stochastic Migration on an SIR Model for the Transmission of HIV A Thesis Presented to The Faculty of the Division of Graduate Studies by Jan P. Medlock In Partial Fulfillment of the Requirements

More information

Modeling Co-Dynamics of Cervical Cancer and HIV Diseases

Modeling Co-Dynamics of Cervical Cancer and HIV Diseases Global ournal of Pure Applied Mathematics. SSN 093-8 Volume 3 Number (0) pp. 05-08 Research ndia Publications http://www.riblication.com Modeling o-dynamics of ervical ancer V Diseases Geomira G. Sanga

More information

Math 216 Final Exam 14 December, 2012

Math 216 Final Exam 14 December, 2012 Math 216 Final Exam 14 December, 2012 This sample exam is provided to serve as one component of your studying for this exam in this course. Please note that it is not guaranteed to cover the material that

More information

Introduction to Stochastic SIR Model

Introduction to Stochastic SIR Model Introduction to Stochastic R Model Chiu- Yu Yang (Alex), Yi Yang R model is used to model the infection of diseases. It is short for Susceptible- Infected- Recovered. It is important to address that R

More information

Lab 5: Nonlinear Systems

Lab 5: Nonlinear Systems Lab 5: Nonlinear Systems Goals In this lab you will use the pplane6 program to study two nonlinear systems by direct numerical simulation. The first model, from population biology, displays interesting

More information

Epidemiology and Chaos Jonathan Wills Math 053: Chaos! Prof. Alex Barnett Fall Abstract:

Epidemiology and Chaos Jonathan Wills Math 053: Chaos! Prof. Alex Barnett Fall Abstract: Abstract: Epidemiology and Chaos Jonathan Wills Math 053: Chaos! Prof. Alex Barnett Fall 2009 Mathematical epidemiological models for the spread of disease through a population are used to predict the

More information

A Stability Analysis on Models of Cooperative and Competitive Species

A Stability Analysis on Models of Cooperative and Competitive Species Research Journal of Mathematical and Statistical Sciences ISSN 2320 6047 A Stability Analysis on Models of Cooperative and Competitive Species Abstract Gideon Kwadzo Gogovi 1, Justice Kwame Appati 1 and

More information

Stochastic modelling of epidemic spread

Stochastic modelling of epidemic spread Stochastic modelling of epidemic spread Julien Arino Centre for Research on Inner City Health St Michael s Hospital Toronto On leave from Department of Mathematics University of Manitoba Julien Arino@umanitoba.ca

More information