将 R 中的 pnbinom() 映射到 SciPy 中的 scipy.stats.nbinom.pmf(k, n, p, loc=0)
Mapping pnbinom() in R to scipy.stats.nbinom.pmf(k, n, p, loc=0) in SciPy
我很难理解 pnbinom(q, size, prob, mu, lower.tail = TRUE, log.p = FALSE)
in R to the scipy.stats.nbinom.pmf(k, n, p, loc=0) in SciPy。
对于R函数,参数定义如下
q =vector of quantiles.
size = target for number of successful trials, or dispersion parameter (the shape parameter of the gamma mixing distribution). Must be strictly positive, need not be integer.
prob =probability of success in each trial. 0 < prob <= 1.
mu = alternative parametrization via mean: see ‘Details’.
log, log.p =logical; if TRUE, probabilities p are given as log(p).
lower.tail = logical; if TRUE (default), probabilities are P[X ≤ x], otherwise, P[X > x].
对于SciPy函数,参数定义如下。
n is the number of successes
p is the probability of a single success.
例如,如果
k=20
a=1.2
p=0.1
在 R 中,pnbinom(k,a,p) = 0.8518848
。这里,k
代入 q
即分位数向量,a
代入 size
,p
代入 'prob'。
另一方面,在 SciPy 中,我假设 n
用作 size
,p
用作 prob
R. 在该设置中,nbinom.pmf(k, a, p) = 0.01530062999480606
.
任何人都可以帮助确定我缺少什么吗?
nbinom.pmf(k, a, p)
returns pmf(概率质量函数),而 pnbinom(k, a, p)
是 cdf(累积分布函数)。
尝试 nbinom.cdf(k, a, p)
从 scipy 获取 cdf,或 dnbinom(k, a, p)
在 R 中获取 pmf。
我很难理解 pnbinom(q, size, prob, mu, lower.tail = TRUE, log.p = FALSE)
in R to the scipy.stats.nbinom.pmf(k, n, p, loc=0) in SciPy。
对于R函数,参数定义如下
q =vector of quantiles.
size = target for number of successful trials, or dispersion parameter (the shape parameter of the gamma mixing distribution). Must be strictly positive, need not be integer.
prob =probability of success in each trial. 0 < prob <= 1.
mu = alternative parametrization via mean: see ‘Details’.
log, log.p =logical; if TRUE, probabilities p are given as log(p).
lower.tail = logical; if TRUE (default), probabilities are P[X ≤ x], otherwise, P[X > x].
对于SciPy函数,参数定义如下。
n is the number of successes
p is the probability of a single success.
例如,如果
k=20
a=1.2
p=0.1
在 R 中,pnbinom(k,a,p) = 0.8518848
。这里,k
代入 q
即分位数向量,a
代入 size
,p
代入 'prob'。
另一方面,在 SciPy 中,我假设 n
用作 size
,p
用作 prob
R. 在该设置中,nbinom.pmf(k, a, p) = 0.01530062999480606
.
任何人都可以帮助确定我缺少什么吗?
nbinom.pmf(k, a, p)
returns pmf(概率质量函数),而 pnbinom(k, a, p)
是 cdf(累积分布函数)。
尝试 nbinom.cdf(k, a, p)
从 scipy 获取 cdf,或 dnbinom(k, a, p)
在 R 中获取 pmf。