Movatterモバイル変換


[0]ホーム

URL:


Jump to content
WikipediaThe Free Encyclopedia
Search

Random walk

From Wikipedia, the free encyclopedia
Process forming a path from many random steps
For the novel, seeRandom Walk.

Five eight-step random walks from a central point. Some paths appear shorter than eight steps where the route has doubled back on itself. (animated version)
Part of a series onstatistics
Probability theory

Inmathematics, arandom walk, sometimes known as adrunkard's walk, is astochastic process that describes a path that consists of a succession ofrandom steps on somemathematical space.

An elementary example of a random walk is the random walk on the integer number lineZ{\displaystyle \mathbb {Z} } which starts at 0, and at each step moves +1 or −1 with equalprobability. Other examples include the path traced by amolecule as it travels in a liquid or a gas (seeBrownian motion), the search path of aforaging animal, or the price of a fluctuatingstock and the financial status of agambler. Random walks have applications toengineering and many scientific fields includingecology,psychology,computer science,physics,chemistry,biology,economics, andsociology. The termrandom walk was first introduced byKarl Pearson in 1905.[1]

Realizations of random walks can be obtained byMonte Carlo simulation.[2]

Lattice random walk

[edit]

A popular random walk model is that of a random walk on a regular lattice, where at each step the location jumps to another site according to some probability distribution. In asimple random walk, the location can only jump to neighboring sites of the lattice, forming alattice path. In asimple symmetric random walk on a locally finite lattice, the probabilities of the location jumping to each one of its immediate neighbors are the same. The best-studied example is the random walk on thed-dimensional integer lattice (sometimes called the hypercubic lattice)Zd{\displaystyle \mathbb {Z} ^{d}}.[3]

If the state space is limited to finite dimensions, the random walk model is called asimple bordered symmetric random walk, and the transition probabilities depend on the location of the state because on margin and corner states the movement is limited.[4]

One-dimensional random walk

[edit]

An elementary example of a random walk is the random walk on theinteger number line,Z{\displaystyle \mathbb {Z} }, which starts at 0 and at each step moves +1 or −1 with equal probability.

This walk can be illustrated as follows. A marker is placed at zero on the number line, and a fair coin is flipped. If it lands on heads, the marker is moved one unit to the right. If it lands on tails, the marker is moved one unit to the left. After five flips, the marker could now be on -5, -3, -1, 1, 3, 5. With five flips, three heads and two tails, in any order, it will land on 1. There are 10 ways of landing on 1 (by flipping three heads and two tails), 10 ways of landing on −1 (by flipping three tails and two heads), 5 ways of landing on 3 (by flipping four heads and one tail), 5 ways of landing on −3 (by flipping four tails and one head), 1 way of landing on 5 (by flipping five heads), and 1 way of landing on −5 (by flipping five tails). See the figure below for an illustration of the possible outcomes of 5 flips.

All possible random walk outcomes after 5 flips of a fair coin
Random walk in two dimensions (animated version)
Random walk in two dimensions with 25 thousand steps (animated version)
Random walk in two dimensions with two million even smaller steps. This image was generated in such a way that points that are more frequently traversed are darker. In the limit, for very small steps, one obtainsBrownian motion.

To define this walk formally, take independent random variablesZ1,Z2,{\displaystyle Z_{1},Z_{2},\dots }, where each variable is either 1 or −1, with a 50% probability for either value, and setS0=0{\displaystyle S_{0}=0} andSn=j=1nZj.{\textstyle S_{n}=\sum _{j=1}^{n}Z_{j}.} Theseries{Sn}{\displaystyle \{S_{n}\}} is called thesimple random walk onZ{\displaystyle \mathbb {Z} }. This series (the sum of the sequence of −1s and 1s) gives the net distance walked, if each part of the walk is of length one.TheexpectationE(Sn){\displaystyle E(S_{n})} ofSn{\displaystyle S_{n}} is zero. That is, the mean of all coin flips approaches zero as the number of flips increases. This follows by the finite additivity property of expectation:E(Sn)=j=1nE(Zj)=0.{\displaystyle E(S_{n})=\sum _{j=1}^{n}E(Z_{j})=0.}

A similar calculation, using the independence of the random variables and the fact thatE(Zn2)=1{\displaystyle E(Z_{n}^{2})=1}, shows that:E(Sn2)=i=1nE(Zi2)+21i<jnE(ZiZj)=n.{\displaystyle E(S_{n}^{2})=\sum _{i=1}^{n}E(Z_{i}^{2})+2\sum _{1\leq i<j\leq n}E(Z_{i}Z_{j})=n.}

This hints thatE(|Sn|){\displaystyle E(|S_{n}|)\,\!}, theexpected translation distance aftern steps, should beof the order ofn{\displaystyle {\sqrt {n}}}. In fact,[5]limnE(|Sn|)n=2π.{\displaystyle \lim _{n\to \infty }{\frac {E(|S_{n}|)}{\sqrt {n}}}={\sqrt {\frac {2}{\pi }}}.}

To answer the question of how many times will a random walk cross a boundary line if permitted to continue walking forever, a simple random walk onZ{\displaystyle \mathbb {Z} } will cross every point an infinite number of times. This result has many names: thelevel-crossing phenomenon,recurrence or thegambler's ruin. The reason for the last name is as follows: a gambler with a finite amount of money will eventually lose when playinga fair game against a bank with an infinite amount of money. The gambler's money will perform a random walk, and it will reach zero at some point, and the game will be over.

Ifa andb are positive integers, then the expected number of steps until a one-dimensional simple random walk starting at 0 first hitsb or −a isab. The probability that this walk will hitb before −a isa/(a+b){\displaystyle a/(a+b)}, which can be derived from the fact that simple random walk is amartingale. And these expectations and hitting probabilities can be computed inO(a+b){\displaystyle O(a+b)} in the general one-dimensional random walk Markov chain.

Some of the results mentioned above can be derived from properties ofPascal's triangle. The number of different walks ofn steps where each step is +1 or −1 is 2n. For the simple random walk, each of these walks is equally likely. In order forSn to be equal to a numberk it is necessary and sufficient that the number of +1 in the walk exceeds those of −1 byk. It follows +1 must appear (n + k)/2 times amongn steps of a walk, hence the number of walks which satisfySn=k{\displaystyle S_{n}=k} equals the number of ways of choosing (n + k)/2 elements from ann element set,[6] denoted(n(n+k)/2){\textstyle n \choose (n+k)/2}. For this to have meaning, it is necessary thatn + k be an even number, which impliesn andk are either both even or both odd. Therefore, the probability thatSn=k{\displaystyle S_{n}=k} is equal to2n(n(n+k)/2){\textstyle 2^{-n}{n \choose (n+k)/2}}. By representing entries of Pascal's triangle in terms offactorials and usingStirling's formula, one can obtain good estimates for these probabilities for large values ofn{\displaystyle n}.

This relation with Pascal's triangle is demonstrated for small values ofn. At zero turns, the only possibility will be to remain at zero. However, at one turn, there is one chance of landing on −1 or one chance of landing on 1. At two turns, a marker at 1 could move to 2 or back to zero. A marker at −1, could move to −2 or back to zero. Therefore, there is one chance of landing on −2, two chances of landing on zero, and one chance of landing on 2.

k−5−4−3−2−1012345
P[S0=k]{\displaystyle P[S_{0}=k]}1
2P[S1=k]{\displaystyle 2P[S_{1}=k]}11
22P[S2=k]{\displaystyle 2^{2}P[S_{2}=k]}121
23P[S3=k]{\displaystyle 2^{3}P[S_{3}=k]}1331
24P[S4=k]{\displaystyle 2^{4}P[S_{4}=k]}14641
25P[S5=k]{\displaystyle 2^{5}P[S_{5}=k]}15101051

Thecentral limit theorem and thelaw of the iterated logarithm describe important aspects of the behavior of simple random walks onZ{\displaystyle \mathbb {Z} }. In particular, the former entails that asn increases, the probabilities (proportional to the numbers in each row) approach anormal distribution.

To be precise, knowing thatP(Xn=k)=2n(n(n+k)/2){\textstyle \mathbb {P} (X_{n}=k)=2^{-n}{\binom {n}{(n+k)/2}}},and usingStirling's formula one has

logP(Xn=k)=n[(1+kn+12n)log(1+kn)+(1kn+12n)log(1kn)]+log2π+o(1).{\displaystyle {\log \mathbb {P} (X_{n}=k)}=n\left[\left({1+{\frac {k}{n}}+{\frac {1}{2n}}}\right)\log \left(1+{\frac {k}{n}}\right)+\left({1-{\frac {k}{n}}+{\frac {1}{2n}}}\right)\log \left(1-{\frac {k}{n}}\right)\right]+\log {\frac {\sqrt {2}}{\sqrt {\pi }}}+o(1).}

Fixing the scalingk=nx{\textstyle k=\lfloor {\sqrt {n}}x\rfloor }, forx{\textstyle x} fixed, and using the expansionlog(1+k/n)=k/nk2/2n2+{\textstyle \log(1+{k}/{n})=k/n-k^{2}/2n^{2}+\dots } whenk/n{\textstyle k/n} vanishes, it follows

P(Xnn=nxn)=1n12πex2(1+o(1)).{\displaystyle {\mathbb {P} \left({\frac {X_{n}}{n}}={\frac {\lfloor {\sqrt {n}}x\rfloor }{\sqrt {n}}}\right)}={\frac {1}{\sqrt {n}}}{\frac {1}{2{\sqrt {\pi }}}}e^{-{x^{2}}}(1+o(1)).}

taking the limit (and observing that1/n{\textstyle {1}/{\sqrt {n}}} corresponds to the spacing of the scaling grid) one finds the gaussian densityf(x)=12πex2{\textstyle f(x)={\frac {1}{2{\sqrt {\pi }}}}e^{-{x^{2}}}}. Indeed, for a absolutely continuous random variableX{\textstyle X} with densityfX{\textstyle f_{X}} it holdsP(X[x,x+dx))=fX(x)dx{\textstyle \mathbb {P} \left(X\in [x,x+dx)\right)=f_{X}(x)dx}, withdx{\textstyle dx} corresponding to an infinitesimal spacing.

As a direct generalization, one can consider random walks on crystal lattices (infinite-fold abelian covering graphs over finite graphs). Actually it is possible to establish the central limit theorem and large deviation theorem in this setting.[7][8]

As a Markov chain

[edit]

A one-dimensionalrandom walk can also be looked at as aMarkov chain whose state space is given by the integersi=0,±1,±2,.{\displaystyle i=0,\pm 1,\pm 2,\dots .} For some numberp satisfying0<p<1{\displaystyle \,0<p<1}, the transition probabilities (the probabilityPi,j of moving from statei to statej) are given byPi,i+1=p=1Pi,i1.{\displaystyle \,P_{i,i+1}=p=1-P_{i,i-1}.}

Heterogeneous generalization

[edit]
Main article:Heterogeneous random walk in one dimension

The heterogeneous random walk draws in each time step a random number that determines the local jumping probabilities and then a random number that determines the actual jump direction. The main question is the probability of staying in each of the various sites aftert{\displaystyle t} jumps, and in the limit of this probability whent{\displaystyle t} is very large.

Higher dimensions

[edit]
Three random walks in three dimensions

In higher dimensions, the set of randomly walked points has interesting geometric properties. In fact, one gets a discretefractal, that is, a set which exhibits stochasticself-similarity on large scales. On small scales, one can observe "jaggedness" resulting from the grid on which the walk is performed. The trajectory of a random walk is the collection of points visited, considered as a set with disregard towhen the walk arrived at the point. In one dimension, the trajectory is simply all points between the minimum height and the maximum height the walk achieved (both are, on average, on the order ofn{\displaystyle {\sqrt {n}}}).

To visualize the two-dimensional case, one can imagine a person walking randomly around a city. The city is effectively infinite and arranged in a square grid of sidewalks. At every intersection, the person randomly chooses one of the four possible routes (including the one originally travelled from). Formally, this is a random walk on the set of all points in theplane withintegercoordinates.

To answer the question of the person ever getting back to the original starting point of the walk, this is the 2-dimensional equivalent of the level-crossing problem discussed above. In 1921George Pólya proved that the personalmost surely would in a 2-dimensional random walk, but for 3 dimensions or higher, the probability of returning to the origin decreases as the number of dimensions increases. In 3 dimensions, the probability decreases to roughly 34%.[9] The mathematicianShizuo Kakutani was known to refer to this result with the following quote: "A drunk man will find his way home, but a drunk bird may get lost forever".[10]

The probability of recurrence is in generalp=1(1πd[π,π]di=1ddθi11di=1dcosθi)1{\displaystyle p=1-\left({\frac {1}{\pi ^{d}}}\int _{[-\pi ,\pi ]^{d}}{\frac {\prod _{i=1}^{d}d\theta _{i}}{1-{\frac {1}{d}}\sum _{i=1}^{d}\cos \theta _{i}}}\right)^{-1}}, which can be derived bygenerating functions[11] or Poisson process.[12]

Another variation of this question which was also asked by Pólya is: "if two people leave the same starting point, then will they ever meet again?"[13] It can be shown that the difference between their locations (two independent random walks) is also a simple random walk, so they almost surely meet again in a 2-dimensional walk, but for 3 dimensions and higher the probability decreases with the number of the dimensions.Paul Erdős and Samuel James Taylor also showed in 1960 that for dimensions less or equal than 4, two independent random walks starting from any two given points have infinitely many intersections almost surely, but for dimensions higher than 5, they almost surely intersect only finitely often.[14]

The asymptotic function for a two-dimensional random walk as the number of steps increases is given by aRayleigh distribution. The probability distribution is a function of the radius from the origin and the step length is constant for each step. Here, the step length is assumed to be 1, N is the total number of steps and r is the radius from the origin.[15]

P(r)=2rNer2/N{\displaystyle P(r)={\frac {2r}{N}}e^{-r^{2}/N}}

Relation to Wiener process

[edit]
Simulated steps approximating a Wiener process in two dimensions

AWiener process is a stochastic process with similar behavior toBrownian motion, the physical phenomenon of a minute particle diffusing in a fluid. (Sometimes theWiener process is called "Brownian motion", although this is strictly speaking a confusion of a model with the phenomenon being modeled.)

A Wiener process is thescaling limit of random walk in dimension 1. This means that if there is a random walk with very small steps, there is an approximation to a Wiener process (and, less accurately, to Brownian motion). To be more precise, if the step size is ε, one needs to take a walk of lengthL2 to approximate a Wiener length ofL. As the step size tends to 0 (and the number of steps increases proportionally), random walk converges to a Wiener process in an appropriate sense. Formally, ifB is the space of all paths of lengthL with the maximum topology, and ifM is the space of measure overB with the norm topology, then the convergence is in the spaceM. Similarly, a Wiener process in several dimensions is the scaling limit of random walk in the same number of dimensions.

A random walk is a discrete fractal (a function with integer dimensions; 1, 2, ...), but a Wiener process trajectory is a true fractal, and there is a connection between the two. For example, take a random walk until it hits a circle of radiusr times the step length. The average number of steps it performs isr2.[citation needed] This fact is thediscrete version of the fact that a Wiener process walk is a fractal ofHausdorff dimension 2.[citation needed]

In two dimensions, the average number of points the same random walk has on theboundary of its trajectory isr4/3. This corresponds to the fact that the boundary of the trajectory of a Wiener process is a fractal of dimension 4/3, a fact predicted byMandelbrot using simulations but proved only in 2000byLawler,Schramm andWerner.[16]

A Wiener process enjoys manysymmetries a random walk does not. For example, a Wiener process walk is invariant to rotations, but the random walk is not, since the underlying grid is not (random walk is invariant to rotations by 90 degrees, but Wiener processes are invariant to rotations by, for example, 17 degrees too). This means that in many cases, problems on a random walk are easier to solve by translating them to a Wiener process, solving the problem there, and then translating back. On the other hand, some problems are easier to solve with random walks due to its discrete nature.

Random walk andWiener process can becoupled, namely manifested on the same probability space in a dependent way that forces them to be quite close. The simplest such coupling is theSkorokhod embedding, but there exist more precise couplings, such asKomlós–Major–Tusnády approximation theorem.

The convergence of a random walk toward the Wiener process is controlled by thecentral limit theorem, and byDonsker's theorem. For a particle in a known fixed position att = 0, the central limit theorem tells us that after a large number ofindependent steps in the random walk, the walker's position is distributed according to anormal distribution of totalvariance:

σ2=tδtε2,{\displaystyle \sigma ^{2}={\frac {t}{\delta t}}\,\varepsilon ^{2},}

wheret is the time elapsed since the start of the random walk,ε{\displaystyle \varepsilon } is the size of a step of the random walk, andδt{\displaystyle \delta t} is the time elapsed between two successive steps.

This corresponds to theGreen's function of thediffusion equation that controls the Wiener process, which suggests that, after a large number of steps, the random walk converges toward a Wiener process.

In 3D, the variance corresponding to theGreen's function of the diffusion equation is:σ2=6Dt.{\displaystyle \sigma ^{2}=6\,D\,t.}

By equalizing this quantity with the variance associated to the position of the random walker, one obtains the equivalent diffusion coefficient to be considered for the asymptotic Wiener process toward which the random walk converges after a large number of steps:D=ε26δt{\displaystyle D={\frac {\varepsilon ^{2}}{6\delta t}}} (valid only in 3D).

The two expressions of the variance above correspond to the distribution associated to the vectorR{\displaystyle {\vec {R}}} that links the two ends of the random walk, in 3D. The variance associated to each componentRx{\displaystyle R_{x}},Ry{\displaystyle R_{y}} orRz{\displaystyle R_{z}} is only one third of this value (still in 3D).

For 2D:[17]

D=ε24δt.{\displaystyle D={\frac {\varepsilon ^{2}}{4\delta t}}.}

For 1D:[18]

D=ε22δt.{\displaystyle D={\frac {\varepsilon ^{2}}{2\delta t}}.}

Gaussian random walk

[edit]

A random walk having a step size that varies according to anormal distribution is used as a model for real-world time series data such as financial markets.

Here, the step size is the inverse cumulative normal distributionΦ1(z,μ,σ){\displaystyle \Phi ^{-1}(z,\mu ,\sigma )} where 0 ≤ z ≤ 1 is a uniformly distributed random number, and μ and σ are the mean and standard deviations of the normal distribution, respectively.

If μ is nonzero, the random walk will vary about a linear trend. If vs is the starting value of the random walk, the expected value aftern steps will be vs +nμ.

For the special case where μ is equal to zero, aftern steps, the translation distance's probability distribution is given byN(0,nσ2), whereN() is the notation for the normal distribution,n is the number of steps, and σ is from the inverse cumulative normal distribution as given above.

Proof: The Gaussian random walk can be thought of as the sum of a sequence of independent and identically distributed random variables, Xi from the inverse cumulative normal distribution with mean equal zero and σ of the original inverse cumulative normal distribution:

Z=i=0nXi,{\displaystyle Z=\sum _{i=0}^{n}{X_{i}},}

but we have the distribution for the sum of two independent normally distributed random variables,Z =X +Y, is given byN(μX+μY,σX2+σY2){\displaystyle {\mathcal {N}}(\mu _{X}+\mu _{Y},\sigma _{X}^{2}+\sigma _{Y}^{2})}(see here).

In our case,μX = μY = 0 andσ2X = σ2Y = σ2 yieldN(0,2σ2){\displaystyle {\mathcal {N}}(0,2\sigma ^{2})}By induction, forn steps we haveZN(0,nσ2).{\displaystyle Z\sim {\mathcal {N}}(0,n\sigma ^{2}).}For steps distributed according to any distribution with zero mean and a finite variance (not necessarily just a normal distribution), theroot mean square translation distance aftern steps is (seeBienaymé's identity)

Var(Sn)=E[Sn2]=σn.{\displaystyle {\sqrt {Var(S_{n})}}={\sqrt {E[S_{n}^{2}]}}=\sigma {\sqrt {n}}.}

But for the Gaussian random walk, this is just the standard deviation of the translation distance's distribution aftern steps. Hence, if μ is equal to zero, and since the root mean square(RMS) translation distance is one standard deviation, there is 68.27% probability that the RMS translation distance aftern steps will fall between±σn{\displaystyle \pm \sigma {\sqrt {n}}}. Likewise, there is 50% probability that the translation distance aftern steps will fall between±0.6745σn{\displaystyle \pm 0.6745\sigma {\sqrt {n}}}.

Number of distinct sites

[edit]

The number of distinct sites visited by a single random walkerS(t){\displaystyle S(t)} has been studied extensively for square and cubic lattices and for fractals.[19][20] This quantity is useful for the analysis of problems of trapping and kinetic reactions. It is also related to the vibrational density of states,[21][22] diffusion reactions processes[23]and spread of populations in ecology.[24][25]

Information rate

[edit]

Theinformation rate of a Gaussian random walk with respect to the squared error distance, i.e. its quadraticrate distortion function, is given parametrically by[26]R(Dθ)=1201max{0,log2(S(φ)/θ)}dφ,{\displaystyle R(D_{\theta })={\frac {1}{2}}\int _{0}^{1}\max\{0,\log _{2}\left(S(\varphi )/\theta \right)\}\,d\varphi ,}Dθ=01min{S(φ),θ}dφ,{\displaystyle D_{\theta }=\int _{0}^{1}\min\{S(\varphi ),\theta \}\,d\varphi ,}whereS(φ)=(2sin(πφ/2))2{\displaystyle S(\varphi )=\left(2\sin(\pi \varphi /2)\right)^{-2}}. Therefore, it is impossible to encode{Zn}n=1N{\displaystyle {\{Z_{n}\}_{n=1}^{N}}} using abinary code of less thanNR(Dθ){\displaystyle NR(D_{\theta })}bits and recover it with expected mean squared error less thanDθ{\displaystyle D_{\theta }}. On the other hand, for anyε>0{\displaystyle \varepsilon >0}, there exists anNN{\displaystyle N\in \mathbb {N} } large enough and abinary code of no more than2NR(Dθ){\displaystyle 2^{NR(D_{\theta })}} distinct elements such that the expected mean squared error in recovering{Zn}n=1N{\displaystyle {\{Z_{n}\}_{n=1}^{N}}} from this code is at mostDθε{\displaystyle D_{\theta }-\varepsilon }.

Applications

[edit]
Antony Gormley'sQuantum Cloud sculpture in London was designed by a computer using a random walk algorithm
This sectionneeds additional citations forverification. Please helpimprove this article byadding citations to reliable sources in this section. Unsourced material may be challenged and removed.(February 2013) (Learn how and when to remove this message)

Applications in financial economics

[edit]

Infinancial economics, therandom walk hypothesis is used to modelshare prices and other factors.[27] Empirical studies found some deviations from this theoretical model, especially in short term and long termcorrelations.

Applications in semiconductor manufacturing

[edit]

Insemiconductor manufacturing, random walks are used to analyze the effects of thermal treatment at smaller nodes. It is applied to understand the diffusion ofdopants,defects and otherimpurities during the critical fabrication steps. Random walk treatments are also used to study the diffusion of reactants, products and plasma duringchemical vapor deposition processes. Continuum diffusion has been used to study the flow of gases, at macroscopic scales, in CVD reactors. However, smaller dimensions and increased complexity has forced us to treat them with random walk. This allows for accurate analysis ofstochastic processes, at molecular level and smaller, in semiconductor manufacturing.

Applications in computer science

[edit]

Incomputer science, random walks are used to estimate the size of theWeb.[28] Random walks can be used to sample from a state space which is unknown or very large, for example to pick a random page off the internet. In computer science, this method is known asMarkov Chain Monte Carlo (MCMC).[citation needed] Incomputer programming it is possible to calculatepi with a random walk.[29]

Inimage segmentation, random walks are used to determine the labels (i.e., "object" or "background") to associate with each pixel.[30] This algorithm is typically referred to as therandom walker segmentation algorithm.

The Twitter website used random walks to make suggestions of whom to follow.[31]

Applications to natural phenomena

[edit]

As mentioned, the range of natural phenomena which have been subject to attempts at description by some flavour of random walks is considerable. This is particularly the case in the fields of physics,[32][33]chemistry,[34]materials science,[35][36] and biology.[37][38][39]

Variants

[edit]

A number of types ofstochastic processes have been considered that are similar to the pure random walks but where the simple structure is allowed to be more generalized. Thepure structure can be characterized by the steps being defined byindependent and identically distributed random variables. Random walks can take place on a variety of spaces, such asgraphs, the integers, the real line, the plane or higher-dimensional vector spaces, oncurved surfaces or higher-dimensionalRiemannian manifolds, and ongroups. It is also possible to define random walks which take their steps at random times, and in that case, the positionX
t
has to be defined for all timest ∈ [0, +∞). Specific cases or limits of random walks include theLévy flight anddiffusion models such asBrownian motion.

On graphs

[edit]

A random walk of lengthk on a possibly infinitegraphG with a root0 is a stochastic process with random variablesX1,X2,,Xk{\displaystyle X_{1},X_{2},\dots ,X_{k}} such thatX1=0{\displaystyle X_{1}=0} andXi+1{\displaystyle {X_{i+1}}} is a vertex chosen uniformly at random from the neighbors ofXi{\displaystyle X_{i}}.Then the numberpv,w,k(G){\displaystyle p_{v,w,k}(G)} is the probability that a random walk of lengthk starting atv ends atw.In particular, ifG is a graph with root0,p0,0,2k{\displaystyle p_{0,0,2k}} is the probability that a2k{\displaystyle 2k}-step random walk returns to0.

Building on the analogy from the earlier section on higher dimensions, assume now that our city is no longer a perfect square grid. When our person reaches a certain junction, he picks between the variously available roads with equal probability. Thus, if the junction has seven exits the person will go to each one with probability one-seventh. This is a random walk on a graph. Will our person reach his home? It turns out that under rather mild conditions, the answer is still yes,[46] but depending on the graph, the answer to the variant question 'Will two persons meet again?' may not be that they meet infinitely often almost surely.[47]

An example of a case where the person will reach his home almost surely is when the lengths of all the blocks are betweena andb (wherea andb are any two finite positive numbers). Notice that we do not assume that the graph isplanar, i.e. the city may contain tunnels and bridges. One way to prove this result is using the connection toelectrical networks. Take a map of the city and place a oneohmresistor on every block. Now measure the "resistance between a point and infinity". In other words, choose some numberR and take all the points in the electrical network with distance bigger thanR from our point and wire them together. This is now a finite electrical network, and we may measure the resistance from our point to the wired points. TakeR to infinity. The limit is called theresistance between a point and infinity. It turns out that the following is true (an elementary proof can be found in the book by Doyle and Snell):

Theorem:a graph is transient if and only if the resistance between a point and infinity is finite. It is not important which point is chosen if the graph is connected.

In other words, in a transient system, one only needs to overcome a finite resistance to get to infinity from any point. In a recurrent system, the resistance from any point to infinity is infinite.

This characterization oftransience and recurrence is very useful, and specifically it allows us to analyze the case of a city drawn in the plane with the distances bounded.

A random walk on a graph is a very special case of aMarkov chain. Unlike a general Markov chain, random walk on a graph enjoys a property calledtime symmetry orreversibility. Roughly speaking, this property, also called the principle ofdetailed balance, means that the probabilities to traverse a given path in one direction or the other have a very simple connection between them (if the graph isregular, they are just equal). This property has important consequences.

Starting in the 1980s, much research has gone into connecting properties of the graph to random walks. In addition to the electrical network connection described above, there are important connections toisoperimetric inequalities, see morehere, functional inequalities such asSobolev andPoincaré inequalities and properties of solutions ofLaplace's equation. A significant portion of this research was focused onCayley graphs offinitely generated groups. In many cases these discrete results carry over to, or are derived frommanifolds andLie groups.

In the context ofrandom graphs, particularly that of theErdős–Rényi model, analytical results to some properties of random walkers have been obtained. These include the distribution of first[48] and last hitting times[49] of the walker, where the first hitting time is given by the first time the walker steps into a previously visited site of the graph, and the last hitting time corresponds the first time the walker cannot perform an additional move without revisiting a previously visited site.

A good reference for random walk on graphs is the online book byAldous and Fill. For groups see the book of Woess.If the transition kernelp(x,y){\displaystyle p(x,y)} is itself random (based on an environmentω{\displaystyle \omega }) then the random walk is called a "random walk in random environment". When the law of the random walk includes the randomness ofω{\displaystyle \omega }, the law is called the annealed law; on the other hand, ifω{\displaystyle \omega } is seen as fixed, the law is called a quenched law. See the book of Hughes, the book of Revesz, or the lecture notes of Zeitouni.

We can think about choosing every possible edge with the same probability as maximizing uncertainty (entropy) locally. We could also do it globally – in maximal entropy random walk (MERW) we want all paths to be equally probable, or in other words: for every two vertexes, each path of given length is equally probable.[50] This random walk has much stronger localization properties.

Self-interacting random walks

[edit]

There are a number of interesting models of random paths in which each step depends on the past in a complicated manner. All are more complex for solving analytically than the usual random walk; still, the behavior of any model of a random walker is obtainable using computers. Examples include:

The self-avoiding walk of lengthn onZd{\displaystyle \mathbb {Z} ^{d}} is the randomn-step path which starts at the origin, makes transitions only between adjacent sites inZd{\displaystyle \mathbb {Z} ^{d}}, never revisit a site, and is chosen uniformly among all such paths. In two dimensions, due to self-trapping, a typical self-avoiding walk is very short,[52] while in higher dimension it grows beyond all bounds.This model has often been used inpolymer physics (since the 1960s).

Biased random walks on graphs

[edit]
Main article:Biased random walk on a graph

Maximal entropy random walk

[edit]
Main article:Maximal entropy random walk

Random walk chosen to maximizeentropy rate, has much stronger localization properties.

Correlated random walks

[edit]

Random walks where the direction of movement at one time iscorrelated with the direction of movement at the next time. It is used to model animal movements.[57][58]

See also

[edit]

References

[edit]
  1. ^Pearson, Karl (1905). "The Problem of the Random Walk".Nature.72 (1865): 294.Bibcode:1905Natur..72..294P.doi:10.1038/072294b0.S2CID 4010776.
  2. ^Theory and Applications of Monte Carlo Simulations. (2013). Kroatien: IntechOpen. Page 229,https://books.google.com/books?id=3HWfDwAAQBAJ&pg=PA229
  3. ^Pal, Révész (1990)Random walk in random and nonrandom environments, World Scientific
  4. ^Kohls, Moritz; Hernandez, Tanja (2016). "Expected Coverage of Random Walk Mobility Algorithm".arXiv:1611.02861 [stat.AP].
  5. ^"Random Walk-1-Dimensional – from Wolfram MathWorld". Mathworld.wolfram.com. 26 April 2000. Retrieved2 November 2016.
  6. ^Edward A. Codling et al., Random walk models in biology, Journal of the Royal Society Interface, 2008
  7. ^Kotani, M.;Sunada, T. (2003).Spectral geometry of crystal lattices. Contemporary Mathematics. Vol. 338. pp. 271–305.doi:10.1090/conm/338/06077.ISBN 978-0-8218-3383-4.
  8. ^Kotani, M.;Sunada, T. (2006). "Large deviation and the tangent cone at infinity of a crystal lattice".Math. Z.254 (4):837–870.doi:10.1007/s00209-006-0951-9.S2CID 122531716.
  9. ^"Pólya's Random Walk Constants". Mathworld.wolfram.com. Retrieved2 November 2016.
  10. ^Durrett, Rick (2010).Probability: Theory and Examples. Cambridge University Press. pp. 191.ISBN 978-1-139-49113-6.
  11. ^Novak, Jonathan (2014). "Pólya's Random Walk Theorem".The American Mathematical Monthly.121 (8):711–716.arXiv:1301.3916.doi:10.4169/amer.math.monthly.121.08.711.ISSN 0002-9890.JSTOR 10.4169/amer.math.monthly.121.08.711.
  12. ^Lange, Kenneth (2015). "Polya′s Random Walk Theorem Revisited".The American Mathematical Monthly.122 (10):1005–1007.doi:10.4169/amer.math.monthly.122.10.1005.ISSN 0002-9890.JSTOR 10.4169/amer.math.monthly.122.10.1005.
  13. ^Pólya, George (1984).Probability; Combinatorics; Teaching and learning in mathematics. Rota, Gian-Carlo, 1932-1999., Reynolds, M. C., Shortt, Rae Michael. Cambridge, Mass.: MIT Press. pp. 582–585.ISBN 0-262-16097-8.OCLC 10208449.
  14. ^Erdős, P.; Taylor, S. J. (1960). "Some intersection properties of random walk paths".Acta Mathematica Academiae Scientiarum Hungaricae.11 (3–4):231–248.CiteSeerX 10.1.1.210.6357.doi:10.1007/BF02020942.ISSN 0001-5954.S2CID 14143214.
  15. ^H. Rycroft, Chris; Z. Bazant, Martin."Lecture 1: Introduction to Random Walks and Diffusion"(PDF).MIT OpenCourseWare. Department of Mathematics, MIT.
  16. ^MacKenzie, D. (2000). "MATHEMATICS: Taking the Measure of the Wildest Dance on Earth".Science.290 (5498):1883–4.doi:10.1126/science.290.5498.1883.PMID 17742050.S2CID 12829171. (Erratum: doi:10.1126/science.291.5504.597)
  17. ^Chapter 2 DIFFUSION. dartmouth.edu.
  18. ^Diffusion equation for the random walkArchived 21 April 2015 at theWayback Machine. physics.uakron.edu.
  19. ^Weiss, George H.; Rubin, Robert J. (1982). "Random Walks: Theory and Selected Applications".Advances in Chemical Physics. Vol. 52. pp. 363–505.doi:10.1002/9780470142769.ch5.ISBN 978-0-470-14276-9.
  20. ^Blumen, A.; Klafter, J.; Zumofen, G. (1986). "Models for Reaction Dynamics in Glasses".Optical Spectroscopy of Glasses. Physic and Chemistry of Materials with Low-Dimensional Structures. Vol. 1. pp. 199–265.Bibcode:1986PCMLD...1..199B.doi:10.1007/978-94-009-4650-7_5.ISBN 978-94-010-8566-3.
  21. ^Alexander, S.; Orbach, R. (1982)."Density of states on fractals: " fractons ""(PDF).Journal de Physique Lettres.43 (17):625–631.doi:10.1051/jphyslet:019820043017062500.S2CID 67757791.
  22. ^Rammal, R.; Toulouse, G. (1983)."Random walks on fractal structures and percolation clusters".Journal de Physique Lettres.44 (1):13–22.doi:10.1051/jphyslet:0198300440101300.
  23. ^Smoluchowski, M.V. (1917). "Versuch einer mathematischen Theorie der Koagulationskinetik kolloider Lösungen".Z. Phys. Chem. (29):129–168.,Rice, S.A. (1 March 1985).Diffusion-Limited Reactions. Comprehensive Chemical Kinetics. Vol. 25. Elsevier.ISBN 978-0-444-42354-2. Retrieved13 August 2013.
  24. ^Skellam, J. G. (1951). "Random Dispersal in Theoretical Populations".Biometrika.38 (1/2):196–218.doi:10.2307/2332328.JSTOR 2332328.PMID 14848123.
  25. ^Skellam, J. G. (1952). "Studies in Statistical Ecology: I. Spatial Pattern".Biometrika.39 (3/4):346–362.doi:10.2307/2334030.JSTOR 2334030.
  26. ^Berger, T. (1970). "Information rates of Wiener processes".IEEE Transactions on Information Theory.16 (2):134–139.doi:10.1109/TIT.1970.1054423.
  27. ^David A. Kodde and Hein Schreuder (1984), Forecasting Corporate Revenue and Profit: Time-Series Models versus Management and Analysts, Journal of Business Finance and Accounting, vol. 11, no 3, Autumn 1984
  28. ^Bar-Yossef, Ziv; Gurevich, Maxim (2008). "Random sampling from a search engine's index".Journal of the ACM.55 (5). Association for Computing Machinery (ACM):1–74.doi:10.1145/1411509.1411514.ISSN 0004-5411.
  29. ^Evan Mills (14 March 2017)."Hey! You Can Find Pi With a Random Walk. Here's How". WIRED.
  30. ^Grady, L (2006)."Random walks for image segmentation"(PDF).IEEE Transactions on Pattern Analysis and Machine Intelligence.28 (11):1768–83.Bibcode:2006ITPAM..28.1768G.CiteSeerX 10.1.1.375.3389.doi:10.1109/TPAMI.2006.233.PMID 17063682.S2CID 489789. Archived fromthe original(PDF) on 5 July 2017. Retrieved2 November 2016.
  31. ^Gupta, Pankaj et al.WTF: The who-to-follow system at Twitter, Proceedings of the 22nd international conference on World Wide Web
  32. ^Risken H. (1984)The Fokker–Planck Equation. Springer, Berlin.
  33. ^De Gennes P. G. (1979)Scaling Concepts in Polymer Physics. Cornell University Press, Ithaca and London.
  34. ^Van Kampen N. G. (1992)Stochastic Processes in Physics and Chemistry, revised and enlarged edition. North-Holland, Amsterdam.
  35. ^Weiss, George H. (1994).Aspects and Applications of the Random Walk. Random Materials and Processes. North-Holland Publishing Co., Amsterdam.ISBN 978-0-444-81606-1.MR 1280031.
  36. ^Doi M. and Edwards S. F. (1986)The Theory of Polymer Dynamics. Clarendon Press, Oxford
  37. ^Goel N. W. andRichter-Dyn N. (1974)Stochastic Models in Biology. Academic Press, New York.
  38. ^Redner S. (2001)A Guide to First-Passage Process. Cambridge University Press
  39. ^Cox D. R. (1962)Renewal Theory. Methuen, London.
  40. ^Codling, E. A; Plank, M. J; Benhamou, S. (6 August 2008)."Random walk models in biology".Journal of the Royal Society Interface.5 (25):813–834.doi:10.1098/rsif.2008.0014.PMC 2504494.PMID 18426776.
  41. ^Hansen, Thomas F.; Martins, Emília P. (August 1996)."Translating Between Microevolutionary Process and Macroevolutionary Patterns: The Correlation Structure of Interspecific Data".Evolution.50 (4):1404–1417.Bibcode:1996Evolu..50.1404H.doi:10.1111/j.1558-5646.1996.tb03914.x.ISSN 0014-3820.PMID 28565714.
  42. ^Jones, R.A.L. (2004).Soft condensed matter. Oxford University Press. pp. 77–78.ISBN 978-0-19-850589-1.
  43. ^Rucci, M; Victor, J. D. (2015)."The unsteady eye: An information-processing stage, not a bug".Trends in Neurosciences.38 (4):195–206.doi:10.1016/j.tins.2015.01.005.PMC 4385455.PMID 25698649.
  44. ^Engbert, R.; Mergenthaler, K.; Sinn, P.; Pikovsky, A. (2011)."An integrated model of fixational eye movements and microsaccades".Proceedings of the National Academy of Sciences.108 (39): E765-70.Bibcode:2011PNAS..108E.765E.doi:10.1073/pnas.1102730108.PMC 3182695.PMID 21873243.
  45. ^Nosofsky, R. M.; Palmeri, T. J. (1997)."An exemplar-based random walk model of speeded classification"(PDF).Psychological Review.104 (2):266–300.doi:10.1037/0033-295x.104.2.266.PMID 9127583. Archived fromthe original(PDF) on 10 December 2004.
  46. ^It is interesting to remark that in a general graph the meeting of two independent random walkers does not always reduces to the problem of a single random walk returning to its starting point.
  47. ^Krishnapur, Manjunath; Peres, Yuval (2004)."Recurrent Graphs where Two Independent Random Walks Collide Finitely Often".Electronic Communications in Probability.9:72–81.arXiv:math/0406487.Bibcode:2004math......6487K.doi:10.1214/ECP.v9-1111.ISSN 1083-589X.S2CID 16584737.
  48. ^Tishby, Ido; Biham, Ofer; Katzav, Eytan (2017). "The distribution of first hitting times of randomwalks on Erdős–Rényi networks".Journal of Physics A: Mathematical and Theoretical.50 (11): 115001.arXiv:1606.01560.Bibcode:2017JPhA...50k5001T.doi:10.1088/1751-8121/aa5af3.S2CID 118850609.
  49. ^Tishby, Ido; Biham, Ofer; Katzav, Eytan (2016). "The distribution of path lengths of self avoiding walks on Erdős–Rényi networks".Journal of Physics A: Mathematical and Theoretical.49 (28) 285002.arXiv:1603.06613.Bibcode:2016JPhA...49B5002T.doi:10.1088/1751-8113/49/28/285002.S2CID 119182848.
  50. ^Burda, Z.; Duda, J.; Luck, J. M.; Waclaw, B. (2009). "Localization of the Maximal Entropy Random Walk".Physical Review Letters.102 (16) 160602.arXiv:0810.4113.Bibcode:2009PhRvL.102p0602B.doi:10.1103/PhysRevLett.102.160602.PMID 19518691.S2CID 32134048.
  51. ^Madras, Neal and Slade, Gordon (1996)The Self-Avoiding Walk, Birkhäuser Boston.ISBN 0-8176-3891-1.
  52. ^Hemmer, S.; Hemmer, P. C. (1984)."An average self-avoiding random walk on the square lattice lasts 71 steps".J. Chem. Phys.81 (1):584–585.Bibcode:1984JChPh..81..584H.doi:10.1063/1.447349.
  53. ^Lawler, Gregory (1996).Intersection of random walks, Birkhäuser Boston.ISBN 0-8176-3892-X.
  54. ^Lawler, GregoryConformally Invariant Processes in the Plane,book.ps.
  55. ^Pemantle, Robin (2007)."A survey of random processes with reinforcement"(PDF).Probability Surveys.4:1–79.arXiv:math/0610076.doi:10.1214/07-PS094.S2CID 11964062.
  56. ^Alamgir, M. andvon Luxburg, U. (2010)."Multi-agent random walks for local clustering on graphs"Archived 15 April 2012 at theWayback Machine,IEEE 10th International Conference on Data Mining (ICDM), pp. 18–27.
  57. ^Bovet, Pierre; Benhamou, Simon (1988). "Spatial analysis of animals' movements using a correlated random walk model".Journal of Theoretical Biology.131 (4):419–433.Bibcode:1988JThBi.131..419B.doi:10.1016/S0022-5193(88)80038-9.
  58. ^Kareiva, P.M.; Shigesada, N. (1983). "Analyzing insect movement as a correlated random walk".Oecologia.56 (2–3):234–238.Bibcode:1983Oecol..56..234K.doi:10.1007/BF00379695.PMID 28310199.S2CID 20329045.

Bibliography

[edit]

External links

[edit]
Discrete time
Continuous time
Both
Fields and other
Time series models
Financial models
Actuarial models
Queueing models
Properties
Limit theorems
Inequalities
Tools
Disciplines
National
Other
Retrieved from "https://en.wikipedia.org/w/index.php?title=Random_walk&oldid=1315602712"
Categories:
Hidden categories:

[8]ページ先頭

©2009-2025 Movatter.jp