Precise definition of Wiener process

Having used DifferentialEquations for two years, I have understood that I still do not understand the precise definiton of Wiener process.

I try to solve the following system of SDEs,

function determ_dyn!(du, u, p, t)
    omega, A, B = p
    du[1] = B+A*cos(omega*t)
    du[2] = 0
    nothing
end

function noise!(du, u, p, t)
    omega, A, B = p
    du[1] = 1/(2*1im)*(exp(1im*u[1])*u[2]-conj(u[2])*exp(-1im*u[1]))
    du[2] = -1/2*(1-abs(u[2])^2)*exp(-1im*u[1])
    nothing
end

and write

t0 = 100
A = 0.5
B = 1.0
omega = 1.0
u0 = [2*pi*rand(), 0.2*rand()+1im*0];
tspan = (0., t0)
p = (omega, A, B)

prob = SDEProblem(determ_dyn!, noise!, noise=WienerProcess(0.8, 0.1), u0, tspan, p)
sol = solve(prob);

I assume that noise=WienerProcess(0.8,0.1) corresponds to the Wiener process with drift \mu=0.8 and volatility \sigma=0.1. But I cannot find in documentation how to define Wiener process with non-zero mean.

Using nonstandard analysis (in which we have truly infinitesimal numbers such as dt) I suspect the Weiner process you mention is the process such that x(0)=0 and x(t+dt) = x(t) + .8 dt + Normal(0,sigma*sqrt(dt))

That is, the increments of the process come from a linear extrapolation plus a random normal increment whose VARIANCE grows linearly with time.

This is consistent with the sum of independent random variables having variance equal to the sum of the variances and the number of random variables in an interval of time proportional to the size of the time interval.

I’ve found nonstandard analysis to be a much more simple intuitive view of analysis in general and stochastic stuff in particular.

However, I haven’t read the docs on the Julia stuff so I could be misinterpreting.

1 Like

Technically, those are no longer Wiener processes, if you have a nonzero mean and non-unit volatility, you have an ItĂ´ process.

4 Likes

But according to Wiki, see Wiener process - Wikipedia , I conclude that is called a Wiener process with drift. In addition, at least in Wolfram Mathematica Wiener process by definition has two parameters, mean & variance.

Yes, terminology is a muddle. Textbooks I am familiar with usually define “the” Wiener process and just transform to Itô from there.

Make sense, thank you