Followup on Duffing Oscillator#
Our approach to modeling the Duffing Oscillator is very much like a typical computational physics project. We used a robust package, DifferentialEquations.jl
, then made a number of functions and objects which interfaced with it to answer the questions we had. Probably 90% of computational physics uses this paradigm.
We are now going to do a bit more analysis of the Duffing Oscillator, with the aim of understanding some of the interesting physics that we observed.
Lyupanov Exponents#
One thing we did not do in the lab is actually calculate the Lyupanov exponent. Recall, the Lyupanov exponent quantifies how quickly two nearby trajectories diverge from one-another.
using DifferentialEquations,Plots
function duffing(initialxv,T,α,β,γ,F,ω)
function dxvdt(xv,p,t)
x,v = xv
return[v,-2*γ*v-α*x-β*x^3+F*cos(ω*t)]
end
tspan=[0., T]
prob=ODEProblem(dxvdt,initialxv,tspan)
solve(prob)
end
duffing(initialxv,T;α,β,γ,F,ω)=duffing(initialxv,T,α,β,γ,F,ω)
duffing(;initialxv,T,α,β,γ,F,ω)=duffing(initialxv,T,α,β,γ,F,ω)
function plot_xt(trajectory,initialT,finalT,dT;opts...)
xt=[(t,trajectory(t)[1]) for t in initialT:dT:finalT]
plot(xt;opts...)
end
function plot_xt!(trajectory,initialT,finalT,dT;opts...)
xt=[(t,trajectory(t)[1]) for t in initialT:dT:finalT]
plot!(xt;opts...)
end
function plot_xv(trajectory,initialT,finalT,dT;opts...)
xv=[(trajectory(t)[1],trajectory(t)[2]) for t in initialT:dT:finalT]
plot(xv;opts...)
end
function plot_xv!(trajectory,initialT,finalT,dT;opts...)
xv=[(trajectory(t)[1],trajectory(t)[2]) for t in initialT:dT:finalT]
plot!(xv;opts...)
end
function scatter_xv(trajectory,initialT,finalT,dT;opts...)
xv=[(trajectory(t)[1],trajectory(t)[2]) for t in initialT:dT:finalT]
scatter(xv;opts...)
end
function scatter_xv!(trajectory,initialT,finalT,dT;opts...)
xv=[(trajectory(t)[1],trajectory(t)[2]) for t in initialT:dT:finalT]
scatter!(xv;opts...)
end
dparamsb=(α=-1,β=1,γ=0.1,F=0.35,ω=1)
traj1b=duffing([0.1,0],200;dparamsb...);
traj2b=duffing([0.1000001,0],200;dparamsb...);
plot_xt(traj1b,0,200,0.1;xlabel="t",ylabel="x",label="x0=0.1")
plot_xt!(traj2b,0,200,0.1;xlabel="t",ylabel="x",label="x0=0.1000001")
For those parameters the trajectories appeared to agree until roughly time t=100, and after that they are completely different.
Lets plot the difference between the trajectories, on a log scale
times=collect(0:0.1:200)
x1=[traj1b(t)[1] for t in times]
x2=[traj2b(t)[1] for t in times]
plot(times,abs.(x2-x1),yscale=:log10,
xlabel="time",ylabel="δx",label="δx₀=1e-7")
It probably makes sense to only plot at timese which are multiples of the drive period
times=collect(0.:2*pi:200)
x1=[traj1b(t)[1] for t in times]
x2=[traj2b(t)[1] for t in times]
scatter(times,abs.(x2-x1),yscale=:log10,
xlabel="time",ylabel="δx",label="δx₀=1e-7")
That looks nicer, and indeed appears to be well approximated by an exponential – up until the time that it satturates. The satturation is simple to understand: The position is bounded, so the difference in positions can only get so big.
We could fit the \(\log(\delta x)\) vs \(t\) graph to a straight line, and extract an exponent, which would be \(\lambda\):
One slightly more sophisticated thing we can do is take the limit where the difference between the starting positions of the two trajectories goes to zero. That is we look at
In fact, what we have now is a finite differences approximation to that derivative
scatter(times,abs.(x2-x1)./(x2[1]-x1[1]),yscale=:log10,
xlabel="time",ylabel="δx/δx₀",label="δx₀=1e-7")
Rather than this finite difference approach to calculate \(\partial x/\partial x_0\) we could use our automatic differentiation code. In fact the routines in DifferentialEquations.jl
are compatible with the automatic differentiation packages. Or we could write our own integrator, which is compatible with our implementation of automatic differentiation.
A somewhat simpler, but equivalent approach involves taking the derivative of our differential equations:
to get
Thus we can calculate \(\partial x/\partial x_0\) we make a length \(4\) vector \(\vec{r}=(x,v,dx/dx_0,dv/dx_0)\). That length 4 vector obeys a known diffential equation. We can integrate it by using
function duffingJx(initialxv,T,α,β,γ,F,ω)
function dxvdt(vars,p,t)
x,v,dxdx0,dvdx0 = vars
return[v,
-2*γ*v-α*x-β*x^3+F*cos(ω*t),
dvdx0,
-2*γ*dvdx0-(α+3*β*x^2)*dxdx0
]
end
tspan=[0., T]
initial=[initialxv...,1,0]
prob=ODEProblem(dxvdt,initial,tspan)
solve(prob)
end
duffingJx(initialxv,T;α,β,γ,F,ω)=duffingJx(initialxv,T,α,β,γ,F,ω)
duffingJx(;initialxv,T,α,β,γ,F,ω)=duffingJx(initialxv,T,α,β,γ,F,ω)
duffingJx (generic function with 3 methods)
One advantage of this differential approach is that we no longer see the satturation that we found in our finite differences approach. This means we can go to longer times, and extract a better exponential
dparamsb=(α=-1,β=1,γ=0.1,F=0.35,ω=1)
dtraj1b=duffingJx([0.1,0],400;dparamsb...);
plot_xt(dtraj1b,0,400,0.1;xlabel="t",ylabel="x",label="x0=0.1")
times1=collect(1:2*pi:400)
dx0dt1b=[dtraj1b(t)[3] for t in times1]
scatter(times1,abs.(dx0dt1b),yscale=:log10,
xlabel="time",ylabel="δx/δx₀",label="")
Now we just need to find the best fit line. Lets make a simple object which finds the coefficients of the best fit. For ease of use, lets make it a function-like object, which can be evaluated at times to act as the fit function.
@. exp(sin([1,2,3,4]))
4-element Vector{Float64}:
2.319776824715853
2.4825777280150008
1.151562836514535
0.46916418587400077
"""
expfit(times,values)
finds the coefficients of the best-fit function \$f(t)=A \\exp(b t)\$.
It returns a function-like object, which can be evaluated at time \$t\$. The coefficients
\$A\$ and \$b\$ can be retrieved as `f.A` or `f.b`
"""
struct expfit
A
b
# constructor
function expfit(times,values)
logvals=@. log(abs(values))
a,b = linearfit(times,logvals,[x->1.,x->x])
return new(exp(a),b)
end
end
(f::expfit)(t)=f.A*exp(f.b*t)
exponent(f::expfit)=f.b
# Our old linear fit function from earlier in the class
"""
linearfit(X,Y,functions)
takes a set of `X=(x1,x2,...xn)`, `Y=(y1,y1,...yn)` and a set of `functions=(f1, f2,...fm)`
and returns the set of coefficients `C=(c1,c2,..cm)` which minimize
n m
χ²= ∑ (yi- ∑ cj fj(xi))^2
i=1 j=1
It is implemented by constructing the `n×m` matrix `A` with matrix elements
Aᵢⱼ= fj(xi)
then `(AᵗA)C=AᵗY`, where `Y=(y1,y2,...yn)`. Thus the optimal coefficients are
`(AᵗA)⁻¹(AᵗY)`, which can be implemented with `(AᵗA)\\(AᵗY)`.
"""
function linearfit(X,Y,functions)
A=[f(x) for x in X, f in functions ]
return transpose(A)*A\(transpose(A)*Y) # This is equivalent to (AᵗA)⁻¹(AᵗY)
end
linearfit
function expfitfun(times,values)
logvals=@. log(abs(values))
a,b = linearfit(times,logvals,[x->1.,x->x])
fun(t)=exp(a+b*t)
return fun
end
expfitfun (generic function with 1 method)
length(times[10:end])
length(log.(abs.(dx0dt1b[10:end])))
55
fitvalues=linearfit(times1[10:end],log.(abs.(dx0dt1b[10:end])),[x->1.,x->x])
2-element Vector{Float64}:
-5.923910239262356
0.16830525712504346
bestfit(t)=exp(fitvalues[1]+fitvalues[2]*t)
bestfit (generic function with 1 method)
scatter(times1,abs.(dx0dt1b),yscale=:log10,
xlabel="time",ylabel="δx/δx₀",label="")
fitvals2=[bestfit(t) for t in times1]
plot!(times1,fitvals2,label="best fit")
fitfun1b=expfit(times1[10:end],dx0dt1b[10:end])
scatter(times1,abs.(dx0dt1b),yscale=:log10,
xlabel="time",ylabel="δx/δx₀",label="")
fitvals=[fitfun1b(t) for t in times1]
plot!(times1,fitvals,label="best fit")
fitfun1b.b # the Lyapunov exponent
0.16830525712504346
Generic Deviations#
For our initial conditions we need to specify both \(x_0\) and \(v_0\). Therefore the sensitivity to initial conditions is actually encoded in a tensor,
This matrix encodes how much the phase space location \((x,v)\) at time \(t\) changes when we change initial conditions \((x_0,v_0)\).
The determinant of \(J\) tells you how much the volume of phase space has changed from time \(t=0\) to time \(t\). IE. the triangle of phase space bounded by \((x_0,v_0),(x_0+\delta x_0,v_0),(x_0,v_0+\delta v_0)\) maps onto the triangle \((x,v),(x+\delta x_1,v+\delta v_1),(x+\delta x_2,v+\delta v_2)\) where
The ratio of the areas of those two triangles is \(\det J\)
For a Hamiltonian (non-disipative system), this determinant will be \(1\). When \(\gamma\neq 0\) our model is not Hamiltonian, and the phase space volume will not be conserved. Nonetheless, one can write
which is referred to as the Canonical Poisson bracket.
The Jacobian \(J\) describes the stretch and twist of a small patch of phase space. It is useful to find its eigenvalues and eigenvectors. The eigenvalues \(j_1,j_2\) tell you how much phase space is squeezed or stretched along the principle axes. For a Hamiltonian system \(j_1\times j_2=1\), meaning that you stretch along one direction, and shrink along the other.
We define the (local) Lyapanov exponent from the time dependence of eigenvalue of \(J\) with the largest magnitude.
using LinearAlgebra
eigvals([1. 1.; 1. 1.])
2-element Vector{Float64}:
0.0
2.0
function duffingJ(initialxv,T,α,β,γ,F,ω)
function dxvdt(vars,p,t)
x,v,dxdx0,dvdx0,dxdv0,dvdv0 = vars
return[
#= change in x=# v,
#= change in x=# -2*γ*v-α*x-β*x^3+F*cos(ω*t),
#= change in dx/dx0=# dvdx0,
#= change in dv/dx0=#-2*γ*dvdx0-(α+3*β*x^2)*dxdx0,
#= change in dx/dv0=# dvdv0,
#= change in dv/dx0=#-2*γ*dvdv0-(α+3*β*x^2)*dxdv0
]
end
tspan=[0., T]
initial=[initialxv...,1,0,0,1]
prob=ODEProblem(dxvdt,initial,tspan)
solve(prob)
end
duffingJ(initialxv,T;α,β,γ,F,ω)=duffingJ(initialxv,T,α,β,γ,F,ω)
duffingJ(;initialxv,T,α,β,γ,F,ω)=duffingJ(initialxv,T,α,β,γ,F,ω)
duffingJ (generic function with 3 methods)
max(1,2,22,3,4,5)
22
maximum([1,2,33,4,3,2])
33
function jacobian(vars)
return [vars[3] vars[4]; vars[5] vars[6]]
end
largestev(mat)=max(abs.(eigvals(mat))...)
largestev (generic function with 1 method)
dparamsb=(α=-1,β=1,γ=0.1,F=0.35,ω=1)
Jtraj1b=duffingJ([0.1,0],400;dparamsb...);
times1=collect(1:2*pi:400)
Jdxdx0=[Jtraj1b(t)[3] for t in times1]
Jdv0x0=[Jtraj1b(t)[4] for t in times1]
Jdxdv0=[Jtraj1b(t)[5] for t in times1]
Jdvdv0=[Jtraj1b(t)[6] for t in times1]
scatter(times1,abs.(Jdxdx0),yscale=:log10,
xlabel="time",label="δx/δx₀")
scatter!(times1,abs.(Jdv0x0),yscale=:log10,
xlabel="time",label="δv/δx₀")
scatter!(times1[2:end],abs.(Jdxdv0)[2:end],yscale=:log10,
xlabel="time",label="δx/δv₀")
scatter!(times1[2:end],abs.(Jdvdv0)[2:end],yscale=:log10,
xlabel="time",label="δv/δv₀")
plot(times1,[largestev(jacobian(Jtraj1b(t))) for t in times1],
yscale=:log10,label="Largest Eigenvalue of Jacobian")
scatter!(times1,abs.(Jdxdx0),yscale=:log10,
xlabel="time",label="δx/δx₀")
Clearly finding the Jacobian was not so important: we will essentially get the same result as when we just used dx/dx0. Nonetheless, we now have access to what is happening to the phase space volume
plot(times1,[abs(det(jacobian(Jtraj1b(t)))) for t in times1],
label="Determiant of Jacobian",ylim=(0,1),yscale=:log10)
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
┌ Warning: No strict ticks found
└ @ PlotUtils ~/.julia/packages/PlotUtils/8mrSm/src/ticks.jl:194
At short time the phase space volume exponentially falls, but after about time 100, it starts oscillating wildly. Those oscillations are unphysical, and are a sign of some sort of numerical error. The problem is that the Jacobian has one very large eigenvalue, and one very large eigenvalue. These are on such different scales that we can’t get them both right using machine precision. The determinant, which is the product of the eigenvalues, gets messed up when we are no longer able to sensibly extract the smaller eigenvalue.
We say that the Jacobian at long times is ill-conditioned. Nonetheless, the largest eigenvalue is still reliable. There are tricks to fixing this, based on either QR decomposition or repeated Gram-Schmidt orthogonalization. We will discuss both QR decomposition and the Gram-Schmidt algorithm later in the course (but will probably not have a chance to explain how to apply it here). Here is a pretty readible paper on the Gram-Schmidt approach.
The fact that one of the eigenvalues becomes very small means that all of phase space is collapsing onto a line. This line is twisted around in space:
longtraj1b=duffing([0.1,0],100000;dparamsb...);
scatter_xv(longtraj1b,2*pi*500,100000,2*pi;xlabel="x",ylabel="v",label="",
xrange=[-2,2],yrange=[-2,2],markersize=0.1)
Now we can make a function which calculates the (local) Lyapunov exponent
function Lyupanov(initialxv,T,α,β,γ,F,ω)
trajectory=duffingJ(initialxv,T,α,β,γ,F,ω);
times=collect(1:2*pi/ω:T)
Jevs=[largestev(jacobian(trajectory(t))) for t in times]
return exponent(expfit(times,Jevs))
end
Lyupanov(initialxv,T;α,β,γ,F,ω)=Lyupanov(initialxv,T,α,β,γ,F,ω)
Lyupanov(;initialxv,T,α,β,γ,F,ω)=Lyupanov(initialxv,T,α,β,γ,F,ω)
Lyupanov (generic function with 3 methods)
Lyupanov([0.1,0],400;dparamsb...)
0.15038236928769205
Lyupanov(;initialxv=[0.1,0],T=400,α = -1, β = 1, γ = 0.1, F = 0.35, ω = 1.)
0.15038236928769205
@time sweep1=[(F,Lyupanov(;initialxv=[0.1,0],T=400,α=-1,β=1,γ=0.1,F=F,ω=1.))
for F in 0.:.0025:0.6];
0.591240 seconds (15.67 M allocations: 1.612 GiB, 13.01% gc time, 5.11% compilation time)
@time sweep2=[(F,Lyupanov(;initialxv=[1.1,0],T=400,α=-1,β=1,γ=0.1,F=F,ω=1.))
for F in 0.:.0025:0.6];
0.567341 seconds (15.38 M allocations: 1.587 GiB, 13.29% gc time, 2.97% compilation time)
plot(sweep1,xlabel="F",ylabel="λ",label="x₀=0.1")
plot!(sweep2,label="x₀=1.1")
The regions of positive Lyupanov Exponent form a fractal in parameter space
ωvals=0.5:0.005:1.5
Fvals=0.2:0.005:0.6
@time lyupgrid=[Lyupanov(;initialxv=[1.1,0],T=50,α=-1,β=1,γ=0.1,F=F,ω=ω) for F in Fvals,
ω in ωvals];
5.520488 seconds (148.14 M allocations: 15.199 GiB, 12.54% gc time, 0.46% compilation time)
heatmap(ωvals,Fvals,lyupgrid,xlabel="ω",ylabel="F")