Movatterモバイル変換


[0]ホーム

URL:


Jump to content
WikipediaThe Free Encyclopedia
Search

Stochastic differential equation

From Wikipedia, the free encyclopedia
Differential equations involving stochastic processes
Differential equations
Scope
Classification
Solution
People

Astochastic differential equation (SDE) is adifferential equation in which one or more of the terms is astochastic process,[1] resulting in a solution which is also a stochastic process. SDEs have many applications throughout pure mathematics and are used tomodel various behaviours of stochastic models such asstock prices,[2]random growth models[3] or physical systems that are subjected tothermal fluctuations.

SDEs have a random differential that is in the most basic case randomwhite noise calculated as the distributional derivative of aBrownian motion or more generally asemimartingale. However, other types of random behaviour are possible, such asjump processes likeLévy processes[4] or semimartingales with jumps.

Stochastic differential equations are in general neither differential equations norrandom differential equations. Random differential equations are conjugate to stochastic differential equations. Stochastic differential equations can also be extended todifferential manifolds.[5][6][7][8]

Background

[edit]

Stochastic differential equations originated in the theory ofBrownian motion, in the work ofAlbert Einstein andMarian Smoluchowski in 1905, althoughLouis Bachelier was the first person credited with modeling Brownian motion in 1900, giving a very early example of a stochastic differential equation now known asBachelier model. Some of these early examples were linear stochastic differential equations, also calledLangevin equations after French physicistLangevin, describing the motion of a harmonic oscillator subject to a random force. The mathematical theory of stochastic differential equations was developed in the 1940s through the groundbreaking work of Japanese mathematicianKiyosi Itô, who introduced the concept ofstochastic integral and initiated the study of nonlinear stochastic differential equations. Another approach was later proposed by Russian physicistStratonovich, leading to a calculus similar to ordinary calculus.

Terminology

[edit]

The most common form of SDEs in the literature is anordinary differential equation with the right hand side perturbed by a term dependent on awhite noise variable. In most cases, SDEs are understood as continuous time limit of the correspondingstochastic difference equations. This understanding of SDEs is ambiguous and must be complemented by a proper mathematical definition of the corresponding integral.[1][3] Such a mathematical definition was first proposed byKiyosi Itô in the 1940s, leading to what is known today as theItô calculus.Another construction was later proposed by Russian physicistStratonovich, leading to what is known as theStratonovich integral.TheItô integral andStratonovich integral are related, but different, objects and the choice between them depends on the application considered. TheItô calculus is based on the concept of non-anticipativeness or causality, which is natural in applications where the variable is time.The Stratonovich calculus, on the other hand, has rules which resemble ordinary calculus and has intrinsic geometric properties which render it more natural when dealing with geometric problems such as random motion onmanifolds, although it is possible and in some cases preferable to model random motion on manifolds through Itô SDEs,[6] for example when trying to optimally approximate SDEs on submanifolds.[9]

An alternative view on SDEs is the stochastic flow of diffeomorphisms. This understanding is unambiguous and corresponds to the Stratonovich version of the continuous time limit of stochastic difference equations. Associated with SDEs is theSmoluchowski equation or theFokker–Planck equation, an equation describing the time evolution ofprobability distribution functions. The generalization of the Fokker–Planck evolution to temporal evolution of differential forms is provided by the concept ofstochastic evolution operator.

In physical science, there is an ambiguity in the usage of the term"Langevin SDEs". While Langevin SDEs can be of amore general form, this term typically refers to a narrow class of SDEs with gradient flow vector fields. This class of SDEs is particularly popular because it is a starting point of the Parisi–Sourlas stochastic quantization procedure,[10] leading to a N=2 supersymmetric model closely related tosupersymmetric quantum mechanics. From the physical point of view, however, this class of SDEs is not very interesting because it never exhibits spontaneous breakdown of topological supersymmetry, i.e.,(overdamped) Langevin SDEs are never chaotic.

Stochastic calculus

[edit]

Brownian motion or theWiener process was discovered to be exceptionally complex mathematically. TheWiener process is almost surely nowhere differentiable;[1][3] thus, it requires its own rules of calculus. There are two dominating versions of stochastic calculus, theItô stochastic calculus and theStratonovich stochastic calculus. Each of the two has advantages and disadvantages, and newcomers are often confused whether the one is more appropriate than the other in a given situation. Guidelines exist (e.g. Øksendal, 2003)[3] and conveniently, one can readily convert an Itô SDE to an equivalent Stratonovich SDE and back again.[1][3] Still, one must be careful which calculus to use when the SDE is initially written down.

Numerical solutions

[edit]

Numerical methods for solving stochastic differential equations[11] include theEuler–Maruyama method,Milstein method,Runge–Kutta method (SDE), Rosenbrock method,[12] and methods based on different representations of iterated stochastic integrals.[13][14]

Use in physics

[edit]
See also:Langevin equation

In physics, SDEs have wide applicability ranging from molecular dynamics to neurodynamics and to the dynamics of astrophysical objects. More specifically, SDEs describe all dynamical systems, in which quantum effects are either unimportant or can be taken into account as perturbations. SDEs can be viewed as a generalization of thedynamical systems theory to models with noise. This is an important generalization because real systems cannot be completely isolated from their environments and for this reason always experience external stochastic influence.

There are standard techniques for transforming higher-order equations into several coupled first-order equations by introducing new unknowns. Therefore, the following is the most general class of SDEs:

dx(t)dt=F(x(t))+α=1ngα(x(t))ξα(t),{\displaystyle {\frac {\mathrm {d} x(t)}{\mathrm {d} t}}=F(x(t))+\sum _{\alpha =1}^{n}g_{\alpha }(x(t))\xi ^{\alpha }(t),\,}

wherexX{\displaystyle x\in X} is the position in the system in itsphase (or state) space,X{\displaystyle X}, assumed to be a differentiable manifold, theFTX{\displaystyle F\in TX} is a flow vector field representing deterministic law of evolution, andgαTX{\displaystyle g_{\alpha }\in TX} is a set of vector fields that define the coupling of the system to Gaussian white noise,ξα{\displaystyle \xi ^{\alpha }}. IfX{\displaystyle X} is a linear space andg{\displaystyle g} are constants, the system is said to be subject to additive noise, otherwise it is said to be subject to multiplicative noise. For additive noise, the Itô and Stratonovich forms of the SDE generate the same solution, and it is not important which definition is used to solve the SDE. For multiplicative noise SDEs the Itô and Stratonovich forms of the SDE are different, and care should be used in mapping between them.[15]

For a fixed configuration of noise, SDE has a unique solution differentiable with respect to the initial condition.[16] Nontriviality of stochastic case shows up when one tries to average various objects of interest over noise configurations. In this sense, an SDE is not a uniquely defined entity when noise is multiplicative and when the SDE is understood as a continuous time limit of astochastic difference equation. In this case, SDE must be complemented by what is known as "interpretations of SDE" such as Itô or a Stratonovich interpretations of SDEs. Nevertheless, when SDE is viewed as a continuous-time stochastic flow of diffeomorphisms, it is auniquely defined mathematical object that corresponds to Stratonovich approach to a continuous time limit of a stochastic difference equation.

In physics, the main method of solution is to find theprobability distribution function as a function of time using the equivalentFokker–Planck equation (FPE). The Fokker–Planck equation is a deterministicpartial differential equation. It tells how the probability distribution function evolves in time similarly to how theSchrödinger equation gives the time evolution of the quantum wave function or thediffusion equation gives the time evolution of chemical concentration. Alternatively, numerical solutions can be obtained byMonte Carlo simulation. Other techniques include thepath integration that draws on the analogy between statistical physics andquantum mechanics (for example, the Fokker-Planck equation can be transformed into theSchrödinger equation by rescaling a few variables) or by writing downordinary differential equations for the statisticalmoments of the probability distribution function.[citation needed]

Use in probability and mathematical finance

[edit]

The notation used inprobability theory (and in many applications of probability theory, for instance in signal processing with thefiltering problem and inmathematical finance) is slightly different. It is also the notation used in publications onnumerical methods for solving stochastic differential equations. This notation makes the exotic nature of the random function of timeξα{\displaystyle \xi ^{\alpha }} in the physics formulation more explicit. In strict mathematical terms,ξα{\displaystyle \xi ^{\alpha }} cannot be chosen as an ordinary function, but only as ageneralized function. The mathematical formulation treats this complication with less ambiguity than the physics formulation.

A typical equation is of the form

dXt=μ(Xt,t)dt+σ(Xt,t)dBt,{\displaystyle \mathrm {d} X_{t}=\mu (X_{t},t)\,\mathrm {d} t+\sigma (X_{t},t)\,\mathrm {d} B_{t},}

whereB{\displaystyle B} denotes aWiener process (standard Brownian motion).This equation should be interpreted as an informal way of expressing the correspondingintegral equation

Xt+sXt=tt+sμ(Xu,u)du+tt+sσ(Xu,u)dBu.{\displaystyle X_{t+s}-X_{t}=\int _{t}^{t+s}\mu (X_{u},u)\mathrm {d} u+\int _{t}^{t+s}\sigma (X_{u},u)\,\mathrm {d} B_{u}.}

The equation above characterizes the behavior of thecontinuous timestochastic processXt as the sum of an ordinaryLebesgue integral and anItô integral. Aheuristic (but very helpful) interpretation of the stochastic differential equation is that in a small time interval of lengthδ the stochastic processXt changes its value by an amount that isnormally distributed withexpectationμ(Xttδ andvarianceσ(Xtt)2 δ and is independent of the past behavior of the process. This is so because the increments of a Wiener process are independent and normally distributed. The functionμ is referred to as the drift coefficient, whileσ is called the diffusion coefficient. The stochastic processXt is called adiffusion process, and satisfies theMarkov property.[1]

The formal interpretation of an SDE is given in terms of what constitutes a solution to the SDE. There are two main definitions of a solution to an SDE, a strong solution and a weak solution[1] Both require the existence of a processXt that solves the integral equation version of the SDE. The difference between the two lies in the underlyingprobability space (Ω,F,P{\displaystyle \Omega ,\,{\mathcal {F}},\,P}). A weak solution consists of a probability space and a process that satisfies the integral equation, while a strong solution is a process that satisfies the equation and is defined on a given probability space. TheYamada–Watanabe theorem makes a connection between the two.

An important example is the equation forgeometric Brownian motion

dXt=μXtdt+σXtdBt.{\displaystyle \mathrm {d} X_{t}=\mu X_{t}\,\mathrm {d} t+\sigma X_{t}\,\mathrm {d} B_{t}.}

which is the equation for the dynamics of the price of astock in theBlack–Scholes options pricing model[2] of financial mathematics.

Generalizing the geometric Brownian motion, it is also possible to define SDEs admitting strong solutions and whose distribution is a convex combination of densities coming from different geometric Brownian motions or Black Scholes models, obtaining a single SDE whose solutions is distributed as a mixture dynamics of lognormal distributions of different Black Scholes models.[2][17][18][19] This leads to models that can deal with thevolatility smile in financial mathematics.

The simpler SDE calledarithmetic Brownian motion[3]

dXt=μdt+σdBt{\displaystyle \mathrm {d} X_{t}=\mu \,\mathrm {d} t+\sigma \,\mathrm {d} B_{t}}

was used by Louis Bachelier as the first model for stock prices in 1900, known today asBachelier model.

There are also more general stochastic differential equations where the coefficientsμ andσ depend not only on the present value of the processXt, but also on previous values of the process and possibly on present or previous values of other processes too. In that case the solution process,X, is not a Markov process, and it is called an Itô process and not a diffusion process. When the coefficients depends only on present and past values ofX, the defining equation is called a stochastic delay differential equation.

A generalization of stochastic differential equations with the Fisk-Stratonovich integral to semimartingales with jumps are the SDEs ofMarcus type. The Marcus integral is an extension of McShane's stochastic calculus.[20]

An application instochastic finance derives from the usage of the equation forOrnstein–Uhlenbeck process

dRt=μRtdt+σtdBt.{\displaystyle \mathrm {d} R_{t}=\mu R_{t}\,\mathrm {d} t+\sigma _{t}\,\mathrm {d} B_{t}.}

which is the equation for the dynamics of the return of the price of astock under the hypothesis that returns display aLog-normal distribution.Under this hypothesis, the methodologies developed by Marcello Minenna determines prediction interval able to identify abnormal return that could hidemarket abuse phenomena.[21][22]

SDEs on manifolds

[edit]

More generally one can extend the theory of stochastic calculus ontodifferential manifolds and for this purpose one uses the Fisk-Stratonovich integral. Consider a manifoldM{\displaystyle M}, some finite-dimensional vector spaceE{\displaystyle E}, a filtered probability space(Ω,F,(Ft)tR+,P){\displaystyle (\Omega ,{\mathcal {F}},({\mathcal {F}}_{t})_{t\in \mathbb {R} _{+}},P)} with(Ft)tR+{\displaystyle ({\mathcal {F}}_{t})_{t\in \mathbb {R} _{+}}} satisfying theusual conditions and letM^=M{}{\displaystyle {\widehat {M}}=M\cup \{\infty \}} be theone-point compactification andx0{\displaystyle x_{0}} beF0{\displaystyle {\mathcal {F}}_{0}}-measurable. Astochastic differential equation onM{\displaystyle M} written

dX=A(X)dZ{\displaystyle \mathrm {d} X=A(X)\circ dZ}

is a pair(A,Z){\displaystyle (A,Z)}, such that

For eachxM{\displaystyle x\in M} the mapA(x):ETxM{\displaystyle A(x):E\to T_{x}M} is linear andA()eΓ(TM){\displaystyle A(\cdot )e\in \Gamma (TM)} for eacheE{\displaystyle e\in E}.

A solution to the SDE onM{\displaystyle M} with initial conditionX0=x0{\displaystyle X_{0}=x_{0}} is a continuous{Ft}{\displaystyle \{{\mathcal {F}}_{t}\}}-adaptedM{\displaystyle M}-valued process(Xt)t<ζ{\displaystyle (X_{t})_{t<\zeta }} up to life timeζ{\displaystyle \zeta }, s.t. for each test functionfCc(M){\displaystyle f\in C_{c}^{\infty }(M)} the processf(X){\displaystyle f(X)} is a real-valued semimartingale and for each stopping timeτ{\displaystyle \tau } with0τ<ζ{\displaystyle 0\leq \tau <\zeta } the equation

f(Xτ)=f(x0)+0τ(df)XA(X)dZ{\displaystyle f(X_{\tau })=f(x_{0})+\int _{0}^{\tau }(\mathrm {d} f)_{X}A(X)\circ \mathrm {d} Z}

holdsP{\displaystyle P}-almost surely, where(df)X:TxMTf(x)M{\displaystyle (df)_{X}:T_{x}M\to T_{f(x)}M} is thedifferential atX{\displaystyle X}. It is amaximal solution if the life time is maximal, i.e.,

{ζ<}{limtζXt= in M^}{\displaystyle \{\zeta <\infty \}\subset \left\{\lim \limits _{t\nearrow \zeta }X_{t}=\infty {\text{ in }}{\widehat {M}}\right\}}

P{\displaystyle P}-almost surely. It follows from the fact thatf(X){\displaystyle f(X)} for each test functionfCc(M){\displaystyle f\in C_{c}^{\infty }(M)} is a semimartingale, thatX{\displaystyle X} is asemimartingale onM{\displaystyle M}. Given a maximal solution we can extend the time ofX{\displaystyle X} onto fullR+{\displaystyle \mathbb {R} _{+}} and after a continuation off{\displaystyle f} onM^{\displaystyle {\widehat {M}}} we get

f(Xt)=f(X0)+0t(df)XA(X)dZ,t0{\displaystyle f(X_{t})=f(X_{0})+\int _{0}^{t}(\mathrm {d} f)_{X}A(X)\circ \mathrm {d} Z,\quad t\geq 0}

up to indistinguishable processes.[23]Although Stratonovich SDEs are the natural choice for SDEs on manifolds, given that they satisfy the chain rule and that their drift and diffusion coefficients behave as vector fields under changes of coordinates, there are cases where Ito calculus on manifolds is preferable. A theory of Ito calculus on manifolds was first developed byLaurent Schwartz through the concept of Schwartz morphism,[6] see also the related 2-jet interpretation of Ito SDEs on manifolds based on the jet-bundle.[8] This interpretation is helpful when trying to optimally approximate the solution of an SDE given on a large space with the solutions of an SDE given on a submanifold of that space,[9] in that a Stratonovich based projection does not result to be optimal. This has been applied to thefiltering problem, leading to optimal projection filters.[9]

As rough paths

[edit]

Usually the solution of an SDE requires a probabilistic setting, as the integral implicit in the solution is a stochastic integral. If it were possible to deal with the differential equation path by path, one would not need to define a stochastic integral and one could develop a theory independently of probability theory. This points to considering the SDE

dXt(ω)=μ(Xt(ω),t)dt+σ(Xt(ω),t)dBt(ω){\displaystyle \mathrm {d} X_{t}(\omega )=\mu (X_{t}(\omega ),t)\,\mathrm {d} t+\sigma (X_{t}(\omega ),t)\,\mathrm {d} B_{t}(\omega )}

as a single deterministic differential equation for everyωΩ{\displaystyle \omega \in \Omega }, whereΩ{\displaystyle \Omega } is the sample space in the given probability space (Ω,F,P{\displaystyle \Omega ,\,{\mathcal {F}},\,P}). However, a direct path-wise interpretation of the SDE is not possible, as the Brownian motion paths have unbounded variation and are nowhere differentiable with probability one, so that there is no naive way to give meaning to terms likedBt(ω){\displaystyle \mathrm {d} B_{t}(\omega )}, precluding also a naive path-wise definition of the stochastic integral as an integral against every singledBt(ω){\displaystyle \mathrm {d} B_{t}(\omega )}. However, motivated by the Wong-Zakai result[24] for limits of solutions of SDEs with regular noise and usingrough paths theory, while adding a chosen definition of iterated integrals of Brownian motion, it is possible to define a deterministic rough integral for every singleωΩ{\displaystyle \omega \in \Omega } that coincides for example with the Ito integral with probability one for a particular choice of the iterated Brownian integral.[24] Other definitions of the iterated integral lead to deterministic pathwise equivalents of different stochastic integrals, like the Stratonovich integral. This has been used for example in financial mathematics to price options without probability.[25]

Existence and uniqueness of solutions

[edit]

As with deterministic ordinary and partial differential equations, it is important to know whether a given SDE has a solution, and whether or not it is unique. The following is a typical existence and uniqueness theorem for Itô SDEs taking values inn-dimensionalEuclidean spaceRn and driven by anm-dimensional Brownian motionB; the proof may be found in Øksendal (2003, §5.2).[3]

LetT > 0, and let

μ:Rn×[0,T]Rn;{\displaystyle \mu :\mathbb {R} ^{n}\times [0,T]\to \mathbb {R} ^{n};}
σ:Rn×[0,T]Rn×m;{\displaystyle \sigma :\mathbb {R} ^{n}\times [0,T]\to \mathbb {R} ^{n\times m};}

bemeasurable functions for which there exist constantsC andD such that

|μ(x,t)|+|σ(x,t)|C(1+|x|);{\displaystyle {\big |}\mu (x,t){\big |}+{\big |}\sigma (x,t){\big |}\leq C{\big (}1+|x|{\big )};}
|μ(x,t)μ(y,t)|+|σ(x,t)σ(y,t)|D|xy|;{\displaystyle {\big |}\mu (x,t)-\mu (y,t){\big |}+{\big |}\sigma (x,t)-\sigma (y,t){\big |}\leq D|x-y|;}

for allt ∈ [0, T] and allx andy ∈ Rn, where

|σ|2=i,j=1n|σij|2.{\displaystyle |\sigma |^{2}=\sum _{i,j=1}^{n}|\sigma _{ij}|^{2}.}

LetZ be a random variable that is independent of theσ-algebra generated byBs,s ≥ 0, and with finitesecond moment:

E[|Z|2]<+.{\displaystyle \mathbb {E} {\big [}|Z|^{2}{\big ]}<+\infty .}

Then the stochastic differential equation/initial value problem

dXt=μ(Xt,t)dt+σ(Xt,t)dBt for t[0,T];{\displaystyle \mathrm {d} X_{t}=\mu (X_{t},t)\,\mathrm {d} t+\sigma (X_{t},t)\,\mathrm {d} B_{t}{\mbox{ for }}t\in [0,T];}
X0=Z;{\displaystyle X_{0}=Z;}

has a P-almost surely uniquet-continuous solution (tω) ↦ Xt(ω) such thatX isadapted to thefiltrationFtZ generated byZ andBs,s ≤ t, and

E[0T|Xt|2dt]<+.{\displaystyle \mathbb {E} \left[\int _{0}^{T}|X_{t}|^{2}\,\mathrm {d} t\right]<+\infty .}

General case: local Lipschitz condition and maximal solutions

[edit]

The stochastic differential equation above is only a special case of a more general form

dYt=α(t,Yt)dXt{\displaystyle \mathrm {d} Y_{t}=\alpha (t,Y_{t})\mathrm {d} X_{t}}

where

More generally one can also look at stochastic differential equations onmanifolds.

Whether the solution of this equation explodes depends on the choice ofα{\displaystyle \alpha }. Supposeα{\displaystyle \alpha } satisfies some local Lipschitz condition, i.e., fort0{\displaystyle t\geq 0} and some compact setKU{\displaystyle K\subset U} and some constantL(t,K){\displaystyle L(t,K)} the condition

|α(s,y)α(s,x)|L(t,K)|yx|,x,yK,0st,{\displaystyle |\alpha (s,y)-\alpha (s,x)|\leq L(t,K)|y-x|,\quad x,y\in K,\;0\leq s\leq t,}

where||{\displaystyle |\cdot |} is the Euclidean norm. This condition guarantees the existence and uniqueness of a so-calledmaximal solution.

Supposeα{\displaystyle \alpha } is continuous and satisfies the above local Lipschitz condition and letF:ΩU{\displaystyle F:\Omega \to U} be some initial condition, meaning it is a measurable function with respect to the initial σ-algebra. Letζ:ΩR¯+{\displaystyle \zeta :\Omega \to {\overline {\mathbb {R} }}_{+}} be apredictable stopping time withζ>0{\displaystyle \zeta >0} almost surely. AU{\displaystyle U}-valued semimartingale(Yt)t<ζ{\displaystyle (Y_{t})_{t<\zeta }} is called amaximal solution of

dYt=α(t,Yt)dXt,Y0=F{\displaystyle dY_{t}=\alpha (t,Y_{t})dX_{t},\quad Y_{0}=F}

withlife timeζ{\displaystyle \zeta } if

dY=α(t,Y)dXζn{\displaystyle \mathrm {d} Y=\alpha (t,Y)\mathrm {d} X^{\zeta _{n}}}

ζ{\displaystyle \zeta } is also a so-calledexplosion time.

Some explicitly solvable examples

[edit]

Explicitly solvable SDEs include:[11]

Linear SDE: General case

[edit]
dXt=(a(t)Xt+c(t))dt+(b(t)Xt+d(t))dWt{\displaystyle \mathrm {d} X_{t}=(a(t)X_{t}+c(t))\mathrm {d} t+(b(t)X_{t}+d(t))\mathrm {d} W_{t}}
Xt=Φt,t0(Xt0+t0tΦs,t01(c(s)b(s)d(s))ds+t0tΦs,t01d(s)dWs){\displaystyle X_{t}=\Phi _{t,t_{0}}\left(X_{t_{0}}+\int _{t_{0}}^{t}\Phi _{s,t_{0}}^{-1}(c(s)-b(s)d(s))\mathrm {d} s+\int _{t_{0}}^{t}\Phi _{s,t_{0}}^{-1}d(s)\mathrm {d} W_{s}\right)}

where

Φt,t0=exp(t0t(a(s)b2(s)2)ds+t0tb(s)dWs){\displaystyle \Phi _{t,t_{0}}=\exp \left(\int _{t_{0}}^{t}\left(a(s)-{\frac {b^{2}(s)}{2}}\right)\mathrm {d} s+\int _{t_{0}}^{t}b(s)\mathrm {d} W_{s}\right)}

Reducible SDEs: Case 1

[edit]
dXt=12f(Xt)f(Xt)dt+f(Xt)dWt{\displaystyle \mathrm {d} X_{t}={\frac {1}{2}}f(X_{t})f'(X_{t})\mathrm {d} t+f(X_{t})\mathrm {d} W_{t}}

for a given differentiable functionf{\displaystyle f} is equivalent to the Stratonovich SDE

dXt=f(Xt)Wt{\displaystyle \mathrm {d} X_{t}=f(X_{t})\circ W_{t}}

which has a general solution

Xt=h1(Wt+h(X0)){\displaystyle X_{t}=h^{-1}(W_{t}+h(X_{0}))}

where

h(x)=xdsf(s){\displaystyle h(x)=\int ^{x}{\frac {\mathrm {d} s}{f(s)}}}

Reducible SDEs: Case 2

[edit]
dXt=(αf(Xt)+12f(Xt)f(Xt))dt+f(Xt)dWt{\displaystyle \mathrm {d} X_{t}=\left(\alpha f(X_{t})+{\frac {1}{2}}f(X_{t})f'(X_{t})\right)\mathrm {d} t+f(X_{t})\mathrm {d} W_{t}}

for a given differentiable functionf{\displaystyle f} is equivalent to the Stratonovich SDE

dXt=αf(Xt)dt+f(Xt)Wt{\displaystyle \mathrm {d} X_{t}=\alpha f(X_{t})\mathrm {d} t+f(X_{t})\circ W_{t}}

which is reducible to

dYt=αdt+dWt{\displaystyle \mathrm {d} Y_{t}=\alpha \mathrm {d} t+\mathrm {d} W_{t}}

whereYt=h(Xt){\displaystyle Y_{t}=h(X_{t})} whereh{\displaystyle h} is defined as before.Its general solution is

Xt=h1(αt+Wt+h(X0)){\displaystyle X_{t}=h^{-1}(\alpha t+W_{t}+h(X_{0}))}

SDEs and supersymmetry

[edit]
Main article:Supersymmetric theory of stochastic dynamics

In supersymmetric theory of SDEs, stochastic dynamics is defined via stochastic evolution operator acting on thedifferential forms on thephase/state space of the model. In this formulation of stochastic dynamics, all SDEs possess topologicalsupersymmetry which represents the preservation of the continuity of the phase space by continuous time flow. The spontaneous breakdown of this supersymmetry is the mathematical essence of the ubiquitous dynamical phenomenon known across disciplines aschaos.

See also

[edit]

References

[edit]
  1. ^abcdefRogers, L.C.G.;Williams, David (2000).Diffusions, Markov Processes and Martingales, Vol 2: Ito Calculus (2nd ed., Cambridge Mathematical Library ed.).Cambridge University Press.doi:10.1017/CBO9780511805141.ISBN 0-521-77594-9.OCLC 42874839.
  2. ^abcMusiela, M., and Rutkowski, M. (2004), Martingale Methods in Financial Modelling, 2nd Edition, Springer Verlag, Berlin.
  3. ^abcdefgØksendal, Bernt K. (2003).Stochastic Differential Equations: An Introduction with Applications. Berlin: Springer.ISBN 3-540-04758-1.
  4. ^Kunita, H. (2004). Stochastic Differential Equations Based on Lévy Processes and Stochastic Flows of Diffeomorphisms. In: Rao, M.M. (eds) Real and Stochastic Analysis. Trends in Mathematics. Birkhäuser Boston.https://doi.org/10.1007/978-1-4612-2054-1_6
  5. ^Imkeller, Peter; Schmalfuss, Björn (2001)."The Conjugacy of Stochastic and Random Differential Equations and the Existence of Global Attractors".Journal of Dynamics and Differential Equations.13 (2):215–249.doi:10.1023/a:1016673307045.ISSN 1040-7294.S2CID 3120200.
  6. ^abcMichel Emery (1989). Stochastic calculus in manifolds. Springer Berlin, Heidelberg. Doihttps://doi.org/10.1007/978-3-642-75051-9
  7. ^Zdzisław Brzeźniak andK. D. Elworthy, Stochastic differential equations on Banach manifolds, Methods Funct. Anal. Topology 6 (2000), no. 1, 43-84.
  8. ^abArmstrong J. andBrigo D. (2018). Intrinsic stochastic differential equations as jets. Proc. R. Soc. A., 474: 20170559,http://doi.org/10.1098/rspa.2017.0559
  9. ^abcArmstrong, J., Brigo, D. and Rossi Ferrucci, E. (2019), Optimal approximation of SDEs on submanifolds: the Itô-vector and Itô-jet projections. Proc. London Math. Soc., 119: 176-213.https://doi.org/10.1112/plms.12226.
  10. ^Parisi, G.; Sourlas, N. (1979). "Random Magnetic Fields, Supersymmetry, and Negative Dimensions".Physical Review Letters.43 (11):744–745.Bibcode:1979PhRvL..43..744P.doi:10.1103/PhysRevLett.43.744.
  11. ^abKloeden, P.E., Platen E. (1992). Numerical Solution of Stochastic Differential Equations. Springer, Berlin, Heidelberg. DOI:https://doi.org/10.1007/978-3-662-12616-5
  12. ^Artemiev, S.S., Averina, T.A. (1997). Numerical Analysis of Systems of Ordinary and Stochastic Differential Equations. VSP, Utrecht, The Netherlands. DOI:https://doi.org/10.1515/9783110944662
  13. ^Kuznetsov, D.F. (2023). Strong approximation of iterated Itô and Stratonovich stochastic integrals: Method of generalized multiple Fourier series. Application to numerical integration of Itô SDEs and semilinear SPDEs. Differ. Uravn. Protsesy Upr., no. 1. DOI:https://doi.org/10.21638/11701/spbu35.2023.110
  14. ^Rybakov, K.A. (2023). Spectral representations of iterated stochastic integrals and their application for modeling nonlinear stochastic dynamics. Mathematics, vol. 11, 4047. DOI:https://doi.org/10.3390/math11194047
  15. ^Gardiner, C W (2009).Handbook of Stochastic Methods (4th ed.). Berlin: Springer-Verlag.ISBN 978-3-540-70712-7.
  16. ^Slavík, A. (2013)."Generalized differential equations: Differentiability of solutions with respect to initial conditions and parameters".Journal of Mathematical Analysis and Applications.402 (1):261–274.doi:10.1016/j.jmaa.2013.01.027.
  17. ^Fengler, M. R. (2005), Semiparametric modeling of implied volatility, Springer Verlag, Berlin. DOIhttps://doi.org/10.1007/3-540-30591-2
  18. ^Brigo, Damiano;Mercurio, Fabio (2002). "Lognormal-mixture dynamics and calibration to market volatility smiles".International Journal of Theoretical and Applied Finance.5 (4):427–446.doi:10.1142/S0219024902001511.
  19. ^Brigo, D, Mercurio, F, Sartorelli, G. (2003). Alternative asset-price dynamics and volatility smile, QUANT FINANC, 2003, Vol: 3, Pages: 173 - 183,ISSN 1469-7688
  20. ^Steven Marcus (1981), "Modeling and approximation of stochastic differential equation driven by semimartigales",Stochastics, vol. 4, pp. 223–245
  21. ^"Detecting Market Abuse". Risk Magazine. 2 November 2004.
  22. ^"The detection of Market Abuse on financial markets: a quantitative approach". Consob – The Italian Securities and Exchange Commission.
  23. ^Hackenbroch, Wolfgang; Thalmaier, Anton (1994).Stochastische Analysis: Eine Einführung in die Theorie der stetigen Semimartingale (in German). Vieweg+Teubner Verlag Wiesbaden. p. 364-365.ISBN 978-3-519-02229-9.
  24. ^abFriz, P. and Hairer, M. (2020). A Course on Rough Paths with an Introduction to Regularity Structures, 2nd ed., Springer-Verlag, Heidelberg, DOIhttps://doi.org/10.1007/978-3-030-41556-3
  25. ^ Armstrong, J., Bellani, C., Brigo, D. and Cass, T. (2021). Option pricing models without probability: a rough paths approach. Mathematical Finance, vol. 31, pages 1494–1521.
  26. ^Hackenbroch, Wolfgang; Thalmaier, Anton (1994).Stochastische Analysis: Eine Einführung in die Theorie der stetigen Semimartingale (in German). Vieweg+Teubner Verlag Wiesbaden. pp. 297–299.ISBN 978-3-519-02229-9.

Further reading

[edit]
  • Evans, Lawrence C. (2013).An Introduction to Stochastic Differential Equations American Mathematical Society.
  • Adomian, George (1983).Stochastic systems. Mathematics in Science and Engineering (169). Orlando, FL: Academic Press Inc.
  • Adomian, George (1986).Nonlinear stochastic operator equations. Orlando, FL: Academic Press Inc.ISBN 978-0-12-044375-8.
  • Adomian, George (1989).Nonlinear stochastic systems theory and applications to physics. Mathematics and its Applications (46). Dordrecht: Kluwer Academic Publishers Group.
  • Calin, Ovidiu (2015).An Informal Introduction to Stochastic Calculus with Applications. Singapore: World Scientific Publishing. p. 315.ISBN 978-981-4678-93-3.
  • Teugels, J.; Sund, B., eds. (2004).Encyclopedia of Actuarial Science. Chichester: Wiley. pp. 523–527.
  • Gardiner, C. W. (2004).Handbook of Stochastic Methods: for Physics, Chemistry and the Natural Sciences. Springer. p. 415.
  • Mikosch, Thomas (1998).Elementary Stochastic Calculus: with Finance in View. Singapore: World Scientific Publishing. p. 212.ISBN 981-02-3543-7.
  • Seifedine Kadry (2007). "A Solution of Linear Stochastic Differential Equation".Wseas Transactions on Mathematics. USA: WSEAS TRANSACTIONS on MATHEMATICS, April 2007.: 618.ISSN 1109-2769.
  • Higham, Desmond J. (January 2001). "An Algorithmic Introduction to Numerical Simulation of Stochastic Differential Equations".SIAM Review.43 (3):525–546.Bibcode:2001SIAMR..43..525H.CiteSeerX 10.1.1.137.6375.doi:10.1137/S0036144500378302.
  • Desmond Higham and Peter Kloeden: "An Introduction to the Numerical Simulation of Stochastic Differential Equations", SIAM,ISBN 978-1-611976-42-7 (2021).
Discrete time
Continuous time
Both
Fields and other
Time series models
Financial models
Actuarial models
Queueing models
Properties
Limit theorems
Inequalities
Tools
Disciplines
International
National
Other
Retrieved from "https://en.wikipedia.org/w/index.php?title=Stochastic_differential_equation&oldid=1317324255"
Categories:
Hidden categories:

[8]ページ先頭

©2009-2025 Movatter.jp