Math 415

One-Dimensional System

Fixed Point

Consider the one-dimensional system:

x˙=f(x)

The fixed point found by setting x˙=0. For the fixed point x. We will use it for determining the stability.

Example

For equation x˙=x21, we have it's plot here:

---
title: x' = x^2-1
xLabel: x
yLabel: x'
bounds: [-2,2,-2,2]
disableZoom: false
grid: true
---
f(x)=x^2-1
g(x)=0

The left fixed point x=(1,0) is a stable point, while the right FP(1,0) is unstable.

Linear Stability Analysis

In order to know the behavior around fixed point linearization is a great method to analyze.

Let x be a fixed point, and let η(t)=x(t)x be a small perturbation away from x. To see whether the perturbation grows or decays, we derive a differential equation for η. Differentiation yields

η˙=ddt(xx)=x˙,

since x is constant. Thus η˙=x˙=f(x)=f(x+η). Now using Taylor’s expansion we obtain

f(x+η)=f(x)+ηf(x)+O(η2),

where O(η2) denotes quadratically small terms in η. Finally, note that f(x)=0 since x is a fixed point. Hence

η˙=ηf(x)+O(η2).

Now if f(x)0, the O(η2) terms are negligible and we may write the approximation

η˙ηf(x).

This is a linear equation in η, and is called the linearization about x*. It shows that the perturbation:

η(t)={Grows Exponentiallyf(x)>0decays Exponentiallyf(x)<0

Potentials

There’s another way to visualize the dynamics of the first-order system: potential V(x) is defined by

f(x)=dVdx

Consider the relation between potential and time V(x(t)), by using chain rule we have

dVdt=dVdxdxdt

since x˙=f(x), we obtain

dVdt=(dVdx)20.

The equilibrium point happens at dV/dx=0, the V remains constant. Since dV/dx=0 implies x˙=0.

Example

Graph the potential for the system x˙=xx3, and identify all equilibrium points.

Solution: Solving dV/dx=xx3 yields

V=12x2+14x4+C.

Once again we set C=0. Figure shows the graph of V. The local minima at x=±1 correspond to stable equilibria, and the local maximum at x=0 corresponds to an unstable equilibrium.

---
title: V(x)-Potential
xLabel: x
yLabel: V(x)
bounds: [-2,2,-0.5,1]
disableZoom: false
grid: true
---
f(x)=-0.5x^2+0.25x^4

Bifurcations

Saddle-Node

Typical Form:

x˙=r±x2 image/svg+xml Master slide Slide Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing

Splitting into two branches.

Transcritical Bifurcation

Normal Form:

x˙=rxx2 image/svg+xml

Some people say that an exchange of stabilities has taken place between the two fixed points.

Pitchfork Bifurcation

This bifurcation is common in physical problems that have a symmetry.

Supercritical Pitchfork Bifurcation

Normal Form:

x˙=rxx3

Note that this equation is invariant under the change of variables xx.

image/svg+xml Master slide Slide Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing Drawing

One stable splitting two stable and one unstable.

Subcritical Pitchfork Bifurcation

Normal Form:

x˙=rx+x3

One stable and two unstable to one stable.

Dimensional Analysis

Non-dimensionalization

Differential equations that show up in modeling “real world situations” usually have many constants in them. Often one can reduce the number of constants in a problem by choosing the right units for the various quantities in the problem. In the other words, we can convert the variables to ratio that has no unit to analyze multiple different coefficient problems.

We define a dimensionless time τ by

τ=tT

where τ is dimensionless time, t is dimensional time, T is characteristic time scale. We need to choose T very carefully to do the non-dimensionalization.

Timescale

λ is the rate of growth. 1/|λ| is timescales of growth.

Example 1

Suppose that a quantity x(t) changes in time according to the ODE

(1)dxdt=a+bx+cx2.

The coefficients a, b, and c must all have different units, otherwise we could not add the terms a, bx, and cx2.

To simplify the equation we choose a constant value for x, let's say x0, and we let this value be our unit. The ratio

ξ=xx0

has no units. In the same way we can pick a unit of time t0 and introduce the quantity

τ=tt0

which also has no units.

The quantities ξ and τ are nondimensionalized versions of our original variables x and t. The point of nondimensionalization is that we can now derive a differential equation for ξ and τ, and then afterwards figure out which choice of the units x0 and t0 simplifies things most.

In this example we substitute

x(t)=x0ξ(τ),andt=t0τ

which leads to

dxdt=x0t0dξdτ

by the chain rule, and

a+bx+cx2=a+(bx0)ξ+(cx02)ξ2

by direct substitution. The differential equation (1) for x and t is therefore equivalent with

x0t0dξdτ=a+(bx0)ξ+(cx02)ξ2,

and thus

dξdτ=t0ax0+(t0b)ξ+(t0x0c)ξ2.

At this point we choose x0 and t0. We can try to make the constant term and the coefficient of ξ both equal to 1. If a0 and b0 then this is possible provided we choose

t0=1b,x0=at0=ab.

The coefficient of ξ2 then becomes

α=t0x02c=a2cb3,

and we get the following differential equation for ξ as a function of τ:

(2)dξdτ=1+ξ+αξ2.

This is a nondimensionalized version of equation (1). Note that instead of three undetermined parameters (a,b,c) it only has one parameter, namely α.

Example 2

The Logistic equation:

N˙=rN(1NK)

where N is population, t is time, r growth rate, K carrying capacity.

The non-dimensionalize term:

τ=tTandx=NN0

Thus, we have

dNdt=N0Tdxdτdxdτ=Trx(1N0Kx)=x(1x)

when T=1/r and N0=K.

Two-Dimensional System

General form

2D system:

{x˙=f(x,y)y˙=g(x,y)

Example

mcϕ¨=bϕ˙mgsinϕ+mcsinϕcosϕ

Let x=ϕ, y=ϕ˙, then we have

{x˙=yy˙=bmcygcsinx+sinxcosx

Linear form

{x˙=ax+byy˙=cx+dy

where a,b,c,d are R. Let x=(xy) , A=(abcd), so we have x˙=Ax.
The fixed points: when x˙=y˙=0 or x˙=0.

Uncoupled System

Consider the system

x˙=(a001)x

Notice {x˙=axy˙=y = {x=x0eaty=y0et the trajectory is different and depends on a:

Created by potrace 1.10, written by Peter Selinger 2001-2011

Classified these cases: (a) Stable node, (b) Stable star,
(c) stable node, (d) line of fixed points, (e) saddle point

Stability Technology

When x is a fixed point:

  1. Attracting but not Lyapunov Stable
Created by potrace 1.10, written by Peter Selinger 2001-2011
  1. Lyapunov Stable but not attracting
Created by potrace 1.10, written by Peter Selinger 2001-2011
  1. Attracting and Lyapunov is Stable Start (b) case.

General Linear System

Consider following form

x˙=(abcd)x

Note: The straight-line trajectories is if x(0)=(x00) then x(t)=(x(t)0) which is stays on x-axis.

Now let's generalize this idea. Let's guess x(t)=eλtv , hence λ is the growth rate and v is the direction of growth (the vector).

x(t)=eλtvx˙(t)=λeλtv&Ax=eλtAv

So, x˙(t)=Ax implies λeλtv=eλtAv and

Av=λv

So, v is an eigenvector and λ is an eigenvalue. x(t)=eλtv is an eigensolution.

2D Eigenvalues

Definition
(AλI)v=0

Then the this singular matrix has determinant zero:

det(AλI)=0λ2τλ+Δ=0λ2(a+d)λ+(adbc)=0

Thus, λ=τ2±τ24Δ2, τ=a+d, and Δ=adbc.
The eigenvectors are when you plug the eigenvalues back to the original form.

Note: τ=λ1+λ2, Δ=λ1λ2

System form

When λ1λ2 the general form of the system is

x(t)=c1eλ1tv1+c2eλ2tv2

Example

For linear system:

{x˙=x+yy˙=4x2ysubject to{x(0)=2y(0)=3

we have A=(1142) and x0=(23) . Then the τ=12=1, Δ=24=6, so λ2+λ6=0 gives λ1=2 and λ2=3.
So, by plugging λ1,2 backs to determent equation, we have

λ1=2:(11)andλ2=3:(14)

By set t=0 I get c1=c2=1. Therefore the general solution is

x(t)=e2t(11)+e3t(14)

Phase diagrams & Fixed Points

Normal Cases

The different λ are right below:

Created by potrace 1.10, written by Peter Selinger 2001-2011

(a) 0<λ1<λ2 (top left), (b) λ1=0<λ2 top right, (c) λ1<0<λ2 (down left), (d) λ1<λ2<0 (down right).

Remark: When λ1<λ2=0 is the a line of stable FPs(reverse arrow for (b)).

Spacial Cases

When λ1=λ2, there are two possible cases:

  1. There are two independent eigenvectors v1,v2.
    This will lead the A to (λ00λ) , so the diagram would be Star node. If λ<0, stable star. If λ>0, unstable star. When λ=0, all points are fixed points.
  2. There is only one eigenvector.
    Only eigenvector would be A=(λb0λ) thus the eigenvector is (b0) . This is called degenerative node
Created by potrace 1.10, written by Peter Selinger 2001-2011

This graph is with b>0 and λ<0.

If τ24Δ<0 we have λ1,2=α±iω where the α is complex conjugate eigenvalues.

Created by potrace 1.10, written by Peter Selinger 2001-2011

Poincare Diagram

Stability_Diagram.png|600

Nullclines

The nullclines are designed as the lines along with x,y not changing (i.e. x˙=0, y˙=0). For example, when {x˙=0y˙=0 , we have x+ey=0 and y=0. so it will look like this.

Created by potrace 1.10, written by Peter Selinger 2001-2011

Note:

  1. Not trajectory
  2. Nullclines cross at fixed point
  3. Trajectories are either horizontal (y=0) or vertical (x=0) when it at numllclines

System Uniqueness Theorem

Consider the IVP(initial value problem). If f and it's partial derivative (Jacobian matrix) are continuous for all x in an open-connected set DR2 contain of x0, hence the trajectory has only one solution. No cross point.

Linearization

Consider a general linear system and it's fix point (x,y), the perturbation is {x(t)=x+u(t)y(t)=y+v(t). Now consider f(x,y)=f(x+u,y+v) we can use Taylor Expansion to get below:

(x˙y˙)=(f(x,y)g(x,y))(u˙v˙)=A(uv)+Quadratic Terms

So A=(fxfygxgy) under fixed point (x,y).

When λ=a+bi

eλt=eateibt=eat[cos(bt)+sin(bt)]

Reversible

Many mechanical systems have time-reversal symmetry. This means that their dynamics look the same whether time runs forward or backward. For example, if you were watching a movie of an undamped pendulum swinging back and forth, you wouldn’t see any physical absurdities if the movie were run backward.

The system is reversible if invariant under the mapping of (t,x)(t,R(x))
Time-reversible (t,x,y)(t,x,y). We have symmetric along the x=0 with different direction of arrows. In other words, for 2D system {x˙=f(x,y)y˙=g(x,y) it such that f is odd in y and g is even in y ,aka f(x,y)=f(x,y) and g(x,y)=g(x,y).

Created by potrace 1.10, written by Peter Selinger 2001-2011

Invariant under (t,x,y)(t,x,y) give us it is symmetric along with y=0 but the direction of arrow at not change.

Note: Any mechanical systems have time-reversal symmetry. i.e. mx¨=F(x). is symmetric under time reversal.

Polar Coordinate

Sometimes we cannot justified the centre case, we might trans the system into polar system to analyze. The following example:

Waiting to be filled Week 7 Class 18

Trans to polar system. Let (x,y)=(rcosθ,rsinθ). Then using

rr˙=xx˙+yy˙,θ˙=xy˙yx˙r2

For polar system we can determine the limit cycle by let r˙=0 then solved for r. If there exist r>0 that means there exist circular limit cycle. We also can determine what is the behavior around limit cycle by analyzing the vector field around fixed point for r˙,r.

Wolfram Code

f[x_, y_] := y
g[x_, y_] := -a*y*(x^2 + y^2 - 1) - x


x0 := r*Cos[\[Theta]]
y0 := r*Sin[\[Theta]]

fr[x_, y_] := (x*f[x, y] + y*g[x, y])/r
fth[x_, y_] := (x*g[x, y] - y*f[x, y])/r^2

rp := Simplify[fr[x0, y0]]
thp := Simplify[fth[x0, y0]]

rp
thp

Poincaré–Bendixson Theorem

  1. R is a closed, bounded subset of the plane;
  2. x˙=f(x) is a continuously differentiable vector field on an open set containing R;
  3. R does not contain any fixed points; and
  4. There exists a trajectory C that is "confined" in R, in the sense that it starts in R and stays in R for all future time.
    Then either C is a closed orbit, or it spirals toward a closed orbit as t. In either case, R contains a closed orbit.

Note. The problem of this question is find the trapping region. Here is an example showing how to make it.

Example

Given a system:

r˙=r(1r2)+μrcosθθ˙=1

Consider r1 as the radius for inner circle, r2 as the radius for outer circle. Then for r1 must such that r˙>0 and for r2 must such that r˙<0. Thus we have

{r1˙=r1(1r12)+μr1cosθ>0r2˙=r2(1r22)+μr2cosθ<0

Thus, to hem in the limit cycle as tightly as we can. For instance, we could pick
rmin=0.9991μ. (Even rmin=1μ works, but more careful reasoning is required.) By a similar argument, the flow is inward on the outer circle if rmax=1.0011+μ.

Conservation Systems

The energy is often called a conserved quantity, a constant of motion, or a first integral. Systems for which a conserved quantity exists are called conservative systems.

Conservative

x˙=f(x) is a conservative system. if there exist a real valued function that is constant along trajectories, but non-constant on every open set.

E(x,y) where dEdt=(x˙,y˙)(dEdx,dEdy)

Linear centre implies nonlinear centre.

Process

Let's explain with example. Newton's Second Law is a classic conservation system: mx¨=F(x). By potential energy we have F(x) force as F(x)=dVdx where V(x) is the potential energy. Then we have mx¨+dVdx=0. Now the only thing we need to do is integration. By multiplied x˙=dxdt we have

mx¨x˙+dVdxx˙=0ddt(m2x˙2+V(x))=0

Thus, E=12mx˙2+V(x) is the energy which is a Conserved Quantity. And the 12mx˙2 is the Kinetic Energy and V(x) is Potential Energy in Physics. It is constant along trajectories.

Note: A conservative system cannot have attracting fixed points. (they are circle)

Check Conservative

Consider a polar system x˙=sinθDx2, xθ˙=cosθ+x2 . Now check if E(x,θ)=x33xcosθ.
\begin{proof}
First take the derivative with respect to t

ddtE(x,θ)=3x2dxdt3cosθdxdt+3xsinθdθdt=3x2(sinθ)3cosθ(sinθ)+3xsinθ(cosθx+x)=0

\end{proof}

Theorem

(Nonlinear centers for conservative systems) Consider the system x˙=f(x) , where x=(x,y)R2, and f is continuously differentiable. Suppose there exists a conserved quantity E(x) and suppose that x is an isolated fixed point (i.e., there are no other fixed points in a small neighborhood surrounding x). If x is a local minimum of E, then all trajectories sufficiently close to x are closed.

Index Theory

The index of a closed curve C is an integer that measures the winding of the vector field on C. The index also provides information about any fixed points that might happen to lie inside the curve.

Then at each point x on C, the vector field x˙=(x˙,y˙) makes a well-defined angle ϕ=tan(y˙/x˙) with the positive x-axis.

Created by potrace 1.10, written by Peter Selinger 2001-2011

Then the index of the closed curve C with respect to the vector field f is defined as

IC=12π[ϕ]C

Given the ordered directions rotate once counterclockwise as we go in increasing order from vector 1 to vector 8. Hence IC=+1. Of course the clockwise is IC=1. The example of IC=+1 is

Created by potrace 1.10, written by Peter Selinger 2001-2011

Properties

  1. Suppose that C can be continuously deformed into C without passing through a fixed point. Then IC=IC.
  2. If C doesn’t enclose any fixed points, then IC=0.
  3. If we reverse all the arrows in the vector field by changing tt, the index is unchanged (Invariant).
  4. Suppose that the closed curve C is actually a trajectory for the system, i.e., C is a closed orbit. Then IC=+1.

Note. The Invariant set means any trajectory that starts in set A stays in A for all time.

Theorem 1

If a closed curve C surrounds n isolated fixed points x1,,xn, then

IC=I1+I2++In

where Ik is the index of xk, for k=1,,n.

Theorem 2

Any closed orbit in the phase plane must enclose fixed points whose indices sum to +1.

\begin{proof}
Let C denote the closed orbit. From property (4) above, IC=+1. Then Theorem 1 implies k=1nIk=+1.
\end{proof}

Fact

IC=+1: Degenerate, Spiral, Centre, Nodes, Stars.
IC=1: Saddle.
There is no possible to have closed orbit for those fixed points on the straight-line vector space. Since it will always have cross of two orbit.

Invariant

Invariant lines: Every point along the line are also have same direction.

It could happen on fixed points. Let's looks some example:

Example

Let A,B,C as three fixed point, so there are three linear line AB,BC,AC. Assume that they are y=mx+b. Then, invariant means y˙=mx˙ are consistency on each y=mk+b.
You can usually plug y into y˙,x˙ to see if they match the y˙=mx˙.

Also, to know that for y=x2, we want to check y˙=2xx˙.

Gradient System

Suppose the system can be written in the form x=V, for some continuously differentiable, single-valued scalar function V(x). Such a system is called a gradient system with potential function V.

If we want to know if a system is gradient, we need to check the definition. If the V/x=f(x,y), V/y=g(x,y). Thus let's explain with an example

Example

For system x˙=y2+ycosx, y˙=2xy+siny.
Now we test V/x=f(x,y) we have

Vx=y2ycosxVx=y2xysinx+C

Then we test V/y=g(x,y) we have

Vy=2xysinyVy=y2xysinx+C

Thus we can find a potential function V(x,y)=y2xysinx such the conditions. So the system is a gradient system.

Theorem

Closed orbits are impossible in gradient systems.

How to find the Potential function

In 2D, the gradient system such that

x˙=Vx,y˙=Vy

Thus, we can use an example to explain it:

Example

Show that there are no closed orbits for the system x˙=siny, y˙=xcosy.
\begin{proof}
The system is a gradient system with potential function V(x,y)=xsiny. We can see that the V/x=siny, V/y=xcosy, then we have V/x=xsiny and V/y=xsiny. Thus we can find there exist a V(x,y) such the condition of gradient system.
\end{proof}

Liapunov Function

consider a system x˙=f(x) with a fixed point at x. Suppose that we can find a Liapunov function, i.e., a continuously differentiable, real-valued function V(x) with the following properties:

  1. V(x)>0 for all xx, and V(x)=0. (We say that V is positive definite.)
  2. V˙<0 for all xx. (All trajectories flow “downhill” toward x.)

Liapunov function is a "there exist" statement which means you only find one function that such the conditions then you can say it is Liapunov.

Note. V˙=0 means the minimum or maximum stable pr unstable point of the system.

Note. Asymptotic stability means that solutions that start close enough not only remain close enough but also eventually converge to the equilibrium.

Example

For given system x˙=yx3, y˙=xy3.
\begin{proof}
By constructing a Lyapunov function V(x,y)=ax2+by2, we can form a suitable a,b for the system. Then we have V˙(x,y)=2axx˙+2byy˙, by substituting the system we have

V˙(x,y)=2ax(yx3)+2by(xy3)=2axy2ax42bxy2by4=2xy(ab)2x4a2y4b

When a=b>0, we have V˙(x,y)=2x4a2y4b<0. Thus the system is stable. Since the system is stable, so there is no closed orbits.
\end{proof}

Chaos System

Lorenz Equation

Consider the Lorenz Equation:

x˙=σ(yx)y˙=rxyxzz˙=xybz

Here σ,r,b>0 are parameters: σ is the Prandtl number, r is the Rayleigh number, and b has no name.

Properties

Nonlinearity

The system has only two nonlinearities, the quadratic terms xy and xz.

Symmetry

There is an important symmetry in the Lorenz equations. If we replace (x,y)(x,y) in system, the equations stay the same. Hence, if (x(t),y(t),z(t)) is a solution, so is (x(t),y(t),z(t)). In other words, all solutions are either symmetric themselves, or have a symmetric partner.

Volume Contraction

The Lorenz system is dissipative: volumes in phase space contract under the flow.

Pick an arbitrary closed surface S(t) of volume V(t) in phase space. Think of the points on S as initial conditions for trajectories, and let them evolve for an infinitesimal time dt. Then S evolves into a new surface S(t+dt); what is its volume V(t+dt)?

Let n denote the outward normal on S. Since f is the instantaneous velocity of the points, fn is the outward normal component of velocity.

Hence

V(t+dt)=V(t)+(volume swept out by tiny patches of surface,integrated over all patches),

so we obtain

V(t+dt)=V(t)+S(fn)dA.

Hence

V˙=V(t+dt)V(t)dt=1dtSfndA.

Finally, we rewrite the integral above by the divergence theorem, and get

V˙=VfdV.

For the Lorenz system,

f=x[σ(yx)]+y[rxyxz]+z[xybz]=σ1b<0.

Since the divergence is constant, it reduces to

V˙=(σ+1+b)V,

which has solution

V(t)=V(0)e(σ+1+b)t.

Thus volumes in phase space shrink exponentially fast. The important key here is showing f<0 which implies the system is dissipative.

One-Dimensional Map

Fixed Point

The fixed point in one-dimensional map is different from continuity function. The general form of the one-dimensional map is

xn+1=f(xn)

Thus, we set a point x that is always goes to itself x=f(x). And that would be the fixed point.

Stability Analysis

Similar to continuity function, we also using perturbation to analyze it. To determine the stability of x, we consider a nearby orbit xn=x+ηn and ask whether the orbit is attracted to or repelled from x. That is, does the deviation ηn grow or decay as n increases? Substitution yields

x+ηn+1=xn+1=f(x+ηn)=f(x)+f(x)ηn+O(ηn2).

But since f(x)=x, this equation reduces to

ηn+1=f(x)ηn+O(ηn2).

Suppose we can safely neglect the O(ηn2) terms. Then we obtain the linearized map ηn+1=f(x)ηn with eigenvalue or multiplier λ=f(x).

The solution of this linear map can be found explicitly by writing a few terms: η1=λη0, η2=λη1, and so in general ηn=λnη0. If |λ|=|f(x)|<1, then ηn0 as n and the fixed point x is linearly stable. Conversely, if |f(x)|>1 the fixed point is unstable. In mathematics language

ηn={Stable|f(x)|<1Unstable|f(x)|>1

There is a special case when multiplier λ=0 i.e. f(x)=0 we call superstable.

Logistic Map

The map is looks like

xn+1=rxn(1xn)

The fixed points are x=rx(1x) which are x=0 and x=11/r. Since we only consider the positive, the second fixed point has range of allowable r1.

By analyzing the stability, we have the multiplier f(x)=r2rx. Thus we have stability for x=0:

ηn={Stabler<1Unstabler>1

and for x=11/r:

ηn={Stable1<r<3Unstabler>3

Bifurcation Type

From the map we can easily see that what type at each point:

As we can see, when r=1 it is a transcritical bifurcation.

Once, it goes to r=3 it is a new bifurcation: flip bifurcation.

Period-p Orbit

Sometimes in logistic map, there is also has period cycle that is not chaos behavior. For p-cycle, we defined as follow: A p-cycle exists iff there are p's points such that f(x1)=x2,f(x2)=x3,f(x3)=x4,f(x4)=f(x5)f(xp)=f(x1). Equivalently, such a x1 must satisfy f(f(x1))=x1=fp(x1)=x1.

Period 2 Cycle

A 2-cycle exists if and only if there are two points p and q such that f(p)=q and f(q)=p. Equivalently, such a p must satisfy f(f(p))=p.

To find p and q, we need to solve the fourth-degree equation f2(x)=x. That sounds hard until you realize that the fixed points x=0 and x=11r are trivial solutions of this equation. (They satisfy f(x)=x, so f2(x)=x automatically.) After factoring out the fixed points, the problem reduces to solving a quadratic equation.

Expansion of the equation f2(x)x=0 gives r2x(1x)[1rx(1x)]x=0. After factoring out x and x(11r) by long division, and solving the resulting quadratic equation, we obtain a pair of roots

p,q=r+1±(r3)(r+1)2r,

which are real for r>3. Thus a 2-cycle exists for all r>3, as claimed. At r=3, the roots coincide and equal x=11r=23, which shows that the 2-cycle bifurcates continuously from x. For r<3 the roots are complex, which means that a 2-cycle doesn't exist. In mathematical language

f2(x)={Not Existr<3Two Roots are Samer=3Existr>3

Stability

Now we’re on familiar ground. To determine whether p is a stable fixed point of f2, we compute the multiplier

λ=ddx(f(f(x)))|x=p=f(f(p))f(p)=f(q)f(p).

(Note that the same λ is obtained at x=q, by the symmetry of the final term above. Hence, when the p and q branches bifurcate, they must do so simultaneously.)

After carrying out the differentiations and substituting for p and q, we obtain

λ=r(12q)r(12p)=r2[12(p+q)+4pq]=r2[12(r+1)/r+4(r+1)/r2]=4+2rr2.

Therefore the 2-cycle is linearly stable for |4+2rr2|<1, i.e., for 3<r<1+6.

Lyapunov exponent (one-dimensional map)

We quantified sensitive dependence by defining the Liapunov exponent for a chaotic differential equation. This is example in one-dimensional map

If this expression has a limit as n, we define that limit to be the Liapunov exponent for the orbit starting at x0:

λ=limn[1ni=0n1ln|f(xi)|]

Proof

\begin{proof}
Here's the intuition. Given some initial condition x0, consider a nearby point x0+δ0, where the initial separation δ is extremely small. Let δn be the separation after n iterates. If |δn||δ0|eλn, then λ is called the Lyapunov exponent. A positive Lyapunov exponent is a signature of chaos.

A more precise and computationally useful formula for λ can be derived. By taking logarithms and noting that δn=fn(x0+δ0)fn(x0), we obtain

λ1nln|δnδ0|=1nln|fn(x0+δ0)fn(x0)δ0|=1nln|(fn)(x0)|

where we’ve taken the limit δ00 in the last step. The term inside the logarithm can be expanded by the chain rule:

(fn)(x0)=i=0n1f(xi).

Hence,

λ1nln|i=0n1f(xi)|=1ni=0n1ln|f(xi)|

\end{proof}

Example

Suppose that f has a stable p-cycle containing the point x0. Show that the Liapunov exponent λ<0. If the cycle is superstable, show that λ=.

Solution: As usual, we convert questions about p-cycles of f into questions about fixed points of fp. Since x0 is an element of a p-cycle, x0 is a fixed point of fp. By assumption, the cycle is stable; hence the multiplier |(fp)(x0)|<1. Therefore ln|(fp)(x0)|<ln(1)=0, a result that we’ll use in a moment.

Note. (fp)(x0)=k=0p1f(xk) since (fp)(x0)=f(x0)f(x1)f(x2)f(xn)

Next observe that for a p-cycle,

λ=limn[1ni=0n1ln|f(xi)|]=1pi=0p1ln|f(xi)|

since the same p terms keep appearing in the infinite sum. Finally, using the chain rule in reverse, we obtain

1pi=0p1ln|f(xi)|=1pln|(fp)(x0)|<0,

as desired. If the cycle is superstable, then |(fp)(x0)|=0 by definition, and thus

λ=ln(0)=.