scipy.stats.skellam

scipy.stats.skellam = <scipy.stats.distributions.skellam_gen object at 0x4605090>[source]

A Skellam discrete random variable.

Discrete random variables are defined from a standard form and may require some shape parameters to complete its specification. Any optional keyword parameters can be passed to the methods of the RV object as given below:

Parameters :

x : array_like

quantiles

q : array_like

lower or upper tail probability

mu1,mu2 : array_like

shape parameters

loc : array_like, optional

location parameter (default=0)

scale : array_like, optional

scale parameter (default=1)

size : int or tuple of ints, optional

shape of random variates (default computed from input arguments )

moments : str, optional

composed of letters [‘mvsk’] specifying which moments to compute where ‘m’ = mean, ‘v’ = variance, ‘s’ = (Fisher’s) skew and ‘k’ = (Fisher’s) kurtosis. (default=’mv’)

Alternatively, the object may be called (as a function) to fix the shape and :

location parameters returning a “frozen” discrete RV object: :

rv = skellam(mu1,mu2, loc=0) :

  • Frozen RV object with the same methods but holding the given shape and location fixed.

Notes

Probability distribution of the difference of two correlated or uncorrelated Poisson random variables.

Let k1 and k2 be two Poisson-distributed r.v. with expected values lam1 and lam2. Then, k1 - k2 follows a Skellam distribution with parameters mu1 = lam1 - rho*sqrt(lam1*lam2) and mu2 = lam2 - rho*sqrt(lam1*lam2), where rho is the correlation coefficient between k1 and k2. If the two Poisson-distributed r.v. are independent then rho = 0.

Parameters mu1 and mu2 must be strictly positive.

For details see: http://en.wikipedia.org/wiki/Skellam_distribution

skellam takes mu1 and mu2 as shape parameters.

Examples

>>> from scipy.stats import skellam
>>> [ mu1,mu2 ] = [<Replace with reasonable values>]
>>> rv = skellam(mu1,mu2)

Display frozen pmf

>>> x = np.arange(0, np.minimum(rv.dist.b, 3))
>>> h = plt.vlines(x, 0, rv.pmf(x), lw=2)

Here, rv.dist.b is the right endpoint of the support of rv.dist.

Check accuracy of cdf and ppf

>>> prb = skellam.cdf(x, mu1,mu2)
>>> h = plt.semilogy(np.abs(x - skellam.ppf(prb, mu1,mu2)) + 1e-20)

Random number generation

>>> R = skellam.rvs(mu1,mu2, size=100)

Methods

rvs(mu1,mu2, loc=0, size=1) Random variates.
pmf(x, mu1,mu2, loc=0) Probability mass function.
logpmf(x, mu1,mu2, loc=0) Log of the probability mass function.
cdf(x, mu1,mu2, loc=0) Cumulative density function.
logcdf(x, mu1,mu2, loc=0) Log of the cumulative density function.
sf(x, mu1,mu2, loc=0) Survival function (1-cdf — sometimes more accurate).
logsf(x, mu1,mu2, loc=0) Log of the survival function.
ppf(q, mu1,mu2, loc=0) Percent point function (inverse of cdf — percentiles).
isf(q, mu1,mu2, loc=0) Inverse survival function (inverse of sf).
stats(mu1,mu2, loc=0, moments=’mv’) Mean(‘m’), variance(‘v’), skew(‘s’), and/or kurtosis(‘k’).
entropy(mu1,mu2, loc=0) (Differential) entropy of the RV.
expect(func, mu1,mu2, loc=0, lb=None, ub=None, conditional=False) Expected value of a function (of one argument) with respect to the distribution.
median(mu1,mu2, loc=0) Median of the distribution.
mean(mu1,mu2, loc=0) Mean of the distribution.
var(mu1,mu2, loc=0) Variance of the distribution.
std(mu1,mu2, loc=0) Standard deviation of the distribution.
interval(alpha, mu1,mu2, loc=0) Endpoints of the range that contains alpha percent of the distribution

Previous topic

scipy.stats.randint

Next topic

scipy.stats.zipf