SciPy

scipy.stats.rv_discrete

class scipy.stats.rv_discrete(a=0, b=inf, name=None, badvalue=None, moment_tol=1e-08, values=None, inc=1, longname=None, shapes=None, extradoc=None, seed=None)[source]

A generic discrete random variable class meant for subclassing.

rv_discrete is a base class to construct specific distribution classes and instances for discrete random variables. It can also be used to construct an arbitrary distribution defined by a list of support points and corresponding probabilities.

Parameters
afloat, optional

Lower bound of the support of the distribution, default: 0

bfloat, optional

Upper bound of the support of the distribution, default: plus infinity

moment_tolfloat, optional

The tolerance for the generic calculation of moments.

valuestuple of two array_like, optional

(xk, pk) where xk are integers and pk are the non-zero probabilities between 0 and 1 with sum(pk) = 1. xk and pk must have the same shape.

incinteger, optional

Increment for the support of the distribution. Default is 1. (other values have not been tested)

badvaluefloat, optional

The value in a result arrays that indicates a value that for which some argument restriction is violated, default is np.nan.

namestr, optional

The name of the instance. This string is used to construct the default example for distributions.

longnamestr, optional

This string is used as part of the first line of the docstring returned when a subclass has no docstring of its own. Note: longname exists for backwards compatibility, do not use for new subclasses.

shapesstr, optional

The shape of the distribution. For example “m, n” for a distribution that takes two integers as the two shape arguments for all its methods If not provided, shape parameters will be inferred from the signatures of the private methods, _pmf and _cdf of the instance.

extradocstr, optional

This string is used as the last part of the docstring returned when a subclass has no docstring of its own. Note: extradoc exists for backwards compatibility, do not use for new subclasses.

seed{None, int, RandomState, Generator}, optional

This parameter defines the object to use for drawing random variates. If seed is None the RandomState singleton is used. If seed is an int, a new RandomState instance is used, seeded with seed. If seed is already a RandomState or Generator instance, then that object is used. Default is None.

Notes

This class is similar to rv_continuous. Whether a shape parameter is valid is decided by an _argcheck method (which defaults to checking that its arguments are strictly positive.) The main differences are:

  • the support of the distribution is a set of integers

  • instead of the probability density function, pdf (and the corresponding private _pdf), this class defines the probability mass function, pmf (and the corresponding private _pmf.)

  • scale parameter is not defined.

To create a new discrete distribution, we would do the following:

>>> from scipy.stats import rv_discrete
>>> class poisson_gen(rv_discrete):
...     "Poisson distribution"
...     def _pmf(self, k, mu):
...         return exp(-mu) * mu**k / factorial(k)

and create an instance:

>>> poisson = poisson_gen(name="poisson")

Note that above we defined the Poisson distribution in the standard form. Shifting the distribution can be done by providing the loc parameter to the methods of the instance. For example, poisson.pmf(x, mu, loc) delegates the work to poisson._pmf(x-loc, mu).

Discrete distributions from a list of probabilities

Alternatively, you can construct an arbitrary discrete rv defined on a finite set of values xk with Prob{X=xk} = pk by using the values keyword argument to the rv_discrete constructor.

Examples

Custom made discrete distribution:

>>> from scipy import stats
>>> xk = np.arange(7)
>>> pk = (0.1, 0.2, 0.3, 0.1, 0.1, 0.0, 0.2)
>>> custm = stats.rv_discrete(name='custm', values=(xk, pk))
>>>
>>> import matplotlib.pyplot as plt
>>> fig, ax = plt.subplots(1, 1)
>>> ax.plot(xk, custm.pmf(xk), 'ro', ms=12, mec='r')
>>> ax.vlines(xk, 0, custm.pmf(xk), colors='r', lw=4)
>>> plt.show()
../_images/scipy-stats-rv_discrete-1_00_00.png

Random number generation:

>>> R = custm.rvs(size=100)
Attributes
random_state

Get or set the RandomState object for generating random variates.

Methods

rvs(self, *args, **kwargs)

Random variates of given type.

pmf(self, k, *args, **kwds)

Probability mass function at k of the given RV.

logpmf(self, k, *args, **kwds)

Log of the probability mass function at k of the given RV.

cdf(self, k, *args, **kwds)

Cumulative distribution function of the given RV.

logcdf(self, k, *args, **kwds)

Log of the cumulative distribution function at k of the given RV.

sf(self, k, *args, **kwds)

Survival function (1 - cdf) at k of the given RV.

logsf(self, k, *args, **kwds)

Log of the survival function of the given RV.

ppf(self, q, *args, **kwds)

Percent point function (inverse of cdf) at q of the given RV.

isf(self, q, *args, **kwds)

Inverse survival function (inverse of sf) at q of the given RV.

moment(self, n, *args, **kwds)

n-th order non-central moment of distribution.

stats(self, *args, **kwds)

Some statistics of the given RV.

entropy(self, *args, **kwds)

Differential entropy of the RV.

expect(self[, func, args, loc, lb, ub, …])

Calculate expected value of a function with respect to the distribution for discrete distribution by numerical summation.

median(self, *args, **kwds)

Median of the distribution.

mean(self, *args, **kwds)

Mean of the distribution.

std(self, *args, **kwds)

Standard deviation of the distribution.

var(self, *args, **kwds)

Variance of the distribution.

interval(self, alpha, *args, **kwds)

Confidence interval with equal areas around the median.

__call__(self, *args, **kwds)

Freeze the distribution for the given arguments.

support(self, *args, **kwargs)

Return the support of the distribution.

Previous topic

scipy.stats.rv_continuous.support

Next topic

scipy.stats.rv_discrete.rvs