Brownian Motion: Difference between revisions

From bradwiki
Jump to navigation Jump to search
 
(30 intermediate revisions by the same user not shown)
Line 1: Line 1:
{{TOC right}} Brownian motion describes the stochastic [[diffusion]] of particles as they travel through ''n''-dimensional spaces filled with other particles and physical barriers. Here the term ''particle'' is a generic term that can be generalized to describe the motion of molecule (e.g. H<sub>2</sub>O) or proteins (e.g. NMDA receptors); note however that stochastic diffusion can also apply to things like the price index of a stock (see [https://en.wikipedia.org/wiki/Random_walk random walk]) or the propagation heat energy across a surface. Brownian motion is among the simplest continuous-time stochastic processes, and a limit of various probabilistic processes (see random walk). As such, Brownian motion is highly generalizable to many applications, and is directly related to the universality of the [[normal distribution]]. In some sense, stochastic diffusion is a pure actuation of the basic statistical properties of probability distributions - it is distribution sampling translated into movement.  
[[File:Brownian-Diffusion.gif|right]]
Brownian motion describes the stochastic [[diffusion]] of particles as they travel through ''n''-dimensional spaces filled with other particles and physical barriers. Here the term ''particle'' is a generic term that can be generalized to describe the motion of molecule (e.g. H<sub>2</sub>O) or proteins (e.g. NMDA receptors); note however that stochastic diffusion can also apply to things like the price index of a stock (see [https://en.wikipedia.org/wiki/Random_walk random walk]) or the propagation heat energy across a surface. Brownian motion is among the simplest continuous-time stochastic processes, and a limit of various probabilistic processes (see random walk). As such, Brownian motion is highly generalizable to many applications, and is directly related to the universality of the [[normal distribution]]. In some sense, stochastic diffusion is a pure actuation of the basic statistical properties of probability distributions - it is distribution sampling translated into movements.  
{{TOC right}}




==Properties of Brownian Motion==


====SPECIFICATION - Physical experiments suggest that Brownian motion has====
Physical experiments characterize the following properties of Brownian motion...
* continuous increments
* continuous increments
* increments of a particle over disjoint time intervals are independent events
* increments of a particle over disjoint time intervals are independent events
* each increment is assumed to result from collisions with many molecules
* each increment is assumed to result from collisions with many molecules
* each increment is assumed to have a normal probability distribution  
* each increment is assumed to have a normal probability distribution  
** (Central Limit Theorem of probability theory: the sum of a large number of independent identically distributed random variables is approximately normal)
* the mean increment is zero as there is no preferred direction
* the mean increment is zero as there is no preferred direction
* the position of a particle spreads out with time
* the position of a particle spreads out with time
Line 17: Line 19:


::<math>
::<math>
f(x, \mu, \sigma) = \frac{1}{\sigma \sqrt{2\pi} } e^{ -\frac{(x-\mu)^2}{2\sigma^2} }
f(x, \mu, \sigma) = \frac{1}{\sigma \sqrt{2\pi} } e^{ - \frac{1}{2} (\frac{x-\mu}{\sigma})^2 }
</math>
</math>
<!--:: [[File:Dist Normal PDF.png]] -->


Mathematically, the random process called Brownian motion is denoted here as B(t) and defined for times t ≥ 0; the probability density of Brownian particles at the end of time period [0, t] is obtained by substituting μ = 0 and σ = √t, giving:
Mathematically, the random process called Brownian motion is denoted here as B(t) and defined for times t ≥ 0; the probability density of Brownian particles at the end of time period [0, t] is obtained by substituting μ = 0 and σ = √t, giving:
<!--:: [[File:Wiersema Eq 2.png|210px]] -->


::<math>
::<math>
\frac{1}{\sqrt{t2\pi} } e^{ - \frac{1}{2} (\frac{x}{\sqrt{t}})^2 }
\frac{1}{\sqrt{t2\pi} } e^{ - \frac{1}{2} (\frac{x}{\sqrt{t}})^2 }
</math>
</math>


where x denotes the value of random variable B(t). The probability distribution of the increment B(t + u) − B(t) is:
where x denotes the value of random variable B(t). The probability distribution of the increment B(t + u) − B(t) is:
<!-- : [[File:Wiersema Eq 3.png|500px]] -->


::<math>
::<math>
Line 38: Line 34:
</math>
</math>


[[File:Brownian5.gif|right]]


==Common Diffusion Terms & Parameters==
==Common Diffusion Terms & Parameters==
 
<br>
I've found it most helpful to learn about the terms and parameters used to characterize stochastic diffusion as they apply to diffusion phenomena along a flat 2D surface. These parameters include:  
I've found it most helpful to learn about the terms and parameters used to characterize stochastic diffusion as they apply to diffusion phenomena along a flat 2D surface. These parameters include:  




==== <big>D</big> &nbsp;: diffusion rate coefficient ====
=== <big>D</big> &nbsp;: diffusion rate coefficient ===
<br>


::<math>
::<math>
Line 52: Line 46:
</math>
</math>


<!--:* <big><code>D = L<sup>2</sup> / 2d⋅t</code></big>-->
:: <big><code>L</code></big> : step length
:: <big><code>L</code></big> : step length
:: <big><code>d</code></big> : dimensions
:: <big><code>d</code></big> : dimensions
Line 59: Line 51:




: <big><code>D (in units: '''µm²/s''')</code></big> is the mean diffusion rate per unit time (velocity), often in µm²/s for biological motion on a molecular level (n.b. µm²/s are the units for particle diffusion on a surface/membrane; the surface can actually be curved or ruffled such that the surface fills a 3D space, however the diffusion equations for those instances are slightly more complex. Units for 3D space are naturally: µm³/s). This refers to how fast, on average, the particle moves along its surface trajectories. This value is often of ultimate interest, that is, the goal of single-particle tracking studies is often to define the average diffusion rate of a molecule and report it as a Diffusion Coefficient; once '''D''' is known, this Diffusion Coefficient can then be easily implemented in [[computer]] simulations of Brownian motion. However under most circumstances, the diffusion rate cannot be observed directly in empirical experiments - this would require the ability to visualize all the microscopic particles and collisions that dictate the particle's movement on a nanosecond timescale. In the animation on the right, the diffusion rate can actually be quantified directly; but what is often seen when observing particle diffusion through a microscope would more closely resemble this:  
<big><code>D (in units: '''µm²/s''')</code></big> is the mean diffusion rate per unit time (velocity), often in µm²/s for biological motion on a molecular level (n.b. µm²/s are the units for particle diffusion on a surface/membrane; the surface can actually be curved or ruffled such that the surface fills a 3D space, however the diffusion equations for those instances are slightly more complex. Units for 3D space are naturally: µm³/s). This refers to how fast, on average, the particle moves along its surface trajectories. This value is often of ultimate interest, that is, the goal of single-particle tracking studies is often to define the average diffusion rate of a molecule and report it as a Diffusion Coefficient; once '''D''' is known, this Diffusion Coefficient can then be easily implemented in [[computer]] simulations of Brownian motion. However under most circumstances, the diffusion rate cannot be observed directly in empirical experiments - this would require the ability to visualize all the microscopic particles and collisions that dictate the particle's movement on a nanosecond timescale. In the animation on the right, the diffusion rate can actually be quantified directly; but what is often seen when observing particle diffusion through a microscope would more closely resemble this:  


<html>
Instead, '''D''' is often calculated from the ''mean squared diffusion'' (MSD) path of the particle, defined below.
<video width="320" height="240" controls>
  <source src="http://www.bradleymonk.com/w/images/e/e9/Stochastic_Diffusion.mp4" type="video/mp4">
</video>
</html>


Instead, '''D''' is often calculated from the ''mean squared diffusion'' (MSD) path of the particle, defined below.


==== <big>MSD</big> &nbsp;: mean squared displacement ====
=== Mean Squared Displacement (MSD)===
<br>
<br>


Line 78: Line 63:
</math>
</math>


<!--:* <big><code>MSD {{=}} 2d⋅D</code></big>-->
:: <big><code>d</code></big> : dimensions
:: <big><code>d</code></big> : dimensions
:: <big><code>D</code></big> : diffusion coefficient
:: <big><code>D</code></big> : diffusion coefficient




: <big><code>MSD (in units: '''µm²''')</code></big> is the mean square displacement of a particle over some time period. If '''D''' (the diffusion coefficient) is unknown, MSD can be computed using the following equation:
<big><code>MSD (in units: '''µm²''')</code></big> is the mean square displacement of a particle over some time period.
 
 
[[File:Mean Squared Displacement Equation.png|left|150px]]
{{Clear}}
 
 
...where the quantity '<big><code>''x''</code></big> ' refers to the displacement of a particle over '<big><code>''n''</code></big> ' total steps, with '<big><code>''k''</code></big> ' indicating the current step.


==== <big>K</big> &nbsp;: standard deviation of the normal distribution for '''D''' ====
=== Standard deviation (k) of the normal distribution of step lengths ===
<br>
<br>


Line 101: Line 76:
</math>
</math>


<!--:* <big><code>k {{=}} √(d⋅D)</code></big>-->
:: <big><code>d</code></big> : dimensions
:: <big><code>d</code></big> : dimensions
:: <big><code>D</code></big> : diffusion coefficient
:: <big><code>D</code></big> : diffusion coefficient




: <big><code>k (in units: '''µm''')</code></big> is the standard deviation (σ) of the normal distribution of step lengths that, when randomly sampled, will give rise to a diffusion rate '''D'''. This value is useful for simulating Brownian motion for a particular diffusion rate.  
<big><code>k (in units: '''µm''')</code></big> is the standard deviation (σ) of the normal distribution of step lengths that, when randomly sampled, will give rise to a diffusion rate '''D'''. This value is useful for simulating Brownian motion for a particular diffusion rate.  




==== <big>L</big> &nbsp;: mean step length ====
 
===Mean Step Length (L)===
<br>
<br>


Line 118: Line 91:
</math>
</math>


<!--:* <big><code>L {{=}} √(2d⋅D)</code></big>-->
:: <big><code>d</code></big> : dimensions
:: <big><code>d</code></big> : dimensions
:: <big><code>D</code></big> : diffusion coefficient
:: <big><code>D</code></big> : diffusion coefficient




: <big><code>L or Λ (in units: '''µm''')</code></big> is the average step length per interval of observation. In diffusion simulations, this is the step size per iteration (equivalent form: <big><code>L = (2d * D)<sup>.5</sup></code></big>).
<big><code>L or Λ (in units: '''µm''')</code></big> is the average step length per interval of observation. In diffusion simulations, this is the step size per iteration (equivalent form: <big><code>L = (2d * D)<sup>.5</sup></code></big>).






==== <big>λ</big> &nbsp;: mean 1D step length component of L ====
=== Mean 1D step length component (λ) ===
<br>
<br>


Line 137: Line 107:




: <big><code>λ (in units: '''µm''')</code></big> is the average 1-dimensional step length for each component (X,Y,Z) dimension of '''''L'''''. For example, simulating 2D particle diffusion will require the generation of individual step lengths for both the X and Y dimension. The total step distance from the origin will be the length of the hypotenuse created by the individual X and Y component step lengths. In fact, the equation: λ {{=}} L / √2 is derived from the Pythagorean theorem for right triangles, such that 2λ² = λ² where 2λ² represents a² + b² and λ² represents c².
<big><code>λ (in units: '''µm''')</code></big> is the average 1-dimensional step length for each component (X,Y,Z) dimension of '''''L'''''. For example, simulating 2D particle diffusion will require the generation of individual step lengths for both the X and Y dimension. The total step distance from the origin will be the length of the hypotenuse created by the individual X and Y component step lengths. In fact, the equation: λ {{=}} L / √2 is derived from the Pythagorean theorem for right triangles, such that 2λ² = λ² where 2λ² represents a² + b² and λ² represents c².






==== <big>ε</big> &nbsp;: step length scalar coefficient ====
=== Step length scalar coefficient (ε) ===
<br>
<br>


Line 151: Line 121:
:: <big><code>δ</code></big> : new desired diffusion rate
:: <big><code>δ</code></big> : new desired diffusion rate


: <big><code>ε (in units: au)</code></big> is a coefficient value that, when multiplied by each λ component step length, will scale those lengths to achieve a new diffusion rate '''δ'''.
<big><code>ε (in units: au)</code></big> is a coefficient value that, when multiplied by each λ component step length, will scale those lengths to achieve a new diffusion rate '''δ'''.
 
 




{{Clear}}
{{Clear}}


==[[Brownian Motion]] Matlab Code==
=Brownian Motion MATLAB Code=
 
<br>
<syntaxhighlight lang="matlab" line start="1" highlight="1" enclose="div">
function [boom] = BradsBrownianMotionScript()
format compact;
format short;
close all;
 
% Note: This matlab script requires 'msdanalyzer' toolbox
%-------------############################------------------%
%                STARTING PARAMETERS
%-------------############################------------------%
D = .3;                    % Diffusion Rate
Ds = .1;                    % Diffusion Scalar (Ds = Dn)
Dn = D/(D/Ds);              % new D after scaling L
d = 2;                      % dimensions
dT = 1;                    % time step
k = sqrt(d*D);             % stdev of D's step size distribution
MSD = 2*d*D;                % mean squared displacement
L = sqrt(2*d*D);            % average diagonal (2D) step size
Lx = L/sqrt(2);            % average linear (1D) step size
Ls = 1/sqrt(D/Ds);          % scales Lx values for Dn
 
 
MSDtest = [1 0 0]; % test: D, Dn, or L
Scale = 1/10; % scale of model
Ndots = 100;
Nsteps = Ndots;
 
 
xyl = ones(2,Ndots);
xyds = ones(2,Ndots);
lims = ((D+1)^2)*10;
 
 
%===========================================================%
%              LIVE PARTICLE DIFFUSION
%-----------------------------------------------------------%
for t = 1:Nsteps
 
    xyds = STEPxyds(Ndots, k);
[xyl] = AMPARSTEP(Ndots, xyds, xyl);
MAINPLOT(xyl, lims);
 
end
%===========================================================%
 
 
%===========================================================%
%              MSD RANDOM STEPS ANALYSIS
%-----------------------------------------------------------%
tracks = cell(Ndots, 1);
 
stepN = 1;
for t = 1:Nsteps
 
xyds = STEPxyds(Ndots, k);
[xyl] = AMPARSTEP(Ndots, xyds, xyl);
    [tracks] = MSDfun(stepN, Nsteps, tracks, xyds);
 
stepN = stepN+1;
end
MSDfunction(tracks,Ndots,Nsteps,D,Dn,L,dT,k,Scale,MSDtest);
 
 
 
 
 
%===========================================================%
%              MSD UNIFORM STEPS ANALYSIS
%-----------------------------------------------------------%
stepN = 1;
for t = 1:Nsteps
 
xyds = stepsize(Ndots, Lx);
[xyl xyds] = MSDAMPARSTEP(Ndots, xyds, xyl, Ls);
    [tracks] = MSDfun(stepN, Nsteps, tracks, xyds);
 
stepN = stepN+1;
end
MSDfunction(tracks,Ndots,Nsteps,D,Dn,L,dT,k,Scale,MSDtest);
 
 
boom = 'done';
%-------------############################------------------%
end %        ##    END MAIN FUNCTION  ##
%-------------############################------------------%
%%
 
 
 
 
 
%%
%-------------############################------------------%
%            ##      SUBFUNCTIONS      ##
%-------------############################------------------%
 
 
%-------------------------------------------%
% STEP SIZE GENERATOR
%-------------------------------------------%
function xyds = STEPxyds(Ndots, k)
 
    xyds = (k * randn(2,Ndots));
 
end
 
 
%-------------------------------------------%
% MOVE PARTICLES MAIN FUNCTION
%-------------------------------------------%
function [xyl] = AMPARSTEP(Ndots, xyds, xyl)
for j = 1:Ndots
        xyl(:,j) = xyl(:,j)+xyds(:,j);
end
end
 
 
%-------------------------------------------%
% LIVE DIFFUSION PLOT
%-------------------------------------------%
function [] = MAINPLOT(xyl, lims)
%-------------------------------------------%
xlim = [-lims lims];
ylim = [-lims lims];
zlim = [-5 5];
 
%=================================%
%      MAIN 2D PLOT
%---------------------------------%
figure(1)
subplot(2,1,1),
AMPARPlot = gscatter(xyl(1,:),xyl(2,:));
axis([xlim, ylim]);
set(AMPARPlot,'marker','.','markersize',[6],'color',[1 0 0])
 
 
%=================================%
%          3D PLOT
%---------------------------------%
figure(1);
subplot(2,1,2),
gscatter(xyl(1,:),xyl(2,:)); view(20, 30);
axis normal;
grid off
axis([xlim, ylim, zlim]);
set(gca, 'Box', 'on');
 
end
 
 
%-------------------------------------------%
% MANUAL STEP SIZE FUNCTION
%-------------------------------------------%
function xyds = stepsize(Ndots, Lx)
%-------------------------------------------%
 
  Lx(1:2,1:Ndots) = Lx;
  xyd = randi([0 1],Ndots,2)';
  xyd(xyd == 0) = -1;
  xyds = (Lx.*xyd);
 
end
 
 
%-------------------------------------------%
% MSD SCALED STEPS FUNCTION
%-------------------------------------------%
function [xyl xyds] = MSDAMPARSTEP(Ndots, xyds, xyl, Ls)
for j = 1:Ndots
        xyds(:,j) = xyds(:,j)*Ls;
        xyl(:,j) = xyl(:,j)+xyds(:,j);
end
end
 
 
%-------------------------------------------%
% MSD TRACKS GENERATOR
%-------------------------------------------%
function [tracks] = MSDfun(stepN, Nsteps, tracks, xyds)
    time = (0:Nsteps-1)';
    xymsd = xyds';
    xymsd = cumsum(xymsd,1);
    tracks{stepN} = [time xymsd];
 
end
 
 
%-------------------------------------------%
% MSD TRACKS ANALYSIS
%-------------------------------------------%
function [] = MSDfunction(tracks,Ndots,Nsteps,D,Dn,L,dT,k,Scale,MSDtest)
 
SPACE_UNITS = 'µm';
TIME_UNITS = 's';
N_PARTICLES = Ndots;
N_TIME_STEPS = Nsteps;
N_DIM = 2;
 
oD = D; % raw µm^2/s
D  = D*Scale;      % to-scale µm^2/s
 
oDn = Dn; % raw µm^2/s
Dn = Dn*Scale; % to-scale µm^2/s
 
oL = L; % raw µm
L = L*Scale; % to-scale µm
 
dTbase = dT; % raw time-step
dT = dT*Scale; % to-scale time-step
k = k; % stdv of step distribution
 
ma = msdanalyzer(2, SPACE_UNITS, TIME_UNITS);
ma = ma.addAll(tracks);
disp(ma)
 
figure
ma.plotTracks;
ma.labelPlotTracks;
 
ma = ma.computeMSD;
ma.msd;


t = (0 : N_TIME_STEPS)' * dT;
<big>Visit this page to view or download a full [[Brownian Motion MATLAB Code|Brownian Motion simulation and analysis in MATLAB]].</big>
[T1, T2] = meshgrid(t, t);
all_delays = unique( abs(T1 - T2) );


figure
ma.plotMSD;




cla
ma.plotMeanMSD(gca, true)


mmsd = ma.getMeanMSD;
=Simulating Particle Trajectories=
t = mmsd(:,1);
x = mmsd(:,2);
dx = mmsd(:,3) ./ sqrt(mmsd(:,4));
errorbar(t, x, dx, 'k')


[fo, gof] = ma.fitMeanMSD;
This exercise shows how to simulate the motion of single and multiple particles in one and two dimensions using MATLAB.  You will discover some useful ways to visualize and analyze particle motion data, as well as learn the Matlab code to accomplish these tasks. Once you understand the simulations, you can tweak the code to simulate the actual experimental conditions you choose for your study of Brownian motion of synthetic beads.  These simulations will generate the predictions you can test in your experiment. In each section, MATLAB code shown in the box to the left is used to generate the plot or analysis shown on the right.
plot(fo)
ma.labelPlotMSD;
legend off


ma = ma.fitMSD;
good_enough_fit = ma.lfit.r2fit > 0.8;
Dmean = mean( ma.lfit.a(good_enough_fit) ) / 2 / ma.n_dim;
Dstd  =  std( ma.lfit.a(good_enough_fit) ) / 2 / ma.n_dim;
Dheader1 = ['Raw Unscaled Values'];
Dhead1 = ['    D        Dn        L'];
Ddat1 = [oD oDn oL];
disp(' ')
disp(Dheader1)
disp(Dhead1)
disp(Ddat1)
yourtesthead = ['YOU ARE TESTING DIFFUSION FOR:'];
if MSDtest(1)
yourtest = ['  D:  original diffusion rate'];
elseif MSDtest(2)
yourtest = ['  Dn:  new diffusion rate'];
elseif MSDtest(3)
yourtest = ['  L:  step length'];
else
yourtest = ['  generic diffusion rate'];
end
disp(yourtesthead)
disp(yourtest)
disp(' ')
fprintf('Estimation of raw D coefficient from MSD:\n')
fprintf('D = %.3g ± %.3g (mean ± std, N = %d)\n', ...
    Dmean, Dstd, sum(good_enough_fit));
% Retrieve instantaneous velocities, per track
trackV = ma.getVelocities;
% Pool track data together
TV = vertcat( trackV{:} );
% Velocities are returned in a N x (nDim+1) array: [ T Vx Vy ...]. So the
% velocity vector in 2D is:
V = TV(:, 2:3);
% Compute diffusion coefficient
varV = var(V);
mVarV = mean(varV); % Take the mean of the two estimates
Dest = mVarV / 2 * dT;
Dheader2 = ['Scaling to model...'];
Dhead2 = ['    D        Dn        L'];
Ddat2 = [D Dn L];
disp(' ')
disp(Dheader2)
disp(Dhead2)
disp(Ddat2)
fprintf('Estimation from velocities histogram:\n')
fprintf('Tested D = %.3g %s, compare to scaled Des value of %.3g %s\n', ...
    Dest, [SPACE_UNITS '²/' TIME_UNITS], D, [SPACE_UNITS '²/' TIME_UNITS]);
% printf('D.psd target value was %.3g %s\n', ...
%    Dest, msdDpsd, [SPACE_UNITS '²/' TIME_UNITS]);
end
</syntaxhighlight>
<br /><br />
{{Clear}}
==[[Stochastic Diffusion]]==
=Introduction=
This exercise shows how to simulate the motion of single and multiple particles in one and two dimensions using Matlab.  You will discover some useful ways to visualize and analyze particle motion data, as well as learn the Matlab code to accomplish these tasks.  Once you understand the simulations, you can tweak the code to simulate the actual experimental conditions you choose for your study of Brownian motion of synthetic beads.  These simulations will generate the predictions you can test in your experiment. 
In each section, Matlab code shown in the box to the left is used to generate the plot or analysis shown on the right.  '''To use the code, copy it from the box on the left, launch the Matlab application,  and paste the code into the Matlab Command Window.''' If you are new to Matlab, check out the [[Intro to Matlab]] page to help you get started.
=Simulating Single Particle Trajectories=
The following sections cover simulating the stochastic motion of individual particles in n-dimensions.
<big>For a tutorial on using the Matlab MSD extension see: [http://bradleymonk.com/0misc/matlab/msd/MSDTuto.html Mean Squared Diffusion (MSD) Tutorial]</big>
==Open Source 'plasticity' Project==
Before jumping into the fundamentals of stochastic diffusion programming, it may be encouraging to know that these basic principles can be combined to model stochastic processes with real-world applications. One current project I'd like to plug is called "plasticity", which is an open source collaboration I started last year aimed at modeling the membrane diffusion of receptors along dendritic surfaces of neurons. The overall goal of "plasticity" is to develop spatially and temporally accurate models of molecular dynamics in neurons, and simulate complex activities using simple MCMC and statistical method Here's a simulation produced using code from [https://github.com/subroutines/plasticity the ''plasticity'' repo on github].
[[File:Github plasticity.png|link=https://github.com/subroutines/plasticity]]
<html>
<iframe width="560" height="315" src="https://www.youtube.com/embed/6ZNnBGgea0Y" frameborder="0" allow="accelerometer; autoplay; encrypted-media; gyroscope; picture-in-picture" allowfullscreen></iframe>
</html>


==One Dimensional Brownian Motion==
==One Dimensional Brownian Motion==
Line 518: Line 148:




 
<syntaxhighlight lang="matlab" line start="1">
<syntaxhighlight lang="matlab" line start="1" highlight="0" enclose="div">
% One Dimensional Brownian Motion
%-------------############################------------------%
%                One Dimensional Brownian Motion
%-------------############################------------------%


N = 1000;
N = 1000;
displacement = randn(1,N);
displacement = randn(1,N);
plot(displacement);
plot(displacement);
</syntaxhighlight>


%-------------############################------------------%


</syntaxhighlight>


{{Clear}}
==Distribution of Displacements==     
==Distribution of Displacements==     


Line 542: Line 170:
</pre>
</pre>


{{Clear}}
==Convert displacements to position==
==Convert displacements to position==


Line 548: Line 178:
[[Image:SingleParticleSimulations_03.png|right|thumb|300px]]
[[Image:SingleParticleSimulations_03.png|right|thumb|300px]]


<pre>
<syntaxhighlight lang="matlab" line start="1">
x = cumsum(displacement);
x = cumsum(displacement);
plot(x);
plot(x);
Line 554: Line 184:
xlabel('time step');
xlabel('time step');
title('Position of 1D Particle versus Time');
title('Position of 1D Particle versus Time');
</pre>
</syntaxhighlight>
 
 


{{Clear}}
==Two dimensional particle simulation==
==Two dimensional particle simulation==


[[Image:SingleParticleSimulations_04.png|right|thumb|300px]]
[[Image:SingleParticleSimulations_04.png|right|thumb|300px]]


<p>Extending this to two dimensions is simple. Since all directions are (assumed to be) equivalent, all we need to do is generate two vectors of random displacements. The vector of displacements saved in a [http://www.mathworks.com/access/helpdesk/help/techdoc/index.html?/access/helpdesk/help/techdoc/ref/struct.html&http://www.mathworks.com/cgi-bin/texis/webinator/search_spt?db=MSS&prox=page&rorder=750&rprox=750&rdfreq=500&rwfreq=500&rlead=250&sufs=0&order=r&is_summary_on=1&pr=SPT&cq=1&collection=1&ResultCount=10&query=struct Matlab structure] called <tt>particle</tt>. x and y position vectors are stored in members of the structure. This data could also have been saved as a 2xN matrix. Using a structure has the important advantage that a meaningful name can be assigned to each member. This good practice makes your code much more readable.</p>
Extending this to two dimensions is simple. Since all directions are (assumed to be) equivalent, all we need to do is generate two vectors of random displacements. The vector of displacements saved in a Matlab struct called <tt>particle</tt>. x and y position vectors are stored in members of the structure. This data could also have been saved as a 2xN matrix. Using a structure has the important advantage that a meaningful name can be assigned to each member. This good practice makes your code much more readable.




{{Style|class=div|size=12px|border=1px dotted red|font=Courier|background=#F8F8F8|pad=1px|margin=1px|width=50%;|
<syntaxhighlight lang="matlab" line start="1">
<syntaxhighlight lang="matlab" line start="1" highlight="0" enclose="div">
% Two Dimensional Brownian Motion
%-------------###############################----------------%
%            Two Dimensional Brownian Motion
%-------------###############################----------------%


particle = struct();
particle = struct();
Line 574: Line 204:


plot(particle.x, particle.y);
plot(particle.x, particle.y);
  ylabel('Y Position');
ylabel('Y Position');
  xlabel('X Position');
xlabel('X Position');
  title('position versus time in 2D');
title('position versus time in 2D');
</syntaxhighlight>
 
 
 


%-------------############################------------------%
</syntaxhighlight>
}}


{{Clear}}
==Compute the Displacement Squared==
==Compute the Displacement Squared==


[[Image:SingleParticleSimulations_05.png|right|thumb|300px]]
[[Image:SingleParticleSimulations_05.png|right|thumb|300px]]


<p>The displacement squared is equal to the x coordinate squared plus the y coordinate squared. Since the simulated particle always start at (0,0), it is unnecessary to subtract off the initial position (as will be necessary with the data you gather in the lab).</p>
The displacement squared is equal to the x coordinate squared plus the y coordinate squared. Since the simulated particle always start at (0,0), it is unnecessary to subtract off the initial position (as will be necessary with the data you gather in the lab).


<p>The dot caret (.^) operator raises each element of a matrix to a power.</p>
The dot caret (.^) operator raises each element of a matrix to a power.
 
<syntaxhighlight lang="matlab" line start="1">
% Displacement Squared


<pre>
dsquared = particle.x .^ 2 + particle.y .^ 2;
dsquared = particle.x .^ 2 + particle.y .^ 2;
plot(dsquared);
plot(dsquared);
</pre>
</syntaxhighlight>
 
 


==Theoretical Value of <i>D</i>==


<p>The theoretical value of the diffusion coefficient, <i>D</i>, is given by <code>D   = k<sub>B</sub> * T / (3πrη)</code> where <i>T</i> = temperature (Kelvin), <i>k</i><sub>B</sub> = Boltzmann's constant, eta = viscosity, and <i>r</i> = diffusion_radius.</p>
{{Clear}}
==Theoretical Value of D==


<p>Note that the units of <i>D</i> are length squared divided by time. See the lab writeup for more information. Let's compute <i>D</i> for a 1 micron particle in water at 293 degrees Kelvin.</p>
The theoretical value of the diffusion coefficient, <i>D</i>, is given by <code>D    = k<sub>B</sub> * T / (3πrη)</code> where <i>T</i> = temperature (Kelvin), <i>k</i><sub>B</sub> = Boltzmann's constant, eta = viscosity, and <i>r</i> = diffusion_radius. Note that the units of <i>D</i> are length squared divided by time. See the lab writeup for more information. Let's compute <i>D</i> for a 1 micron particle in water at 293 degrees Kelvin.


<pre>
<syntaxhighlight lang="matlab" line start="1">
r    = 1.0e-6;              % radius in meters
r    = 1.0e-6;              % radius in meters
eta  = 1.0e-3;              % viscosity of water in SI units (Pascal-seconds) at 293 K
eta  = 1.0e-3;              % viscosity of water in SI units (Pascal-seconds) at 293 K
Line 607: Line 243:
T    = 293;                % Temperature in degrees Kelvin
T    = 293;                % Temperature in degrees Kelvin


D   = kB * T / (3 * pi * r * eta)
D = kB * T / (3 * pi * r * eta);
 
</syntaxhighlight>
ans =
      4.29e-13
</pre>
 


Qian et al. derived a way to estimate the diffusion coefficient from the distribution of instantaneous velocities. If v is the instantaneous velocity vector, then
Qian et al. derived a way to estimate the diffusion coefficient from the distribution of instantaneous velocities. If v is the instantaneous velocity vector, then


<big><code>(v) = 2D / dT</code></big>
<pre>
v = 2D / dT
</pre>


==A more realistic particle -- Getting the Units Right==
==A more realistic particle -- Getting the Units Right==
Line 629: Line 263:




{{Style|class=div|size=12px|border=1px dotted red|font=Courier|background=#F8F8F8|pad=1px|margin=1px|width=50%;|
 
<syntaxhighlight lang="matlab" line start="1" highlight="0" enclose="div">
<syntaxhighlight lang="matlab" line start="1">
%-------------###############################----------------%
N = 1000;
%             Two Dimensional Realistic Brownian Motion
 
%-------------###############################----------------%
r    = 1.0e-6;              % radius in meters
eta  = 1.0e-3;              % viscosity of water in SI units (Pascal-seconds) at 293 K
kB  = 1.38e-23;            % Boltzmann constant
T    = 293;                % Temperature in degrees Kelvin
 
D = kB * T / (3 * pi * r * eta);
 


dimensions = 2;        % two dimensional simulation
dimensions = 2;        % two dimensional simulation
Line 647: Line 287:


dSquaredDisplacement = (dx .^ 2) + (dy .^ 2);
dSquaredDisplacement = (dx .^ 2) + (dy .^ 2);
  squaredDisplacement = ( x .^ 2) + ( y .^ 2);
squaredDisplacement = ( x .^ 2) + ( y .^ 2);


plot(x,y);
plot(x,y);
title('Particle Track of a Single Simulated Particle');
title('Particle Track of a Single Simulated Particle');
%-------------############################------------------%
</syntaxhighlight>
</syntaxhighlight>
}}


==Displacement Squared Plot==
==Displacement Squared Plot==
Line 662: Line 299:
<p>Theory predicts that the displacement should increase in proportion to the square root of time. The theoretical value of displacement squared is plotted with a thick black line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot. With only a single particle and a small number of samples, deviation from the line can be quite large.</p>
<p>Theory predicts that the displacement should increase in proportion to the square root of time. The theoretical value of displacement squared is plotted with a thick black line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot. With only a single particle and a small number of samples, deviation from the line can be quite large.</p>


<pre>
<syntaxhighlight lang="matlab" line start="1">
% continuing from above...
 
clf;
clf;
plot(time, (0:1:(N-1)) * 2*k^2 , 'k', 'LineWidth', 3);      % plot theoretical line
hold on;
hold on;
plot(time, (0:1:(N-1)) * 2*k^2 , 'k', 'LineWidth', 3);      % plot theoretical line
plot(time, squaredDisplacement);
plot(time, squaredDisplacement);
hold off;
hold off;
xlabel('Time');
xlabel('Time');
ylabel('Displacement Squared');
ylabel('Displacement Squared');
title('Displacement Squared versus Time for 1 Particle in 2 Dimensions');
title('Displacement Squared versus Time for 1 Particle in 2 Dimensions');
</pre>
</syntaxhighlight>
 
 
 
 
 
 


==Estimating <i>D</i> from the Simulated Data==
==Estimating <i>D</i> from the Simulated Data==
Line 682: Line 327:


ans =  
ans =  
     4.2192e-013
     4.22 E-13
</pre>
</pre>


Line 699: Line 344:
               7.1019e-015
               7.1019e-015
</pre>
</pre>


==Systematic Error -- Bulk Flow in the Solvent==
==Systematic Error -- Bulk Flow in the Solvent==
Line 706: Line 357:
<p>Sometimes, evaporation or uneven heating of the solvent will cause a flow to occur on the slide you are observing. We can model this easily. The following code models a flow with a magnitude 0.5 k in the x direction and 0.1 k in the y direction.</p>
<p>Sometimes, evaporation or uneven heating of the solvent will cause a flow to occur on the slide you are observing. We can model this easily. The following code models a flow with a magnitude 0.5 k in the x direction and 0.1 k in the y direction.</p>


<pre>
<syntaxhighlight lang="matlab" line start="1">
dx = dx + 0.2 * k;
dx = dx + 0.2 * k;
dy = dy + 0.05 * k;
dy = dy + 0.05 * k;
Line 729: Line 380:
actualError  =  
actualError  =  
               -2.3859e-016
               -2.3859e-016
</pre>
</syntaxhighlight>
 
 
 
 
 
 
 


==Displacement Squared in the Presence of Bulk Flow==
==Displacement Squared in the Presence of Bulk Flow==
Line 749: Line 407:
</pre>
</pre>


=Simulating Multiple Particles=
 
 
 
 
 
 
==Simulating Multiple Particles==


<p>When you take your data in the lab, you will make movies of many particles. You will use a Matlab program to extract particle tracks from these movies. Because particles drift out of view and go in and out of focus, most movies will be about 5 seconds long at a sample rate of 10 Hz or so. Let's simulate this.</p>
<p>When you take your data in the lab, you will make movies of many particles. You will use a Matlab program to extract particle tracks from these movies. Because particles drift out of view and go in and out of focus, most movies will be about 5 seconds long at a sample rate of 10 Hz or so. Let's simulate this.</p>


==Using a For Loop to Generate Multiple Data Sets==


<p>A <tt>for</tt> loop is the key to generating multiple particle simulations. The results of the simulations are stored in a cellular array of structures called <tt>particle</tt>. For example, <tt>particle{3}</tt> refers to a structure containing the results of simulation number 3. <tt>particle{3}.D</tt> is the estimated value of <i>D</i> for simulation number 3. It is not necessary to understand this code in depth. But do yourself a favor and have a look.</p>


<pre>
 
===Using a For Loop to Generate Multiple Data Sets===
[[Image:MultipleParticleSimulation_02.png|right|thumb|300px]]
 
A <tt>for</tt> loop is the key to generating multiple particle simulations. The results of the simulations are stored in a cellular array of structures called <tt>particle</tt>. For example, <tt>particle{3}</tt> refers to a structure containing the results of simulation number 3. <tt>particle{3}.D</tt> is the estimated value of <i>D</i> for simulation number 3. It is not necessary to understand this code in depth. But do yourself a favor and have a look. The following code also plots all of the generated particle tracks on a single set of axes, each in a random color.
 
<syntaxhighlight lang="matlab" line start="1">
particleCount = 10;
particleCount = 10;
N = 50;
N = 50;
Line 775: Line 443:
     particle{i}.standardError = std( particle{i}.drsquared ) / ( 2 * dimensions * tau * sqrt(N) );
     particle{i}.standardError = std( particle{i}.drsquared ) / ( 2 * dimensions * tau * sqrt(N) );
end
end
</pre>


==SimulateParticle Function==


<p>That's a lot of typing. Fortunately, all of the commands to generate multiple particle tracks have been combined into in a single function called <tt>SimulateParticles</tt>. If you are interested in how the function is implemented, type <tt>edit SimulateParticles.m</tt> to have a look at the m-file for this function.</p>
clf;
 
<pre>
help SimulateParticles
 
particle = SimulateParticles(N, particleCount, tau, k);
usage: out =
SimulateParticles( N, particleCount, tau, k )
 
N is the number of samples
particleCount is the number of particles
tau is the sample period
k is the standard deviation of dx and dy
returns a cellular array of length particleCount
</pre>
 
==Look at the Results==
 
[[Image:MultipleParticleSimulation_01.png|right|thumb|300px]]
 
<p>The following code plots all of the generated particle tracks on a single set of axes, each in a random color.</p>
 
<pre>clf;
hold on;
hold on;
for i = 1:particleCount
for i = 1:particleCount
Line 813: Line 455:
title('Combined Particle Tracks');
title('Combined Particle Tracks');
hold off;
hold off;
</pre>
</syntaxhighlight>
 
 
 
 


==Displacement Squared==
===Displacement Squared===


[[Image:MultipleParticleSimulation_02.png|right|thumb|300px]]
[[Image:MultipleParticleSimulation_01.png|right|thumb|300px]]


<p>The following plot shows displacement squared versus time for all of the particles. The ensemble average of all the displacements is shown with a thick black line. The theoretical value of displacement squared is plotted with a thick blue line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot.</p>
<p>The following plot shows displacement squared versus time for all of the particles. The ensemble average of all the displacements is shown with a thick black line. The theoretical value of displacement squared is plotted with a thick blue line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot.</p>


<pre>
<syntaxhighlight lang="matlab" line start="1">
% compute the ensemble average
% compute the ensemble average
rsquaredSum = zeros(1,N);
rsquaredSum = zeros(1,N);
Line 847: Line 493:
title('Displacement Squared vs Time');
title('Displacement Squared vs Time');
hold off;
hold off;
</pre>
</syntaxhighlight>
 
 
 
 
 


==Estimated Value of <i>D</i>==
===Estimated Value of <i>D</i>===


[[Image:MultipleParticleSimulation_03.png|right|thumb|300px]]
[[Image:MultipleParticleSimulation_03.png|right|thumb|300px]]
Line 855: Line 506:
<p>This plot shows the computed value of <i>D</i> for each simulation with error bars. A thick blue line indicates the best overall estimate of <i>D</i> (the average of the <i>D</i> value from each simulation) along with error bars in green <b>*</b> WHICH HAPPEN TO BE WRONG -- NEED TO FIX <b>*</b>.</p>
<p>This plot shows the computed value of <i>D</i> for each simulation with error bars. A thick blue line indicates the best overall estimate of <i>D</i> (the average of the <i>D</i> value from each simulation) along with error bars in green <b>*</b> WHICH HAPPEN TO BE WRONG -- NEED TO FIX <b>*</b>.</p>


<pre>
 
<syntaxhighlight lang="matlab" line start="1">
clear D e dx;
clear D e dx;


Line 891: Line 543:
uncertainty =  
uncertainty =  
             2.3294e-014
             2.3294e-014
</pre>
</syntaxhighlight>
 
 
 
 
 


=Fancy Statistics and Plots=
=Motion Statistics and Plots=


<p>This section looks at the statistical properties of the simulated data in more detail. In particular, it discusses:</p>
<p>This section looks at the statistical properties of the simulated data in more detail. In particular, it discusses:</p>
Line 920: Line 577:
title('Histogram of Values for 1000000 Samples of randn');
title('Histogram of Values for 1000000 Samples of randn');
</pre>
</pre>


==Sampling Uncertainty==
==Sampling Uncertainty==
Line 931: Line 592:
<p>Matlab note: check out the nested <tt>for</tt> loops used to create the plot.</p>
<p>Matlab note: check out the nested <tt>for</tt> loops used to create the plot.</p>


<pre>clf;
 
hold on;
<syntaxhighlight lang="matlab" line start="1">
<span class="keyword">for i= 1:100
clf; hold on;
     <span class="keyword">for j = 1:50
for i= 1:100
     for j = 1:50
         y = randn(1,i);
         y = randn(1,i);
         m = mean(y);
         m = mean(y);
         plot(i,m,'x');
         plot(i,m,'x');
     <span class="keyword">end
     end
end


<span class="keyword">end
plot(1:100, 1./sqrt(1:100), 'k', 'LineWidth', 2);  % plot upper error bar in dark black
plot(1:100, 1./sqrt(1:100), 'k', 'LineWidth', 2);  % plot upper error bar in dark black
plot(1:100, -1./sqrt(1:100), 'k', 'LineWidth', 2);  % plot lower error bar in dark black
plot(1:100, -1./sqrt(1:100), 'k', 'LineWidth', 2);  % plot lower error bar in dark black
Line 947: Line 609:
ylabel('Population Mean');
ylabel('Population Mean');
title('Population Mean of Normally Distributed Random Variable versus Population Size');
title('Population Mean of Normally Distributed Random Variable versus Population Size');
</pre>
</syntaxhighlight>
 
 
 
 
 


==What Happens when you Square a Random Variable?==
==What Happens when you Square a Random Variable?==


[[Image:FancyStatistics_04.png|right|thumb|300px]]
[[Image:FancyStatistics_04.png|right|thumb|300px]]


<p>We did not estimate <i>D</i> in the simulations from the x and y displacements directly. Instead, we computed the mean squared value of dx and dy. What is the distribution of the resulting value? Adding the squares of two normally distributed random variables results in a [http://en.wikipedia.org/wiki/Chi_squared chi-squared distribution] (with two degrees of freedom) whose mean value equal to the sum of the variances of each variable. Here is what the chi-squared distribution looks like:</p>
<p>We did not estimate <i>D</i> in the simulations from the x and y displacements directly. Instead, we computed the mean squared value of dx and dy. What is the distribution of the resulting value? Adding the squares of two normally distributed random variables results in a [http://en.wikipedia.org/wiki/Chi_squared chi-squared distribution] (with two degrees of freedom) whose mean value equal to the sum of the variances of each variable. Here is what the chi-squared distribution looks like:</p>


<pre>
<pre>
Line 974: Line 643:
</pre>
</pre>


==100 Years of BIO Lab Data in 1 Second==


[[Image:FancyStatistics_05.png|right|thumb|300px]]


<p>So does the uncertainty of the squared and summed behave as expected? The following plot is a simulation of 5000 data sets - 50 at each value of N just as above. (This is what a plot of all the data from students doing the BIO lab for the next hundred years might look like. Some lazy groups decided to use very low values of N.)</p>


<pre>
clf;
hold on;


for i= 1:100
    for j = 1:50
        dx = randn(1,i);
        dy = randn(1,i);
        m = mean( dx .^ 2 + dy .^ 2 );
        plot(i,m,'x');
    end
end


plot(1:100, 2 + 2./sqrt(1:100), 'k', 'LineWidth', 2);  % plot upper error bar in dark black
plot(1:100, 2 - 2./sqrt(1:100), 'k', 'LineWidth', 2);  % plot lower error bar in dark black
hold off;
xlabel('Population Size (N)');
ylabel('Population Mean');
title('Population Mean of Chi Squared (2 DOF) Distributed Random Variable versus Population Size');
</pre>
==Planning Your Time in the Lab==
<p>Sampling error sets a lower bound on the uncertainty in your estimate of the diffusion coefficient from experimental data. To plan your time in the lab, it will be important to understand how much data you should take for each experimental condition. Because the particles go out of focus and drift away from of the observation area, it can be difficult to make movies longer than about 5 seconds. At a frame rate of 10 frames per second, how many movies would you have to make to achieve a final uncertainty of 10%? 1%? .1%? What level of uncertainty will you try for in the lab?</p>


==Auto Correlation - A Closer Look at the Data==
==Auto Correlation - A Closer Look at the Data==
Line 1,010: Line 653:
[[Image:FancyStatistics_06.png|right|thumb|300px]]
[[Image:FancyStatistics_06.png|right|thumb|300px]]


<p>The simulations so far have assumed that we are in the overdamped limit, or the inertia-less regime. This assumption makes generating simulated trajectories very easy - all you have to do is add up a bunch of properly distributed random numbers. Of course, just because something is convenient doesn't mean it's true.</p>
The simulations so far have assumed that we are in the overdamped limit, or the inertia-less regime. This assumption makes generating simulated trajectories very easy - all you have to do is add up a bunch of properly distributed random numbers. Of course, just because something is convenient doesn't mean it's true.


<p>There are many statistical tests for independence and normality. (My personal favorite is the Kolmogorov-Smirnov test – but never before 5:00 PM.) Auto and cross correlation are a good place to start testing for independence. Autocorrelation looks for a relationship between a variable and its past or future values. Cross correlation looks for a relationship between two variables. Matlab has a built in function to compute auto and cross correlations called <tt>xcorr</tt>.</p>
There are many statistical tests for independence and normality. (My personal favorite is the Kolmogorov-Smirnov test – but never before 5:00 PM.) Auto and cross correlation are a good place to start testing for independence. Autocorrelation looks for a relationship between a variable and its past or future values. Cross correlation looks for a relationship between two variables. Matlab has a built in function to compute auto and cross correlations called <tt>xcorr</tt>.


<p>By construction, the simulated displacements are independent. The change in position at one time should exhibit no relationship at all to the change at any other time. This can be verified with <tt>xcorr</tt>. If x is a vector, <tt>xcorr(x)</tt> returns the correlation of x with itself for all possible offsets. The length of the resulting autocorrelation sequence is 2N+1. The middle value always stands out because x correlates perfectly with itself when there is no offset. Specifying the option 'coeff' causes the xcorr function to normalize this value to exactly 1 --perfect correlation.</p>
By construction, the simulated displacements are independent. The change in position at one time should exhibit no relationship at all to the change at any other time. This can be verified with <tt>xcorr</tt>. If x is a vector, <tt>xcorr(x)</tt> returns the correlation of x with itself for all possible offsets. The length of the resulting autocorrelation sequence is 2N+1. The middle value always stands out because x correlates perfectly with itself when there is no offset. Specifying the option 'coeff' causes the xcorr function to normalize this value to exactly 1 --perfect correlation.


<p>Also notice that the autocorrelation sequence is symmetric about the origin.</p>
Also notice that the autocorrelation sequence is symmetric about the origin.


<pre>
<pre>
Line 1,028: Line 671:
title('Particle 1 x-axis Displacement Autocorrelation');
title('Particle 1 x-axis Displacement Autocorrelation');
</pre>
</pre>


==Cross Correlation==
==Cross Correlation==
Line 1,045: Line 691:
</pre>
</pre>


==Matlab Tricks==
 
 
 
 
==MATLAB Tricks==


[[Image:FancyStatistics_08.png|right|thumb|300px]]
[[Image:FancyStatistics_08.png|right|thumb|300px]]


<p>Matlab can generate (and plot) an amazing amount of data. For example, the <tt>xcorr</tt> function can compute the auto and cross correlations of a large set of data values. If A is an MxN matrix, <tt>xcorr(A)</tt> returns a size 2*M-1 x N^2 matrix whose columns contain the cross-correlation sequences for all combinations of  the columns of A. The football shape of the data is a result of the way that the data is windowed when computing the correlation.</p>
<p>Matlab can generate (and plot) an amazing amount of data. For example, the <tt>xcorr</tt> function can compute the auto and cross correlations of a large set of data values. If A is an MxN matrix, <tt>xcorr(A)</tt> returns a size 2*M-1 x N^2 matrix whose columns contain the cross-correlation sequences for all combinations of  the columns of A. The football shape of the data is a result of the way that the data is windowed when computing the correlation.</p>


<pre>
<pre>
Line 1,074: Line 725:
title('All Possible Auto and Cross Correlations in the x Dimension');
title('All Possible Auto and Cross Correlations in the x Dimension');
</pre>
</pre>


==A Correlated Trajectory==
==A Correlated Trajectory==
Line 1,102: Line 757:




==notes & articles==
=Additional Resources=
 
here are several good resources for explaining and calculating MSD:
*[http://mathworld.wolfram.com/RandomWalk2-Dimensional.html wolfram alpha]
*[http://www.compsoc.man.ac.uk/~lucky/Democritus/Theory/msd.html Democritus]
*[http://www.mathworks.com/matlabcentral/fileexchange/40692-mean-square-displacement-analysis-of-particles-trajectories Matlab toolbox]
 
<br><br>
 
{{Article|Michalet|2010|Phys Rev E Stat Nonlin Soft Matter Phys - [http://www.ncbi.nlm.nih.gov/pmc/articles/PMC3055791/ PDF]|PMC3055791|Mean Square Displacement Analysis of Single-Particle Trajectories with Localization Error: Brownian Motion in Isotropic Medium}}
{{ExpandBox|Expand to view experiment summary|
 
We examine the capability of mean square displacement analysis to extract reliable values of the diffusion coefficient D of single particle undergoing Brownian motion in an isotropic medium in the presence of localization uncertainty. The theoretical results, supported by simulations, show that a simple unweighted least square fit of the MSD curve can provide the best estimate of D provided an optimal number of MSD points is used for the fit. We discuss the practical implications of these results for data analysis in single-particle tracking experiments.
 
}}<!-- END ARTICLE -->
 
<br>
<br>
*[http://mathworld.wolfram.com/RandomWalk2-Dimensional.html Wolfram Alpha - Random Walk]
*[http://www.compsoc.man.ac.uk/~lucky/Democritus/Theory/msd.html Democritus - MSD Theory]
*[http://www.mathworks.com/matlabcentral/fileexchange/40692-mean-square-displacement-analysis-of-particles-trajectories MSD MATLAB Toolbox]
*[http://www.ncbi.nlm.nih.gov/pmc/articles/PMC3055791/ Mean Square Displacement Analysis of Single-Particle Trajectories with Localization Error: Brownian Motion in Isotropic Medium]
*[http://www.nature.com/ncb/journal/v17/n4/full/ncb3131.html Active Diffusion Positions in the Nucleus]
*[[Stochastic Diffusion]]


{{Article|Almonacid, Ahmed, Bussonnier, Mailly, Betz, Voituriez, Gov, Verlhac|2015|Nature - [http://www.nature.com/ncb/journal/v17/n4/full/ncb3131.html PDF]|25774831|Active diffusion positions the nucleus in mouse oocytes}}
{{ExpandBox|Expand to view experiment summary|
For mean square displacement (MSD) analysis of vesicles trajectories, we used the @msdanalyzer MATLAB class described in: http://bradleymonk.com/matlab/msd/MSDTuto.html. Trajectories were provided in the xml files from Fiji TrackMate analysis.
}}<!-- END ARTICLE -->
<br><br>
{{ExpandBox|Image Gallery|
[[File:Brownian1.gif]]
[[File:Brownian2.gif]]
[[File:Brownian3.png]]
[[File:Brownian5.gif]]
[[File:Dendrite Surface Diffusion.png|500px]]
}}


==See Also==
*[[Category:Diffusion]]
* [[Stochastic Diffusion]]
*[[Category:Neurobiology]]
[[Category:Diffusion]] [[Category:Neurobiology]] [[Category:Math]] [[Category:Statistics]] [[Category:Synaptic Plasticity]] [[Category:Programming]]
*[[Category:Math]]
*[[Category:Statistics]]
*[[Category:Synaptic Plasticity]]
*[[Category:Programming]]

Latest revision as of 03:12, 23 June 2024

Brownian motion describes the stochastic diffusion of particles as they travel through n-dimensional spaces filled with other particles and physical barriers. Here the term particle is a generic term that can be generalized to describe the motion of molecule (e.g. H2O) or proteins (e.g. NMDA receptors); note however that stochastic diffusion can also apply to things like the price index of a stock (see random walk) or the propagation heat energy across a surface. Brownian motion is among the simplest continuous-time stochastic processes, and a limit of various probabilistic processes (see random walk). As such, Brownian motion is highly generalizable to many applications, and is directly related to the universality of the normal distribution. In some sense, stochastic diffusion is a pure actuation of the basic statistical properties of probability distributions - it is distribution sampling translated into movements.


Properties of Brownian Motion

Physical experiments characterize the following properties of Brownian motion...

  • continuous increments
  • increments of a particle over disjoint time intervals are independent events
  • each increment is assumed to result from collisions with many molecules
  • each increment is assumed to have a normal probability distribution
  • the mean increment is zero as there is no preferred direction
  • the position of a particle spreads out with time
  • the variance of the increment is proportional to the length of time that Brownian motion has been observed


The probability density of a normally distributed random variable with mean μ and standard deviation σ is given by:

Mathematically, the random process called Brownian motion is denoted here as B(t) and defined for times t ≥ 0; the probability density of Brownian particles at the end of time period [0, t] is obtained by substituting μ = 0 and σ = √t, giving:

where x denotes the value of random variable B(t). The probability distribution of the increment B(t + u) − B(t) is:


Common Diffusion Terms & Parameters


I've found it most helpful to learn about the terms and parameters used to characterize stochastic diffusion as they apply to diffusion phenomena along a flat 2D surface. These parameters include:


D  : diffusion rate coefficient

L : step length
d : dimensions
t : time


D (in units: µm²/s) is the mean diffusion rate per unit time (velocity), often in µm²/s for biological motion on a molecular level (n.b. µm²/s are the units for particle diffusion on a surface/membrane; the surface can actually be curved or ruffled such that the surface fills a 3D space, however the diffusion equations for those instances are slightly more complex. Units for 3D space are naturally: µm³/s). This refers to how fast, on average, the particle moves along its surface trajectories. This value is often of ultimate interest, that is, the goal of single-particle tracking studies is often to define the average diffusion rate of a molecule and report it as a Diffusion Coefficient; once D is known, this Diffusion Coefficient can then be easily implemented in computer simulations of Brownian motion. However under most circumstances, the diffusion rate cannot be observed directly in empirical experiments - this would require the ability to visualize all the microscopic particles and collisions that dictate the particle's movement on a nanosecond timescale. In the animation on the right, the diffusion rate can actually be quantified directly; but what is often seen when observing particle diffusion through a microscope would more closely resemble this:

Instead, D is often calculated from the mean squared diffusion (MSD) path of the particle, defined below.


Mean Squared Displacement (MSD)


d : dimensions
D : diffusion coefficient


MSD (in units: µm²) is the mean square displacement of a particle over some time period.

Standard deviation (k) of the normal distribution of step lengths


d : dimensions
D : diffusion coefficient


k (in units: µm) is the standard deviation (σ) of the normal distribution of step lengths that, when randomly sampled, will give rise to a diffusion rate D. This value is useful for simulating Brownian motion for a particular diffusion rate.


Mean Step Length (L)


d : dimensions
D : diffusion coefficient


L or Λ (in units: µm) is the average step length per interval of observation. In diffusion simulations, this is the step size per iteration (equivalent form: L = (2d * D).5).


Mean 1D step length component (λ)



λ (in units: µm) is the average 1-dimensional step length for each component (X,Y,Z) dimension of L. For example, simulating 2D particle diffusion will require the generation of individual step lengths for both the X and Y dimension. The total step distance from the origin will be the length of the hypotenuse created by the individual X and Y component step lengths. In fact, the equation: λ = L / √2 is derived from the Pythagorean theorem for right triangles, such that 2λ² = λ² where 2λ² represents a² + b² and λ² represents c².


Step length scalar coefficient (ε)



δ : new desired diffusion rate

ε (in units: au) is a coefficient value that, when multiplied by each λ component step length, will scale those lengths to achieve a new diffusion rate δ.


Brownian Motion MATLAB Code


Visit this page to view or download a full Brownian Motion simulation and analysis in MATLAB.



Simulating Particle Trajectories

This exercise shows how to simulate the motion of single and multiple particles in one and two dimensions using MATLAB. You will discover some useful ways to visualize and analyze particle motion data, as well as learn the Matlab code to accomplish these tasks. Once you understand the simulations, you can tweak the code to simulate the actual experimental conditions you choose for your study of Brownian motion of synthetic beads. These simulations will generate the predictions you can test in your experiment. In each section, MATLAB code shown in the box to the left is used to generate the plot or analysis shown on the right.


One Dimensional Brownian Motion

Brownian motion in one dimension is composed of a sequence of normally distributed random displacements. The randn function returns a matrix of a normally distributed random numbers with standard deviation 1. The two arguments specify the size of the matrix, which will be 1xN in the example below.

The first step in simulating this process is to generate a vector of random displacements. The commands to do this are shown below. N is the number of samples to generate.


% One Dimensional Brownian Motion

N = 1000;
displacement = randn(1,N);
plot(displacement);



Distribution of Displacements

Have a look at the distribution of the randomly generated displacements. The hist command plots a histogram of the values. The second argument - 25 - specifies that Matlab should divide the values into 25 bins.

hist(displacement, 25);


Convert displacements to position

Now we have some appropriate random displacements. Their sum represents a particle trajectory in 1 dimension. The Matlab function cumsum returns the cumulative sum of a vector. The following commands take the cumulative sum of displacement and save the result in a vector called x.

x = cumsum(displacement);
plot(x);
ylabel('position');
xlabel('time step');
title('Position of 1D Particle versus Time');


Two dimensional particle simulation

Extending this to two dimensions is simple. Since all directions are (assumed to be) equivalent, all we need to do is generate two vectors of random displacements. The vector of displacements saved in a Matlab struct called particle. x and y position vectors are stored in members of the structure. This data could also have been saved as a 2xN matrix. Using a structure has the important advantage that a meaningful name can be assigned to each member. This good practice makes your code much more readable.


% Two Dimensional Brownian Motion

particle = struct();
particle.x = cumsum( randn(N, 1) );
particle.y = cumsum( randn(N, 1) );

plot(particle.x, particle.y);
ylabel('Y Position');
xlabel('X Position');
title('position versus time in 2D');



Compute the Displacement Squared

The displacement squared is equal to the x coordinate squared plus the y coordinate squared. Since the simulated particle always start at (0,0), it is unnecessary to subtract off the initial position (as will be necessary with the data you gather in the lab).

The dot caret (.^) operator raises each element of a matrix to a power.

% Displacement Squared

dsquared = particle.x .^ 2 + particle.y .^ 2;
plot(dsquared);



Theoretical Value of D

The theoretical value of the diffusion coefficient, D, is given by D = kB * T / (3πrη) where T = temperature (Kelvin), kB = Boltzmann's constant, eta = viscosity, and r = diffusion_radius. Note that the units of D are length squared divided by time. See the lab writeup for more information. Let's compute D for a 1 micron particle in water at 293 degrees Kelvin.

r    = 1.0e-6;              % radius in meters
eta  = 1.0e-3;              % viscosity of water in SI units (Pascal-seconds) at 293 K
kB   = 1.38e-23;            % Boltzmann constant
T    = 293;                 % Temperature in degrees Kelvin

D = kB * T / (3 * pi * r * eta);

Qian et al. derived a way to estimate the diffusion coefficient from the distribution of instantaneous velocities. If v is the instantaneous velocity vector, then

v = 2D / dT

A more realistic particle -- Getting the Units Right

So far, we have been looking at simulated particles with a mean squared displacement of 1 unit per time interval. To accurately model a real particle, it is necessary to adjust the distribution of random displacements to match the experimental conditions.

According to theory, the mean squared displacement of the particle is proportional to the time interval, where r(t) = position, d = number of dimensions, D = diffusion coefficient, and tau = time interval.

To generate the correct distribution, the output from randn (which has a standard normal distribution) must be scaled by the factor k.


N = 1000;

r    = 1.0e-6;              % radius in meters
eta  = 1.0e-3;              % viscosity of water in SI units (Pascal-seconds) at 293 K
kB   = 1.38e-23;            % Boltzmann constant
T    = 293;                 % Temperature in degrees Kelvin

D = kB * T / (3 * pi * r * eta);


dimensions = 2;         % two dimensional simulation
tau = .1;               % time interval in seconds
time = tau * 1:N;       % create a time vector for plotting

k = sqrt(D * dimensions * tau);
dx = k * randn(N,1);
dy = k * randn(N,1);

x = cumsum(dx);
y = cumsum(dy);

dSquaredDisplacement = (dx .^ 2) + (dy .^ 2);
squaredDisplacement  = ( x .^ 2) + ( y .^ 2);

plot(x,y);
title('Particle Track of a Single Simulated Particle');

Displacement Squared Plot

Theory predicts that the displacement should increase in proportion to the square root of time. The theoretical value of displacement squared is plotted with a thick black line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot. With only a single particle and a small number of samples, deviation from the line can be quite large.

% continuing from above...

clf;
plot(time, (0:1:(N-1)) * 2*k^2 , 'k', 'LineWidth', 3);      % plot theoretical line
hold on;
plot(time, squaredDisplacement);
hold off;

xlabel('Time');
ylabel('Displacement Squared');
title('Displacement Squared versus Time for 1 Particle in 2 Dimensions');




Estimating D from the Simulated Data

The best estimate of the value of D from the simulated data is:

simulatedD = mean( dSquaredDisplacement ) / ( 2 * dimensions * tau )

ans = 
     4.22 E-13

Uncertainty in the Estimate

The likely error of this measurement decreases as the square root of the number of samples. This will be discussed in more detail later.

standardError = std( dSquaredDisplacement ) / ( 2 * dimensions * tau * sqrt(N) )
actualError = D - simulatedD

standardError = 
               1.3162e-014

actualError   = 
               7.1019e-015




Systematic Error -- Bulk Flow in the Solvent

Sometimes, evaporation or uneven heating of the solvent will cause a flow to occur on the slide you are observing. We can model this easily. The following code models a flow with a magnitude 0.5 k in the x direction and 0.1 k in the y direction.

dx = dx + 0.2 * k;
dy = dy + 0.05 * k;

x = cumsum(dx);
y = cumsum(dy);

dSquaredDisplacement = (dx .^ 2) + (dy .^ 2);
 squaredDisplacement = ( x .^ 2) + ( y .^ 2);

simulatedD    = mean( dSquaredDisplacement ) / ( 2 * dimensions * tau )
standardError = std(  dSquaredDisplacement ) / ( 2 * dimensions * tau * sqrt(N) )
actualError = D - simulatedD

plot(x,y);
title('Particle Track of a Single Simulated Particle with Bulk Flow');

simulatedD    =  
               4.2926e-013
standardError =  
               1.3694e-014
actualError   = 
              -2.3859e-016





Displacement Squared in the Presence of Bulk Flow

Notice how the plot of displacement squared diverges from the theoretical value. It has a distinct quadratic component. The magnitude of this error increases dramatically with time. This suggests that the error caused by bulk flow can be minimized by using the shortest possible sampling period. But there's a catch. As you increase the sampling rate, the amount of noise from the motion tracking algorithm goes up. A tenth of a second works pretty well for the particles you will observe in the lab. If you have time, take a few movies at a different rates to see the effect.

clf;
hold on;
plot(time, (0:1:(N-1)) * 2*k^2 , 'k', 'LineWidth', 3);      % plot theoretical line
plot(time, squaredDisplacement);
hold off;

xlabel('Time');
ylabel('Displacement Squared');
title('Displacement Squared versus Time with Bulk Flow');




Simulating Multiple Particles

When you take your data in the lab, you will make movies of many particles. You will use a Matlab program to extract particle tracks from these movies. Because particles drift out of view and go in and out of focus, most movies will be about 5 seconds long at a sample rate of 10 Hz or so. Let's simulate this.



Using a For Loop to Generate Multiple Data Sets

A for loop is the key to generating multiple particle simulations. The results of the simulations are stored in a cellular array of structures called particle. For example, particle{3} refers to a structure containing the results of simulation number 3. particle{3}.D is the estimated value of D for simulation number 3. It is not necessary to understand this code in depth. But do yourself a favor and have a look. The following code also plots all of the generated particle tracks on a single set of axes, each in a random color.

particleCount = 10;
N = 50;
tau = .1;
time = 0:tau:(N-1) * tau;
particle = { };             % create an empty cell array to hold the results

for i = 1:particleCount
    particle{i} = struct();
    particle{i}.dx = k * randn(1,N);
    particle{i}.x = cumsum(particle{i}.dx);
    particle{i}.dy = k * randn(1,N);
    particle{i}.y = cumsum(particle{i}.dy);
    particle{i}.drsquared = particle{i}.dx .^2 + particle{i}.dy .^ 2;
    particle{i}.rsquared = particle{i}.x .^ 2 + particle{i}.y .^ 2;
    particle{i}.D = mean( particle{i}.drsquared ) / ( 2 * dimensions * tau );
    particle{i}.standardError = std( particle{i}.drsquared ) / ( 2 * dimensions * tau * sqrt(N) );
end


clf;
hold on;
for i = 1:particleCount
    plot(particle{i}.x, particle{i}.y, 'color', rand(1,3));
end

xlabel('X position (m)');
ylabel('Y position (m)');
title('Combined Particle Tracks');
hold off;



Displacement Squared

The following plot shows displacement squared versus time for all of the particles. The ensemble average of all the displacements is shown with a thick black line. The theoretical value of displacement squared is plotted with a thick blue line. Since displacement is expected to increase with the square root of time, displacement squared is a straight line in the plot.

% compute the ensemble average
rsquaredSum = zeros(1,N);

for i = 1:particleCount
    rsquaredSum = rsquaredSum + particle{i}.rsquared;
end

ensembleAverage = rsquaredSum / particleCount;

% create the plot
clf;
hold on;
plot(time, (0:1:(N-1)) * 2*k^2 , 'b', 'LineWidth', 3);      % plot theoretical line

plot(time, ensembleAverage , 'k', 'LineWidth', 3);          % plot ensemble average
legend('Theoretical','Average','location','NorthWest');

for i = 1:particleCount
    plot(time, particle{i}.rsquared, 'color', rand(1,3));   % plot each particle track
end

xlabel('Time (seconds)');
ylabel('Displacement Squared (m^2)');
title('Displacement Squared vs Time');
hold off;




Estimated Value of D

This plot shows the computed value of D for each simulation with error bars. A thick blue line indicates the best overall estimate of D (the average of the D value from each simulation) along with error bars in green * WHICH HAPPEN TO BE WRONG -- NEED TO FIX *.


clear D e dx;

% extract the D value from each simulation and place them all into a single
% matrix called 'D'
for i = 1:particleCount
    D(i) = particle{i}.D;
    dx(i,:) = particle{i}.dx;
    e(i) = particle{i}.standardError;
end

% compute the estimate of D and the uncertainty
averageD = mean(D)
uncertainty = std(D)/sqrt(particleCount)

% plot everything
clf;
hold on;

plot(averageD * ones(1,particleCount), 'b', 'linewidth', 3);                    % plot estimated D
plot((averageD + uncertainty) * ones(1,particleCount), 'g-', 'linewidth', 1);   % plot upper error bar
plot((averageD - uncertainty) * ones(1,particleCount), 'g-', 'linewidth', 1);   % plot lower error bar
errorbar(D,e,'ro');                                                             % plot D values with error bars

xlabel('Simulation Number');
ylabel('Estimated Diffusion Coefficient');
title('Estimated Diffusion Coefficient with Error Bars')
legend('Average Value of D', 'location', 'NorthWest');

hold off;

averageD    = 
             4.2886e-013

uncertainty = 
             2.3294e-014




Motion Statistics and Plots

This section looks at the statistical properties of the simulated data in more detail. In particular, it discusses:

  • Uncertainty in the estimate of the mean value of a random variable from a population of samples
  • The effect of squaring a normally distributed random variable
  • The assumption of statistical independence of samples

A More Perfect Distribution

Error creating thumbnail: File missing
Error creating thumbnail: File missing

Did you notice that the distribution of random displacement values in the second section looked a little lopsided? Even with 1000 samples, there can be some noticeable deviations from the ideal distribution. A million samples looks quite a bit closer to the ideal.

hist(randn(1,1e3),25)
xlabel('Value');
ylabel('Frequency');
title('Histogram of Values for 1000 Samples of randn');
hist(randn(1,1e6),100)
xlabel('Value');
ylabel('Frequency');
title('Histogram of Values for 1000000 Samples of randn');



Sampling Uncertainty

Error creating thumbnail: File missing

This lab requires you to make an estimate of the average value of a random variable (actually, the square of a random variable) from a population of samples of that variable. The uncertainty in your estimate decreases with the square root of the number of samples, N. (That is, the standard error = 1/sqrt(N).)

This concept is illustrated in the following plot. To create the plot, fifty populations of N random samples are created for each value of N from 1 to 100. The mean value of each sample population is plotted with an 'x' versus N. The uncertainty appears to decrease as 1/sqrt(N) as expected. About two thirds of the values fall between the error bars (plotted in dark black).

Matlab note: check out the nested for loops used to create the plot.


clf; hold on;
for i= 1:100
    for j = 1:50
        y = randn(1,i);
        m = mean(y);
        plot(i,m,'x');
    end
end

plot(1:100, 1./sqrt(1:100), 'k', 'LineWidth', 2);   % plot upper error bar in dark black
plot(1:100, -1./sqrt(1:100), 'k', 'LineWidth', 2);  % plot lower error bar in dark black
hold off;
xlabel('Population Size (N)');
ylabel('Population Mean');
title('Population Mean of Normally Distributed Random Variable versus Population Size');




What Happens when you Square a Random Variable?

Error creating thumbnail: File missing


We did not estimate D in the simulations from the x and y displacements directly. Instead, we computed the mean squared value of dx and dy. What is the distribution of the resulting value? Adding the squares of two normally distributed random variables results in a chi-squared distribution (with two degrees of freedom) whose mean value equal to the sum of the variances of each variable. Here is what the chi-squared distribution looks like:


dx = randn(1,1e6);
dy = randn(1,1e6);
drSquared = dx .^ 2 + dy .^ 2;

mean(drSquared)
var(dx) + var(dy)

clf;
hist(drSquared,100);
title('Chi Squared Distribution (2 DOF), 1000000 Samples');

ans = 
    1.9982

ans = 
    1.9982




Auto Correlation - A Closer Look at the Data

Error creating thumbnail: File missing

The simulations so far have assumed that we are in the overdamped limit, or the inertia-less regime. This assumption makes generating simulated trajectories very easy - all you have to do is add up a bunch of properly distributed random numbers. Of course, just because something is convenient doesn't mean it's true.

There are many statistical tests for independence and normality. (My personal favorite is the Kolmogorov-Smirnov test – but never before 5:00 PM.) Auto and cross correlation are a good place to start testing for independence. Autocorrelation looks for a relationship between a variable and its past or future values. Cross correlation looks for a relationship between two variables. Matlab has a built in function to compute auto and cross correlations called xcorr.

By construction, the simulated displacements are independent. The change in position at one time should exhibit no relationship at all to the change at any other time. This can be verified with xcorr. If x is a vector, xcorr(x) returns the correlation of x with itself for all possible offsets. The length of the resulting autocorrelation sequence is 2N+1. The middle value always stands out because x correlates perfectly with itself when there is no offset. Specifying the option 'coeff' causes the xcorr function to normalize this value to exactly 1 --perfect correlation.

Also notice that the autocorrelation sequence is symmetric about the origin.

clf;
c = xcorr(particle{1}.dx, 'coeff');
xaxis = (1-length(c))/2:1:(length(c)-1)/2;

plot(xaxis, c);
xlabel('Lag');
ylabel('Correlation');
title('Particle 1 x-axis Displacement Autocorrelation');



Cross Correlation

Error creating thumbnail: File missing

With two vector arguments, xcorr(x,y) returns a cross correlation matrix. The cross correlation can be used to test the relationship (or lack thereof) between one particle's trajectory and another's. If two particles move independently, the cross correlations should be very small. The code below computes the cross correlation between the x displacements of particle simulations number 1 and 2.

clf;
c = xcorr(particle{1}.dx, particle{2}.dx, 'coeff');
xaxis = (1-length(c))/2:1:(length(c)-1)/2;
plot(xaxis, c);
xlabel('Lag');
ylabel('Correlation');
Title('Particle 1, 2 x-axis Displacement Cross Correlation');



MATLAB Tricks

Error creating thumbnail: File missing

Matlab can generate (and plot) an amazing amount of data. For example, the xcorr function can compute the auto and cross correlations of a large set of data values. If A is an MxN matrix, xcorr(A) returns a size 2*M-1 x N^2 matrix whose columns contain the cross-correlation sequences for all combinations of the columns of A. The football shape of the data is a result of the way that the data is windowed when computing the correlation.


% create an array whose columns contain the dx values for each particle

for i = 1:particleCount
    allDx(:,i) = particle{i}.dx';
end

% compute all possible auto and cross correlations

c = xcorr(allDx, 'coeff');

% plot the results
clf;
hold on;
for i=1:size(c,1)
    plot(xaxis, c(:,i),'color',rand(1,3));
end
hold off;

xlabel('Lag');
ylabel('Correlation Coefficient');
title('All Possible Auto and Cross Correlations in the x Dimension');



A Correlated Trajectory

Error creating thumbnail: File missing

So what does the autocorrelation sequence look like for a trajectory that is not generated from independent samples? In the following example, the displacement at each time interval depends in part on the displacement in the last interval plus a random number. The autocorrelation is not nearly as sharp as the one generated by independent random samples.

x     = zeros(1,N);
c     = 0.80;           % degree of correlation; 0 to 1
step  = randn(1,N);
x(2) = randn();

for t=2:N
     x(t) = (c * x(t-1)) + ((1-c)*step(t));
end;

clf;
plot(xaxis, xcorr(x, 'coeff'));

xlabel('Lag');
ylabel('Correlation Coefficient');
title('Autocorrelation');



Additional Resources