Ratio distribution

From HandWiki
Short description: Probability distribution

A ratio distribution (also known as a quotient distribution) is a probability distribution constructed as the distribution of the ratio of random variables having two other known distributions. Given two (usually independent) random variables X and Y, the distribution of the random variable Z that is formed as the ratio Z = X/Y is a ratio distribution.

An example is the Cauchy distribution (also called the normal ratio distribution), which comes about as the ratio of two normally distributed variables with zero mean. Two other distributions often used in test-statistics are also ratio distributions: the t-distribution arises from a Gaussian random variable divided by an independent chi-distributed random variable, while the F-distribution originates from the ratio of two independent chi-squared distributed random variables. More general ratio distributions have been considered in the literature.[1][2][3][4][5][6][7][8][9]

Often the ratio distributions are heavy-tailed, and it may be difficult to work with such distributions and develop an associated statistical test. A method based on the median has been suggested as a "work-around".[10]

Algebra of random variables

Main page: Algebra of random variables

The ratio is one type of algebra for random variables: Related to the ratio distribution are the product distribution, sum distribution and difference distribution. More generally, one may talk of combinations of sums, differences, products and ratios. Many of these distributions are described in Melvin D. Springer's book from 1979 The Algebra of Random Variables.[8]

The algebraic rules known with ordinary numbers do not apply for the algebra of random variables. For example, if a product is C = AB and a ratio is D=C/A it does not necessarily mean that the distributions of D and B are the same. Indeed, a peculiar effect is seen for the Cauchy distribution: The product and the ratio of two independent Cauchy distributions (with the same scale parameter and the location parameter set to zero) will give the same distribution.[8] This becomes evident when regarding the Cauchy distribution as itself a ratio distribution of two Gaussian distributions of zero means: Consider two Cauchy random variables, C1 and C2 each constructed from two Gaussian distributions C1=G1/G2 and C2=G3/G4 then

C1C2=G1/G2G3/G4=G1G4G2G3=G1G2×G4G3=C1×C3,

where C3=G4/G3. The first term is the ratio of two Cauchy distributions while the last term is the product of two such distributions.

Derivation

A way of deriving the ratio distribution of Z=X/Y from the joint distribution of the two other random variables X , Y , with joint pdf pX,Y(x,y), is by integration of the following form[3]

pZ(z)=+|y|pX,Y(zy,y)dy.

If the two variables are independent then pXY(x,y)=pX(x)pY(y) and this becomes

pZ(z)=+|y|pX(zy)pY(y)dy.

This may not be straightforward. By way of example take the classical problem of the ratio of two standard Gaussian samples. The joint pdf is

pX,Y(x,y)=12πexp(x22)exp(y22)

Defining Z=X/Y we have

pZ(z)=12π|y|exp((zy)22)exp(y22)dy=12π|y|exp(y2(z2+1)2)dy

Using the known definite integral 0xexp(cx2)dx=12c we get

pZ(z)=1π(z2+1)

which is the Cauchy distribution, or Student's t distribution with n = 1

The Mellin transform has also been suggested for derivation of ratio distributions.[8]

In the case of positive independent variables, proceed as follows. The diagram shows a separable bivariate distribution fx,y(x,y)=fx(x)fy(y) which has support in the positive quadrant x,y>0 and we wish to find the pdf of the ratio R=X/Y. The hatched volume above the line y=x/R represents the cumulative distribution of the function fx,y(x,y) multiplied with the logical function X/YR. The density is first integrated in horizontal strips; the horizontal strip at height y extends from x = 0 to x = Ry and has incremental probability fy(y)dy0Ryfx(x)dx.
Secondly, integrating the horizontal strips upward over all y yields the volume of probability above the line

FR(R)=0fy(y)(0Ryfx(x)dx)dy

Finally, differentiate FR(R) with respect to R to get the pdf fR(R).

fR(R)=ddR[0fy(y)(0Ryfx(x)dx)dy]

Move the differentiation inside the integral:

fR(R)=0fy(y)(ddR0Ryfx(x)dx)dy

and since

ddR0Ryfx(x)dx=yfx(Ry)

then

fR(R)=0fy(y)fx(Ry)ydy

As an example, find the pdf of the ratio R when

fx(x)=αeαx,fy(y)=βeβy,x,y0
Evaluating the cumulative distribution of a ratio

We have

0Ryfx(x)dx=eαx|0Ry=1eαRy

thus

FR(R)=0fy(y)(1eαRy)dy=0βeβy(1eαRy)dy=1αRβ+αR=Rβα+R

Differentiation wrt. R yields the pdf of R

fR(R)=ddR(Rβα+R)=βα(βα+R)2

Moments of random ratios

From Mellin transform theory, for distributions existing only on the positive half-line x0, we have the product identity E[(UV)p]=E[Up]E[Vp] provided U,V are independent. For the case of a ratio of samples like E[(X/Y)p], in order to make use of this identity it is necessary to use moments of the inverse distribution. Set 1/Y=Z such that E[(XZ)p]=E[Xp]E[Yp]. Thus, if the moments of Xp and Yp can be determined separately, then the moments of X/Y can be found. The moments of Yp are determined from the inverse pdf of Y , often a tractable exercise. At simplest, E[Yp]=0ypfy(y)dy.

To illustrate, let X be sampled from a standard Gamma distribution

xα1ex/Γ(α) whose p-th moment is Γ(α+p)/Γ(α).

Z=Y1is sampled from an inverse Gamma distribution with parameter β and has pdf Γ1(β)z1+βe1/z. The moments of this pdf are

E[Zp]=E[Yp]=Γ(βp)Γ(β),p<β.

Multiplying the corresponding moments gives

E[(X/Y)p]=E[Xp]E[Yp]=Γ(α+p)Γ(α)Γ(βp)Γ(β),p<β.

Independently, it is known that the ratio of the two Gamma samples R=X/Y follows the Beta Prime distribution:

fβ(r,α,β)=B(α,β)1rα1(1+r)(α+β) whose moments are E[Rp]=B(α+p,βp)B(α,β)

Substituting B(α,β)=Γ(α)Γ(β)Γ(α+β) we have E[Rp]=Γ(α+p)Γ(βp)Γ(α+β)/Γ(α)Γ(β)Γ(α+β)=Γ(α+p)Γ(βp)Γ(α)Γ(β) which is consistent with the product of moments above.

Means and variances of random ratios

In the Product distribution section, and derived from Mellin transform theory (see section above), it is found that the mean of a product of independent variables is equal to the product of their means. In the case of ratios, we have

E(X/Y)=E(X)E(1/Y)

which, in terms of probability distributions, is equivalent to

E(X/Y)=xfx(x)dx×y1fy(y)dy

Note that E(1/Y)1E(Y) i.e., y1fy(y)dy1yfy(y)dy

The variance of a ratio of independent variables is

Var(X/Y)=E([X/Y]2)E2(X/Y)=E(X2)E(1/Y2)E2(X)E2(1/Y)

Normal ratio distributions

Uncorrelated central normal ratio

When X and Y are independent and have a Gaussian distribution with zero mean, the form of their ratio distribution is a Cauchy distribution. This can be derived by setting Z=X/Y=tanθ then showing that θ has circular symmetry. For a bivariate uncorrelated Gaussian distribution we have

p(x,y)=12πe12x2×12πe12y2=12πe12(x2+y2)=12πe12r2 with r2=x2+y2

If p(x,y) is a function only of r then θ is uniformly distributed on [0,2π] with density 1/2π so the problem reduces to finding the probability distribution of Z under the mapping

Z=X/Y=tanθ

We have, by conservation of probability

pz(z)|dz|=pθ(θ)|dθ|

and since dz/dθ=1/cos2θ

pz(z)=pθ(θ)|dz/dθ|=12πcos2θ

and setting cos2θ=11+(tanθ)2=11+z2 we get

pz(z)=1/2π1+z2

There is a spurious factor of 2 here. Actually, two values of θ spaced by π map onto the same value of z, the density is doubled, and the final result is

pz(z)=1/π1+z2,<z<

When either of the two Normal distributions is non-central then the result for the distribution of the ratio is much more complicated and is given below in the succinct form presented by David Hinkley.[6] The trigonometric method for a ratio does however extend to radial distributions like bivariate normals or a bivariate Student t in which the density depends only on radius r=x2+y2. It does not extend to the ratio of two independent Student t distributions which give the Cauchy ratio shown in a section below for one degree of freedom.

Uncorrelated noncentral normal ratio

In the absence of correlation (cor(X,Y)=0), the probability density function of the two normal variables X = N(μX, σX2) and Y = N(μY, σY2) ratio Z = X/Y is given exactly by the following expression, derived in several sources:[6]

pZ(z)=b(z)d(z)a3(z)12πσxσy[Φ(b(z)a(z))Φ(b(z)a(z))]+1a2(z)πσxσyec2

where

a(z)=1σx2z2+1σy2
b(z)=μxσx2z+μyσy2
c=μx2σx2+μy2σy2
d(z)=eb2(z)ca2(z)2a2(z)

and Φ is the normal cumulative distribution function:

Φ(t)=t12πe12u2 du.
  • Under several assumptions (usually fulfilled in practical applications), it is possible to derive a highly accurate solid approximation to the PDF. Main benefits are reduced formulae complexity, closed-form CDF, simple defined median, well defined error management, etc... For the sake of simplicity let's introduce parameters: p=μx2σx, q=μy2σy and r=μxμy. Then so called solid approximation pZ(z) to the uncorrelated noncentral normal ratio PDF is expressed by equation [11]
pZ(z)=1πperf[q]1r1+p2q2zr(1+p2q2[zr]2)32ep2(zr1)21+p2q2[zr]2
  • Under certain conditions, a normal approximation is possible, with variance:[12]
σz2=μx2μy2(σx2μx2+σy2μy2)

Correlated central normal ratio

The above expression becomes more complicated when the variables X and Y are correlated. If μx=μy=0 but σXσY and ρ0 the more general Cauchy distribution is obtained

pZ(z)=1πβ(zα)2+β2,

where ρ is the correlation coefficient between X and Y and

α=ρσxσy,
β=σxσy1ρ2.

The complex distribution has also been expressed with Kummer's confluent hypergeometric function or the Hermite function.[9]

Correlated noncentral normal ratio

This was shown in Springer 1979 problem 4.28.

A transformation to the log domain was suggested by Katz(1978) (see binomial section below). Let the ratio be

Tμx+(0,σx2)μy+(0,σy2)=μx+Xμy+Y=μxμy1+Xμx1+Yμy.

Take logs to get

loge(T)=loge(μxμy)+loge(1+Xμx)loge(1+Yμy).

Since loge(1+δ)=δδ22+δ33+ then asymptotically

loge(T)loge(μxμy)+XμxYμyloge(μxμy)+(0,σx2μx2+σy2μy2).

Alternatively, Geary (1930) suggested that

tμyTμxσy2T22ρσxσyT+σx2

has approximately a standard Gaussian distribution:[1] This transformation has been called the Geary–Hinkley transformation;[7] the approximation is good if Y is unlikely to assume negative values, basically μy>3σy.

Exact correlated noncentral normal ratio

This is developed by Dale (Springer 1979 problem 4.28) and Hinkley 1969. Geary showed how the correlated ratio z could be transformed into a near-Gaussian form and developed an approximation for t dependent on the probability of negative denominator values x+μx<0 being vanishingly small. Fieller's later correlated ratio analysis is exact but care is needed when combining modern math packages with verbal conditions in the older literature. Pham-Ghia has exhaustively discussed these methods. Hinkley's correlated results are exact but it is shown below that the correlated ratio condition can also be transformed into an uncorrelated one so only the simplified Hinkley equations above are required, not the full correlated ratio version.

Let the ratio be:

z=x+μxy+μy

in which x,y are zero-mean correlated normal variables with variances σx2,σy2 and X,Y have means μx,μy. Write x=xρyσx/σy such that x,y become uncorrelated and x has standard deviation

σx=σx1ρ2.

The ratio:

z=x+ρyσx/σy+μxy+μy

is invariant under this transformation and retains the same pdf. The y term in the numerator appears to be made separable by expanding:

x+ρyσx/σy+μx=x+μxρμyσxσy+ρ(y+μy)σxσy

to get

z=x+μxy+μy+ρσxσy

in which μ'x=μxρμyσxσy and z has now become a ratio of uncorrelated non-central normal samples with an invariant z-offset (this is not formally proven, though appears to have been used by Geary),

Finally, to be explicit, the pdf of the ratio z for correlated variables is found by inputting the modified parameters σx,μx,σy,μy and ρ=0 into the Hinkley equation above which returns the pdf for the correlated ratio with a constant offset ρσxσy on z.

Contours of the correlated bivariate Gaussian distribution (not to scale) giving ratio x/y
pdf of probability distribution ratio z
pdf of the Gaussian ratio z and a simulation (points) for
σx=σy=1,μx=0,μy=0.5,ρ=0.975

The figures above show an example of a positively correlated ratio with σx=σy=1,μx=0,μy=0.5,ρ=0.975 in which the shaded wedges represent the increment of area selected by given ratio x/y[r,r+δ] which accumulates probability where they overlap the distribution. The theoretical distribution, derived from the equations under discussion combined with Hinkley's equations, is highly consistent with a simulation result using 5,000 samples. In the top figure it is clear that for a ratio z=x/y1 the wedge has almost bypassed the main distribution mass altogether and this explains the local minimum in the theoretical pdf pZ(x/y). Conversely as x/y moves either toward or away from one the wedge spans more of the central mass, accumulating a higher probability.

Complex normal ratio

The ratio of correlated zero-mean circularly symmetric complex normal distributed variables was determined by Baxley et al.[13] and has since been extended to the nonzero-mean and nonsymmetric case.[14] In the correlated zero-mean case, the joint distribution of x, y is

fx,y(x,y)=1π2|Σ|exp([xy]HΣ1[xy])

where

Σ=[σx2ρσxσyρ*σxσyσy2],x=xr+ixi,y=yr+iyi

()H is an Hermitian transpose and

ρ=ρr+iρi=E(xy*σxσy)||1

The PDF of Z=X/Y is found to be

fz(zr,zi)=1|ρ|2πσx2σy2(|z|2σx2+1σy22ρrzrρiziσxσy)2=1|ρ|2πσx2σy2(|zσxρ*σy|2+1|ρ|2σy2)2

In the usual event that σx=σy we get

fz(zr,zi)=1|ρ|2π(|zρ*|2+1|ρ|2)2

Further closed-form results for the CDF are also given.

The ratio distribution of correlated complex variables, rho = 0.7 exp(i pi/4).

The graph shows the pdf of the ratio of two complex normal variables with a correlation coefficient of ρ=0.7exp(iπ/4). The pdf peak occurs at roughly the complex conjugate of a scaled down ρ.

Ratio of log-normal

The ratio of independent or correlated log-normals is log-normal. This follows, because if X1 and X2 are log-normally distributed, then ln(X1) and ln(X2) are normally distributed. If they are independent or their logarithms follow a bivarate normal distribution, then the logarithm of their ratio is the difference of independent or correlated normally distributed random variables, which is normally distributed.[note 1]

This is important for many applications requiring the ratio of random variables that must be positive, where joint distribution of X1 and X2 is adequately approximated by a log-normal. This is a common result of the multiplicative central limit theorem, also known as Gibrat's law, when Xi is the result of an accumulation of many small percentage changes and must be positive and approximately log-normally distributed.[15]

Uniform ratio distribution

With two independent random variables following a uniform distribution, e.g.,

pX(x)={10<x<10otherwise

the ratio distribution becomes

pZ(z)={1/20<z<112z2z10otherwise

Cauchy ratio distribution

If two independent random variables, X and Y each follow a Cauchy distribution with median equal to zero and shape factor a

pX(x|a)=aπ(a2+x2)

then the ratio distribution for the random variable Z=X/Y is[16]

pZ(z|a)=1π2(z21)ln(z2).

This distribution does not depend on a and the result stated by Springer[8] (p158 Question 4.6) is not correct. The ratio distribution is similar to but not the same as the product distribution of the random variable W=XY:

pW(w|a)=a2π2(w2a4)ln(w2a4).[8]

More generally, if two independent random variables X and Y each follow a Cauchy distribution with median equal to zero and shape factor a and b respectively, then:

  1. The ratio distribution for the random variable Z=X/Y is[16] pZ(z|a,b)=abπ2(b2z2a2)ln(b2z2a2).
  2. The product distribution for the random variable W=XY is[16] pW(w|a,b)=abπ2(w2a2b2)ln(w2a2b2).

The result for the ratio distribution can be obtained from the product distribution by replacing b with 1b.

Ratio of standard normal to standard uniform

Main page: Slash distribution

If X has a standard normal distribution and Y has a standard uniform distribution, then Z = X / Y has a distribution known as the slash distribution, with probability density function

pZ(z)={[φ(0)φ(z)]/z2z0φ(0)/2z=0,

where φ(z) is the probability density function of the standard normal distribution.[17]

Chi-squared, Gamma, Beta distributions

Let G be a normal(0,1) distribution, Y and Z be chi-squared distributions with m and n degrees of freedom respectively, all independent, with fχ(x,k)=xk21ex/22k/2Γ(k/2). Then

GY/mtm the Student's t distribution
Y/mZ/n=Fm,n i.e. Fisher's F-test distribution
YY+Zβ(m2,n2) the beta distribution
YZβ(m2,n2) the standard beta prime distribution

If V1χk12(λ), a noncentral chi-squared distribution, and V2χk22(0) and V1 is independent of V2 then

V1/k1V2/k2F'k1,k2(λ), a noncentral F-distribution.

mnF'm,n=β(m2,n2) or F'm,n=β(m2,n2,1,nm) defines F'm,n, Fisher's F density distribution, the PDF of the ratio of two Chi-squares with m, n degrees of freedom.

The CDF of the Fisher density, found in F-tables is defined in the beta prime distribution article. If we enter an F-test table with m = 3, n = 4 and 5% probability in the right tail, the critical value is found to be 6.59. This coincides with the integral

F3,4(6.59)=6.59β(x;m2,n2,1,nm)dx=0.05

For gamma distributions U and V with arbitrary shape parameters α1 and α2 and their scale parameters both set to unity, that is, UΓ(α1,1),VΓ(α2,1), where Γ(x;α,1)=xα1exΓ(α), then

UU+Vβ(α1,α2), expectation =α1α1+α2
UVβ(α1,α2), expectation =α1α21,α2>1
VUβ(α2,α1), expectation =α2α11,α1>1

If UΓ(x;α,1), then θUΓ(x;α,θ)=xα1exθθkΓ(α). Note that here θ is a scale parameter, rather than a rate parameter.

If UΓ(α1,θ1),VΓ(α2,θ2), then by rescaling the θ parameter to unity we have

Uθ1Uθ1+Vθ2=θ2Uθ2U+θ1Vβ(α1,α2)
Uθ1Vθ2=θ2θ1UVβ(α1,α2)

Thus

UVβ(α1,α2,1,θ1θ2) and E[UV]=θ1θ2α1α21

in which β(α,β,p,q) represents the generalised beta prime distribution.

In the foregoing it is apparent that if Xβ(α1,α2,1,1)β(α1,α2) then θXβ(α1,α2,1,θ). More explicitly, since

β(x;α1,α2,1,R)=1Rβ(xR;α1,α2)

if UΓ(α1,θ1),VΓ(α2,θ2) then

UV1Rβ(xR;α1,α2)=(xR)α11(1+xR)α1+α21RB(α1,α2),x0

where

R=θ1θ2,B(α1,α2)=Γ(α1)Γ(α2)Γ(α1+α2)

Rayleigh Distributions

If X, Y are independent samples from the Rayleigh distribution fr(r)=(r/σ2)er2/2σ2,r0, the ratio Z = X/Y follows the distribution[18]

fz(z)=2z(1+z2)2,z0

and has cdf

Fz(z)=111+z2=z21+z2,z0

The Rayleigh distribution has scaling as its only parameter. The distribution of Z=αX/Y follows

fz(z,α)=2αz(α+z2)2,z>0

and has cdf

Fz(z,α)=z2α+z2,z0

Fractional gamma distributions (including chi, chi-squared, exponential, Rayleigh and Weibull)

The generalized gamma distribution is

f(x;a,d,r)=rΓ(d/r)adxd1e(x/a)rx0;a,d,r>0

which includes the regular gamma, chi, chi-squared, exponential, Rayleigh, Nakagami and Weibull distributions involving fractional powers. Note that here a is a scale parameter, rather than a rate parameter; d is a shape parameter.

If Uf(x;a1,d1,r),Vf(x;a2,d2,r) are independent, and W=U/V
then[19] g(w)=r(a1a2)d2B(d1r,d2r)wd21(1+(a2a1)rwr)d1+d2r,w>0
where B(u,v)=Γ(u)Γ(v)Γ(u+v)

Modelling a mixture of different scaling factors

In the ratios above, Gamma samples, U, V may have differing sample sizes α1,α2 but must be drawn from the same distribution xα1exθθkΓ(α) with equal scaling θ.

In situations where U and V are differently scaled, a variables transformation allows the modified random ratio pdf to be determined. Let X=UU+V=11+B where UΓ(α1,θ),VΓ(α2,θ),θ arbitrary and, from above, XBeta(α1,α2),B=V/UBeta(α2,α1).

Rescale V arbitrarily, defining YUU+φV=11+φB,0φ

We have B=1XX and substitution into Y gives Y=Xφ+(1φ)X,dY/dX=φ(φ+(1φ)X)2

Transforming X to Y gives fY(Y)=fX(X)|dY/dX|=β(X,α1,α2)φ/[φ+(1φ)X]2

Noting X=φY1(1φ)Y we finally have

fY(Y,φ)=φ[1(1φ)Y]2β(φY1(1φ)Y,α1,α2),0Y1

Thus, if UΓ(α1,θ1) and VΓ(α2,θ2)
then Y=UU+V is distributed as fY(Y,φ) with φ=θ2θ1

The distribution of Y is limited here to the interval [0,1]. It can be generalized by scaling such that if YfY(Y,φ) then

ΘYfY(Y,φ,Θ)

where fY(Y,φ,Θ)=φ/Θ[1(1φ)Y/Θ]2β(φY/Θ1(1φ)Y/Θ,α1,α2),0YΘ

ΘY is then a sample from ΘUU+φV

Reciprocals of samples from beta distributions

Though not ratio distributions of two variables, the following identities for one variable are useful:

If Xβ(α,β) then 𝐱=X1Xβ(α,β)
If 𝐘β(α,β) then y=1𝐘β(β,α)

combining the latter two equations yields

If Xβ(α,β) then 𝐱=1X1β(β,α).
If 𝐘β(α,β) then y=𝐘1+𝐘β(α,β)

since 11+𝐘=𝐘1𝐘1+1β(β,α)

then

1+𝐘{β(β,α)}1, the distribution of the reciprocals of β(β,α) samples.

If UΓ(α,1),VΓ(β,1) then UVβ(α,β) and

U/V1+U/V=UV+Uβ(α,β)

Further results can be found in the Inverse distribution article.

  • If X,Y are independent exponential random variables with mean μ, then X − Y is a double exponential random variable with mean 0 and scale μ.

Binomial distribution

This result was first derived by Katz et al. in 1978.[20]

Suppose XBinomial(n,p1) and YBinomial(m,p2) and X, Y are independent. Let T=X/nY/m.

Then log(T) is approximately normally distributed with mean log(p1/p2) and variance (1/p1)1n+(1/p2)1m.

The binomial ratio distribution is of significance in clinical trials: if the distribution of T is known as above, the probability of a given ratio arising purely by chance can be estimated, i.e. a false positive trial. A number of papers compare the robustness of different approximations for the binomial ratio.[citation needed]

Poisson and truncated Poisson distributions

In the ratio of Poisson variables R = X/Y there is a problem that Y is zero with finite probability so R is undefined. To counter this, we consider the truncated, or censored, ratio R' = X/Y' where zero sample of Y are discounted. Moreover, in many medical-type surveys, there are systematic problems with the reliability of the zero samples of both X and Y and it may be good practice to ignore the zero samples anyway.

The probability of a null Poisson sample being eλ, the generic pdf of a left truncated Poisson distribution is

p~x(x;λ)=11eλeλλxx!,x1,2,3,

which sums to unity. Following Cohen,[21] for n independent trials, the multidimensional truncated pdf is

p~(x1,x2,,xn;λ)=1(1eλ)ni=1neλλxixi!,xi1,2,3,

and the log likelihood becomes

L=ln(p~)=nln(1eλ)nλ+ln(λ)1nxiln1n(xi!),xi1,2,3,

On differentiation we get

dL/dλ=n1eλ+1λi=1nxi

and setting to zero gives the maximum likelihood estimate λ^ML

λ^ML1eλ^ML=1ni=1nxi=x¯

Note that as λ^0 then x¯1 so the truncated maximum likelihood λ estimate, though correct for both truncated and untruncated distributions, gives a truncated mean x¯ value which is highly biassed relative to the untruncated one. Nevertheless it appears that x¯ is a sufficient statistic for λ since λ^ML depends on the data only through the sample mean x¯=1ni=1nxi in the previous equation which is consistent with the methodology of the conventional Poisson distribution.

Absent any closed form solutions, the following approximate reversion for truncated λ is valid over the whole range 0λ;1x¯.

λ^=x¯e(x¯1)0.07(x¯1)e0.666(x¯1)+ϵ,|ϵ|<0.006

which compares with the non-truncated version which is simply λ^=x¯. Taking the ratio R=λ^X/λ^Y is a valid operation even though λ^X may use a non-truncated model while λ^Y has a left-truncated one.

The asymptotic large-nλ variance of λ^ (and Cramér–Rao bound) is

𝕍𝕒𝕣(λ^)(𝔼[δ2Lδλ2]λ=λ^)1

in which substituting L gives

δ2Lδλ2=n[x¯λ2eλ(1eλ)2]

Then substituting x¯ from the equation above, we get Cohen's variance estimate

𝕍𝕒𝕣(λ^)λ^n(1eλ^)21(λ^+1)eλ^

The variance of the point estimate of the mean λ, on the basis of n trials, decreases asymptotically to zero as n increases to infinity. For small λ it diverges from the truncated pdf variance in Springael[22] for example, who quotes a variance of

𝕍𝕒𝕣(λ)=λ/n1eλ[1λeλ1eλ]

for n samples in the left-truncated pdf shown at the top of this section. Cohen showed that the variance of the estimate relative to the variance of the pdf, 𝕍𝕒𝕣(λ^)/𝕍𝕒𝕣(λ), ranges from 1 for large λ (100% efficient) up to 2 as λ approaches zero (50% efficient).

These mean and variance parameter estimates, together with parallel estimates for X, can be applied to Normal or Binomial approximations for the Poisson ratio. Samples from trials may not be a good fit for the Poisson process; a further discussion of Poisson truncation is by Dietz and Bohning[23] and there is a Zero-truncated Poisson distribution Wikipedia entry.

Double Lomax distribution

This distribution is the ratio of two Laplace distributions.[24] Let X and Y be standard Laplace identically distributed random variables and let z = X / Y. Then the probability distribution of z is

f(x)=12(1+|z|)2

Let the mean of the X and Y be a. Then the standard double Lomax distribution is symmetric around a.

This distribution has an infinite mean and variance.

If Z has a standard double Lomax distribution, then 1/Z also has a standard double Lomax distribution.

The standard Lomax distribution is unimodal and has heavier tails than the Laplace distribution.

For 0 < a < 1, the a-th moment exists.

E(Za)=Γ(1+a)Γ(1a)

where Γ is the gamma function.

Ratio distributions in multivariate analysis

Ratio distributions also appear in multivariate analysis.[25] If the random matrices X and Y follow a Wishart distribution then the ratio of the determinants

φ=|𝐗|/|𝐘|

is proportional to the product of independent F random variables. In the case where X and Y are from independent standardized Wishart distributions then the ratio

Λ=|𝐗|/|𝐗+𝐘|

has a Wilks' lambda distribution.

Ratios of Quadratic Forms involving Wishart Matrices

Probability distribution can be derived from random quadratic forms

r=VTAV

where V and/or A are random.[26] If A is the inverse of another matrix B then r=VTB1V is a random ratio in some sense, frequently arising in Least Squares estimation problems.

In the Gaussian case if A is a matrix drawn from a complex Wishart distribution AWC(A0,k,p) of dimensionality p x p and k degrees of freedom with kp while V is an arbitrary complex vector with Hermitian (conjugate) transpose (.)H, the ratio

r=kVHA01VVHA1V

follows the Gamma distribution

p1(r)=rkperΓ(kp+1),r0

The result arises in least squares adaptive Wiener filtering - see eqn(A13) of.[25] Note that the original article contends that the distribution is p1(r)=rkp1er/Γ(kp).

Similarly, for full-rank ( kp) zero-mean real-valued Wishart matrix samples WW(Σ,k,p), and V a random vector independent of W, the ratio

r=VTΣ1VVTW1Vχkp+12

This result is usually attributed to Muirhead (1982).[27]

Given complex Wishart matrix AWC(I,k,p), the ratio

ρ=(VHA1V)2VHA2VVHV

follows the Beta distribution (see eqn(47) of[28])

p2(ρ)=(1ρ)p2ρkp+1k!(k+1p)!(p2)!,0ρ1

The result arises in the performance analysis of constrained least squares filtering and derives from a more complex but ultimately equivalent ratio that if AWC(A0,n,p) then

ρ=(VHA1V)2VHA1A0A1VVHA01V

In its simplest form, if Ai,jWC(I,k,p) and Wi,j=(W1)i,j then the ratio of the (1,1) inverse element squared to the sum of modulus squares of the whole top row elements has distribution

ρ=(W1,1)2j1..p|W1,j|2β(p1,kp+2)

See also

Notes

  1. Note, however, that X1 and X2 can be individually log-normally distributed without having a bivariate log-normal distribution. As of 2022-06-08 the Wikipedia article on "Copula (probability theory)" includes a density and contour plot of two Normal marginals joint with a Gumbel copula, where the joint distribution is not bivariate normal.

References

  1. 1.0 1.1 Geary, R. C. (1930). "The Frequency Distribution of the Quotient of Two Normal Variates". Journal of the Royal Statistical Society 93 (3): 442–446. doi:10.2307/2342070. 
  2. Fieller, E. C. (November 1932). "The Distribution of the Index in a Normal Bivariate Population". Biometrika 24 (3/4): 428–440. doi:10.2307/2331976. 
  3. 3.0 3.1 Curtiss, J. H. (December 1941). "On the Distribution of the Quotient of Two Chance Variables". The Annals of Mathematical Statistics 12 (4): 409–421. doi:10.1214/aoms/1177731679. 
  4. George Marsaglia (April 1964). Ratios of Normal Variables and Ratios of Sums of Uniform Variables. Defense Technical Information Center.
  5. Marsaglia, George (March 1965). "Ratios of Normal Variables and Ratios of Sums of Uniform Variables". Journal of the American Statistical Association 60 (309): 193–204. doi:10.2307/2283145. http://www.dtic.mil/get-tr-doc/pdf?AD=AD0600972. 
  6. 6.0 6.1 6.2 Hinkley, D. V. (December 1969). "On the Ratio of Two Correlated Normal Random Variables". Biometrika 56 (3): 635–639. doi:10.2307/2334671. 
  7. 7.0 7.1 Hayya, Jack; Armstrong, Donald; Gressis, Nicolas (July 1975). "A Note on the Ratio of Two Normally Distributed Variables". Management Science 21 (11): 1338–1341. doi:10.1287/mnsc.21.11.1338. 
  8. 8.0 8.1 8.2 8.3 8.4 8.5 Springer, Melvin Dale (1979). The Algebra of Random Variables. John Wiley & Sons. ISBN 0-471-01406-0. https://archive.org/details/algebraofrandomv0000spri. 
  9. 9.0 9.1 Pham-Gia, T.; Turkkan, N.; Marchand, E. (2006). "Density of the Ratio of Two Normal Random Variables and Applications". Communications in Statistics – Theory and Methods (Taylor & Francis) 35 (9): 1569–1591. doi:10.1080/03610920600683689. 
  10. Brody, James P.; Williams, Brian A.; Wold, Barbara J.; Quake, Stephen R. (October 2002). Proc Natl Acad Sci U S A 99 (20): 12975–12978. doi:10.1073/pnas.162468199. PMID 12235357. PMC 130571. Bibcode2002PNAS...9912975B. http://authors.library.caltech.edu/685/1/BROpnas02.pdf. 
  11. Šimon, Ján; Ftorek, Branislav (2022-09-15). "Basic Statistical Properties of the Knot Efficiency". Symmetry (MDPI) 14 (9): 1926. doi:10.3390/sym14091926. ISSN 2073-8994. 
  12. Díaz-Francés, Eloísa; Rubio, Francisco J. (2012-01-24). "On the existence of a normal approximation to the distribution of the ratio of two independent normal random variables". Statistical Papers (Springer Science and Business Media LLC) 54 (2): 309–323. doi:10.1007/s00362-012-0429-2. ISSN 0932-5026. 
  13. Baxley, R T; Waldenhorst, B T; Acosta-Marum, G (2010). "Complex Gaussian Ratio Distribution with Applications for Error Rate Calculation in Fading Channels with Imperfect CSI". 2010 IEEE Global Telecommunications Conference GLOBECOM 2010. pp. 1–5. doi:10.1109/GLOCOM.2010.5683407. ISBN 978-1-4244-5636-9. https://www.researchgate.net/publication/224210655. 
  14. Sourisseau, M.; Wu, H.-T.; Zhou, Z. (October 2022). "Asymptotic analysis of synchrosqueezing transform—toward statistical inference with nonlinear-type time-frequency analysis". Annals of Statistics 50 (5): 2694-2712. doi:10.1214/22-AOS2203. https://projecteuclid.org/journals/annals-of-statistics/volume-50/issue-5/Asymptotic-analysis-of-synchrosqueezing-transformtoward-statistical-inference-with-nonlinear-type/10.1214/22-AOS2203.short?tab=ArticleLinkReference. 
  15. Of course, any invocation of a central limit theorem assumes suitable, commonly met regularity conditions, e.g., finite variance.
  16. 16.0 16.1 16.2 Kermond, John (2010). "An Introduction to the Algebra of Random Variables". Mathematical Association of Victoria 47th Annual Conference Proceedings – New Curriculum. New Opportunities (The Mathematical Association of Victoria): 1–16. ISBN 978-1-876949-50-1. 
  17. "SLAPPF". Statistical Engineering Division, National Institute of Science and Technology. http://www.itl.nist.gov/div898/software/dataplot/refman2/auxillar/slappf.htm. 
  18. Hamedani, G. G. (Oct 2013). "Characterizations of Distribution of Ratio of Rayleigh Random Variables". Pakistan Journal of Statistics 29 (4): 369–376. 
  19. Raja Rao, B.; Garg., M. L. (1969). "A note on the generalized (positive) Cauchy distribution". Canadian Mathematical Bulletin 12 (6): 865–868. doi:10.4153/CMB-1969-114-2. 
  20. Katz D. et al.(1978) Obtaining confidence intervals for the risk ratio in cohort studies. Biometrics 34:469–474
  21. Cohen, A Clifford (June 1960). "Estimating the Parameter in a Conditional Poisson Distribution". Biometrics 60 (2): 203–211. doi:10.2307/2527552. 
  22. Springael, Johan (2006). "On the sum of independent zero-truncated Poisson random variables". https://repository.uantwerpen.be/docman/irua/b66c5a/4743e891.pdf. 
  23. Dietz, Ekkehart; Bohning, Dankmar (2000). "On Estimation of the Poisson Parameter in Zero-Modified Poisson Models". Computational Statistics & Data Analysis 34 (4): 441–459. doi:10.1016/S0167-9473(99)00111-5. 
  24. Bindu P and Sangita K (2015) Double Lomax distribution and its applications. Statistica LXXV (3) 331–342
  25. 25.0 25.1 Brennan, L E; Reed, I S (January 1982). "An Adaptive Array Signal Processing Algorithm for Communications". IEEE Transactions on Aerospace and Electronic Systems AES-18 No 1: 124–130. doi:10.1109/TAES.1982.309212. Bibcode1982ITAES..18..124B. 
  26. Mathai, A M; Provost, L (1992). Quadratic Forms in Random Variables. New York: Mercel Decker Inc.. ISBN 0-8247-8691-2. https://www.researchgate.net/publication/224817325. 
  27. Muirhead, Robb (1982). Aspects of Multivariate Statistical Theory. USA: Wiley. pp. 96; Theorem 3.2.12. 
  28. Reed, I S; Mallett, J D; Brennan, L E (November 1974). "Rapid Convergence Rate in Adaptive Arrays". IEEE Transactions on Aerospace and Electronic Systems AES-10 No.6 (6): 853–863. doi:10.1109/TAES.1974.307893. Bibcode1974ITAES..10..853R.