L i=fddlmZddlmZddlmZddlZddlZddl m Z ddl Z ddl mZddlmZdd lmZdd lmZdd lmZmZmZdd lmZdd lmZddlmZmZ ddl!m"Z"ddl m#Z#gdZ$eddZ%e"e%dddd#Z.d$Z/d%Z0d&Z1d?d'Z2eGd(d)Z3d@d*Z4d+Z5d,Z6eGd-d.Z7dAd0Z8eGd1d2Z9dBd3Z:d4Z;d5Z<e"e)dde-"dCd6Z=Gd7d8Z>d9Z?d/d:d;Z@y)D) namedtuple) dataclass)combN) combinations)shgo) distributions)ConfidenceInterval)norm)gammakvgammaln)ifft)_a_ij_Aij_Dij2)_concordant_pairs_discordant_pairs)_axis_nan_policy_factory) _stats_py)epps_singleton_2sampcramervonmisessomersd barnard_exactboschloo_exactcramervonmises_2samp tukey_hsdpoisson_means_testEpps_Singleton_2sampResult statisticpvalue) n_samples too_smallctj|}t|t|}}|dks|dkrtd|d|dtj|j s tdtj|j s td||z}|j dkDrtd|j dtj|d jr td d d l m }|tj||fd z }tj|d |z }tjtj||ztj||zfj } tjtj||ztj||zfj } tj"| j d} tj"| j d} ||z | z||z | zz} tj$j'| }tj$j)|}|d t|zkrt+j,dd tj.| d tj.| d z }|tj0|j tj0||z}t3||dkrdd|dzzd|dz|dzzzzz }||z}t5j6|}t5j8||ddt}t;||S)a Compute the Epps-Singleton (ES) test statistic. Test the null hypothesis that two samples have the same underlying probability distribution. Parameters ---------- x, y : array-like The two samples of observations to be tested. Input must not have more than one dimension. Samples can have different lengths, but both must have at least five observations. t : array-like, optional The points (t1, ..., tn) where the empirical characteristic function is to be evaluated. It should be positive distinct numbers. The default value (0.4, 0.8) is proposed in [1]_. Input must not have more than one dimension. Returns ------- statistic : float The test statistic. pvalue : float The associated p-value based on the asymptotic chi2-distribution. See Also -------- ks_2samp, anderson_ksamp Notes ----- Testing whether two samples are generated by the same underlying distribution is a classical question in statistics. A widely used test is the Kolmogorov-Smirnov (KS) test which relies on the empirical distribution function. Epps and Singleton introduce a test based on the empirical characteristic function in [1]_. One advantage of the ES test compared to the KS test is that is does not assume a continuous distribution. In [1]_, the authors conclude that the test also has a higher power than the KS test in many examples. They recommend the use of the ES test for discrete samples as well as continuous samples with at least 25 observations each, whereas `anderson_ksamp` is recommended for smaller sample sizes in the continuous case. The p-value is computed from the asymptotic distribution of the test statistic which follows a `chi2` distribution. If the sample size of both `x` and `y` is below 25, the small sample correction proposed in [1]_ is applied to the test statistic. The default values of `t` are determined in [1]_ by considering various distributions and finding good values that lead to a high power of the test in general. Table III in [1]_ gives the optimal values for the distributions tested in that study. The values of `t` are scaled by the semi-interquartile range in the implementation, see [1]_. References ---------- .. [1] T. W. Epps and K. J. Singleton, "An omnibus test for the two-sample problem using the empirical characteristic function", Journal of Statistical Computation and Simulation 26, p. 177--203, 1986. .. [2] S. J. Goerg and J. Kaiser, "Nonparametric testing of distributions - the Epps-Singleton two-sample test using the empirical characteristic function", The Stata Journal 9(3), p. 454--465, 2009. z6x and y should have at least 5 elements, but len(x) = z and len(y) = .z$x must not contain nonfinite values.z$y must not contain nonfinite values.rz t must be 1d, but t.ndim equals rz&t must contain positive elements only.)iqrr!)rT)biaszEstimated covariance matrix does not have full rank. This indicates a bad choice of the input t and the test might not be consistent.) stacklevelaxis?gܿg333333$@g333333greaterF) alternative symmetricxp)npasarraylen ValueErrorisfiniteallndim less_equalany scipy.statsr(hstackreshapevstackcossinTcovlinalgpinv matrix_rankwarningswarnmeandotmaxr _SimpleChi2 _get_pvaluer)xytnxnynr(sigmatsgxgycov_xcov_yest_cov est_cov_invrg_diffwcorrchi2ps \/mnt/ssd/data/python-lab/Trading/venv/lib/python3.12/site-packages/scipy/stats/_hypotests.pyrrsJ 1 A VSVB QBF Tt167 7 ;;q>   ?@@ ;;q>   ?@@ RA vvz;AFF81EFF }}Q ABB  1a&! "Q &E Aw % 'B BFF2a4L"&&A,/ 0 2 2B BFF2a4L"&&A,/ 0 2 2B FF244d #E FF244d #EtUladE\)G))..)K k*A1SV8| 6"# $ WWRa 2772A#6 6F "&&266+v6 77A B bC!e*$tR$Z"t*-D'EEF 1H   #Da9RTUA %a ++ two-sided)diffr1c6t||||||||z||zz ||z||zz z }|dkrtjddS||dzz ||dzz z}||z ||z z |z tj|z }|||zz} ||z} t j jddg| \} } t j jddg| \} }tj| | dz}tj| |dzdddf}t j j|| }t j j|| }||z }||z }||z |z }||z ||z z}tjdd5|tj|z }ddd|d k(r,tjtj|k\}n|d k(r|k}n|k\}tj||z|}tj||S#1swY{xYw) a Performs the Poisson means test, AKA the "E-test". This is a test of the null hypothesis that the difference between means of two Poisson distributions is `diff`. The samples are provided as the number of events `k1` and `k2` observed within measurement intervals (e.g. of time, space, number of observations) of sizes `n1` and `n2`. Parameters ---------- k1 : int Number of events observed from distribution 1. n1: float Size of sample from distribution 1. k2 : int Number of events observed from distribution 2. n2 : float Size of sample from distribution 2. diff : float, default=0 The hypothesized difference in means between the distributions underlying the samples. alternative : {'two-sided', 'less', 'greater'}, optional Defines the alternative hypothesis. The following options are available (default is 'two-sided'): * 'two-sided': the difference between distribution means is not equal to `diff` * 'less': the difference between distribution means is less than `diff` * 'greater': the difference between distribution means is greater than `diff` Returns ------- statistic : float The test statistic (see [1]_ equation 3.3). pvalue : float The probability of achieving such an extreme value of the test statistic under the null hypothesis. Notes ----- Let: .. math:: X_1 \sim \mbox{Poisson}(\mathtt{n1}\lambda_1) be a random variable independent of .. math:: X_2 \sim \mbox{Poisson}(\mathtt{n2}\lambda_2) and let ``k1`` and ``k2`` be the observed values of :math:`X_1` and :math:`X_2`, respectively. Then `poisson_means_test` uses the number of observed events ``k1`` and ``k2`` from samples of size ``n1`` and ``n2``, respectively, to test the null hypothesis that .. math:: H_0: \lambda_1 - \lambda_2 = \mathtt{diff} A benefit of the E-test is that it has good power for small sample sizes, which can reduce sampling costs [1]_. It has been evaluated and determined to be more powerful than the comparable C-test, sometimes referred to as the Poisson exact test. References ---------- .. [1] Krishnamoorthy, K., & Thomson, J. (2004). A more powerful test for comparing two Poisson means. Journal of Statistical Planning and Inference, 119(1), 23-35. .. [2] Przyborowski, J., & Wilenski, H. (1940). Homogeneity of results in testing samples from Poisson series: With an application to testing clover seed for dodder. Biometrika, 31(3/4), 313-323. Examples -------- Suppose that a gardener wishes to test the number of dodder (weed) seeds in a sack of clover seeds that they buy from a seed company. It has previously been established that the number of dodder seeds in clover follows the Poisson distribution. A 100 gram sample is drawn from the sack before being shipped to the gardener. The sample is analyzed, and it is found to contain no dodder seeds; that is, `k1` is 0. However, upon arrival, the gardener draws another 100 gram sample from the sack. This time, three dodder seeds are found in the sample; that is, `k2` is 3. The gardener would like to know if the difference is significant and not due to chance. The null hypothesis is that the difference between the two samples is merely due to chance, or that :math:`\lambda_1 - \lambda_2 = \mathtt{diff}` where :math:`\mathtt{diff} = 0`. The alternative hypothesis is that the difference is not due to chance, or :math:`\lambda_1 - \lambda_2 \ne 0`. The gardener selects a significance level of 5% to reject the null hypothesis in favor of the alternative [2]_. >>> import scipy.stats as stats >>> res = stats.poisson_means_test(0, 100, 3, 100) >>> res.statistic, res.pvalue (-1.7320508075688772, 0.08837900929018157) The p-value is .088, indicating a near 9% chance of observing a value of the test statistic under the null hypothesis. This exceeds 5%, so the gardener does not reject the null hypothesis as the difference cannot be regarded as significant at this level. rrr!g|=g?Nignore)invaliddividereless) _poisson_means_test_ivrSignificanceResultr4sqrtr poissonppfarangepmferrstateabssum)k1n1k2n2rfr1 lmbd_hat2vart_k1k2 nlmbd_hat1 nlmbd_hat2x1_lbx1_ubx2_lbx2_ubx1x2prob_x1prob_x2lmbd_x1lmbd_x2 lmbds_diffvar_x1x2t_x1x2 indicatorr s rcrrs8V2r2r4=r'b2g&b2g)>>I A~++Aq11 a.2q> )C 2gR$&"''#, 6Fy4'(JiJ !((,,eY-?LLE5 ((,,eY-?LLE5 5%!) $B 5%!) $QW -B ##''J7G##''J7G2gG2gG7"T)J|gl*H Xh 70bggh//0 k!FF6NbffVn4  f$ f$ VVWw& 2 3F  ' ' 7700s <HHc|t|k7s|t|k7r tdd}|dks|dkr t||dks|dkr td|dkr tdhd}|j|vrtd|dy) Nz`k1` and `k2` must be integers.z1`k1` and `k2` must be greater than or equal to 0.rz%`n1` and `n2` must be greater than 0.z(diff must be greater than or equal to 0.>rkr0rezAlternative must be one of 'z'.)int TypeErrorr7lower)rvrwrxryrfr1 count_err alternativess rcrlrlPs SW}c"g 9::CI Ava## Qw"'@AA axCDD3L,.7 ~RHII/rdceZdZdZdZy)CramerVonMisesResultc ||_||_yNr)selfrr s rc__init__zCramerVonMisesResult.__init__es" rdch|jjd|jd|jdS)Nz (statistic=z , pvalue=)) __class____name__rr )rs rc__repr__zCramerVonMisesResult.__repr__is8>>**+;t~~6FG++a) *rdN)r __module__ __qualname__rrrdrcrrds *rdrcddfd}tj|}tj|d}tj|d}d}tj|rn|||| tj t |dzzz }|||z||<tj|d k\||<|dz }tj|rn|S) u psi1 is defined in equation 1.10 in Csörgő, S. and Faraway, J. (1996). This implements a modified version by excluding the term V(x) / 12 (here: _cdf_cvm_inf(x) / 12) to avoid evaluating _cdf_cvm_inf(x) twice in _cdf_cvm. Implementation based on MAPLE code of Julian Faraway and R code of the function pCvM in the package goftest (v1.1.1), permission granted by Adrian Baddeley. Main difference in the implementation: the code here keeps adding terms of the series until the terms are small enough. c|dzdz }td|td|z}tj| |dz dzz|ztjtjz S)Nr!r"???)r r4exprnpi)rPzbs rc_ed2z_psi1_mod.._ed2{sX qD1H sAJC #vvqbzQqSCL(1,rwwruu~==rdc|dzdz }tj| tjtjz }||dz dzzdt d|zdt d|zzt d|z zS)Nr!r"g@rr?)r4rrnrr )rPrcs rc_ed3z_psi1_mod.._ed3sk qD1H FFA2J 'AaC3<1RQZC#KLLrdc d|zdz}dtj|z}|dz}|dz}|t|dzz d|zdz|z zd|zz }t|dz d|zdz|z zd |zz }d|dzzt|d zz d|zd z|z zd |zz }d |zt|dzz d|zdz|z zd|zz } d |zt|dzz d|zd z|z zd|zz } ||z|z| z| zS)Nr!rrr?r"r Hrr& )r4rnr ) krOmsxy1y2e1e2e3e4e5rrs rc_Akz_psi1_mod.._AksO aC!G ^ X X q3w $A 2~"6 6!b& A 1s7^dAEAI#34 4R @ !a%[5S> )D!a%!)r1A,B Bb2g N UU1s7^ #dAEAI+;&< <b I UU1s7^ #dAEAI+;&< <b IBw|b 2%%rdfloatdtypeboolrrHz>)r4r5 zeros_like ones_liker<rr rt)rOrtotcondrrrrs @@rc _psi1_modrns> M & 1 A -- )C << (D A &&, AdG_ a!e 4 5IMD VVAY$&T  Q &&, JrdcZtj|}d}tj|d}tj|d}d}tj|rM||||}|||z||<tj |dk\||<|dz }tj|rM|S)u2 Calculate the cdf of the Cramér-von Mises statistic (infinite sample size). See equation 1.2 in Csörgő, S. and Faraway, J. (1996). Implementation based on MAPLE code of Julian Faraway and R code of the function pCvM in the package goftest (v1.1.1), permission granted by Adrian Baddeley. Main difference in the implementation: the code here keeps adding terms of the series until the terms are small enough. The function is not expected to be accurate for large values of x, say x > 4, when the cdf is very close to 1. cXtjt|dzt|dzz tjdztj|zz }d|zdz}|dzd|zz }t d|}|tj|ztj| z|zS)Nrrrr"r!r)r4rrrrnr )rOrurPqrs rctermz_cdf_cvm_inf..terms FF71s7#gacl2 3ruuczBGGAJ7N O aC!G qDBqDM tQK2771:~r *Q..rdrrrrrr)r4r5rrr<rt)rOrrrrrs rc _cdf_cvm_infrs 1 A/ -- )C << (D A &&, 4! IMD VVAY$&T  Q &&, Jrdc>tj|}| t|}netj|d}dd|zz |k||dz kz}t||ddd|zz zzt |||z z||<d|||dz k\<|j dk(r|d S|S) u Calculate the cdf of the Cramér-von Mises statistic for a finite sample size n. If N is None, use the asymptotic cdf (n=inf). See equation 1.8 in Csörgő, S. and Faraway, J. (1996) for finite samples, 1.2 for the asymptotic cdf. The function is not expected to be accurate for large values of x, say x > 2, when the cdf is very close to 1 and it might return values > 1 in that case, e.g. _cdf_cvm(2.0, 12) = 1.0000027556716846. Moreover, it is not accurate for small values of n, especially close to the bounds of the distribution's domain, [1/(12*n), n/3], where the value jumps to 0 and 1, respectively. These are limitations of the approximation by Csörgő and Faraway (1996) implemented in this function. rrr/rg@rrrr)r4r5rrrr:)rOrTrPsups rc_cdf_cvmrs 1 Ay O MM!7 +2a4y1}QrT*af%RAY7)AcF:Ka:OO#!qs( vv{u Hrdc2|j|jfSrr)res_s rc_cvm_result_to_tuplers ==#** $$rd)r#r$result_to_tuplect|trtt|j}t j t j|}|jdkr tdt|}||g|}dt jd|dzzdz d|zz }dd|zz t j||z dzz}t jdt||z dd}t||S) uPerform the one-sample Cramér-von Mises test for goodness of fit. This performs a test of the goodness of fit of a cumulative distribution function (cdf) :math:`F` compared to the empirical distribution function :math:`F_n` of observed random variates :math:`X_1, ..., X_n` that are assumed to be independent and identically distributed ([1]_). The null hypothesis is that the :math:`X_i` have cumulative distribution :math:`F`. Parameters ---------- rvs : array_like A 1-D array of observed values of the random variables :math:`X_i`. The sample must contain at least two observations. cdf : str or callable The cumulative distribution function :math:`F` to test the observations against. If a string, it should be the name of a distribution in `scipy.stats`. If a callable, that callable is used to calculate the cdf: ``cdf(x, *args) -> float``. args : tuple, optional Distribution parameters. These are assumed to be known; see Notes. Returns ------- res : object with attributes statistic : float Cramér-von Mises statistic. pvalue : float The p-value. See Also -------- kstest, cramervonmises_2samp Notes ----- .. versionadded:: 1.6.0 The p-value relies on the approximation given by equation 1.8 in [2]_. It is important to keep in mind that the p-value is only accurate if one tests a simple hypothesis, i.e. the parameters of the reference distribution are known. If the parameters are estimated from the data (composite hypothesis), the computed p-value is not reliable. References ---------- .. [1] Cramér-von Mises criterion, Wikipedia, https://en.wikipedia.org/wiki/Cram%C3%A9r%E2%80%93von_Mises_criterion .. [2] Csörgő, S. and Faraway, J. (1996). The Exact and Asymptotic Distribution of Cramér-von Mises Statistics. Journal of the Royal Statistical Society, pp. 221-234. Examples -------- Suppose we wish to test whether data generated by ``scipy.stats.norm.rvs`` were, in fact, drawn from the standard normal distribution. We choose a significance level of ``alpha=0.05``. >>> import numpy as np >>> from scipy import stats >>> rng = np.random.default_rng(165417232101553420507139617764912913465) >>> x = stats.norm.rvs(size=500, random_state=rng) >>> res = stats.cramervonmises(x, 'norm') >>> res.statistic, res.pvalue (0.1072085112565724, 0.5508482238203407) The p-value exceeds our chosen significance level, so we do not reject the null hypothesis that the observed sample is drawn from the standard normal distribution. Now suppose we wish to check whether the same samples shifted by 2.1 is consistent with being drawn from a normal distribution with a mean of 2. >>> y = x + 2.1 >>> res = stats.cramervonmises(y, 'norm', args=(2,)) >>> res.statistic, res.pvalue (0.8364446265294695, 0.00596286797008283) Here we have used the `args` keyword to specify the mean (``loc``) of the normal distribution to test the data against. This is equivalent to the following, in which we create a frozen normal distribution with mean 2.1, then pass its ``cdf`` method as an argument. >>> frozen_dist = stats.norm(loc=2) >>> res = stats.cramervonmises(y, frozen_dist.cdf) >>> res.statistic, res.pvalue (0.8364446265294695, 0.00596286797008283) In either case, we would reject the null hypothesis that the observed sample is drawn from a normal distribution with a mean of 2 (and default variance of 1) because the p-value is less than our chosen significance level. rz2The sample must contain at least two observations.r!rr/gNr) isinstancestrgetattrr cdfr4sortr5sizer7r6rqrucliprr) rvsrargsvalsrTcdfvalsrr_rbs rcrrsD#smS)-- 772::c? #D yyA~MNN D A$G 299Q!  q 1Q3'A 2a42661w;*++A Xa^#R.A !A 66rdc(tjdtj}td|dzD]Z}|}tj||dzzdzdztj}t |}|dz|d||| dxxx|dzz ccc\|S)z Distribution of probability of the Wilcoxon ranksum statistic r_plus (sum of ranks of positive differences). Returns an array with the probabilities of all the possible ranks r = 0, ..., n*(n+1)/2 rrr!rN)r4onesfloat64rangezerosr6)rTrrprev_crs rc_get_wilcoxon_distrr_s $A 1a!e_ HHQ!a%[A%) < K "1 1"#&3,  Hrdctjd|dzdddf}||dzzdz }d|z}tj|}dtjz|z |z}tjtj||zd}tj d|z|z|z}tj t|}tjt|dz} |ddd| dd| dxxdzcc<| d| d<| S)a Distribution of probability of the Wilcoxon ranksum statistic r_plus (sum of ranks of positive differences). Returns an array with the probabilities of all the possible ranks r = 0, ..., n*(n+1)/2 This is a slower reference function References ---------- .. [1] 1. Harris T, Hardin JW. Exact Wilcoxon Signed-Rank and Wilcoxon Mann-Whitney Ranksum Tests. The Stata Journal. 2013;13(2):337-343. rNr!rr,y?r)) r4rqrprodrArrealrrr) rTairQrjthetaphi_spphi_srbrs rc_get_wilcoxon_distr2rps 1ac 1d7 #B 1Q3 A !A ! A beeGAIaKE WWRVVE"H%A .F FF2e8A:  'E U A ((3q6!8 C#A#CIFaKF!fCG JrdcD|jddk(s|jddk(r tjtjfS|j}t |}t |}|jddzj}|jddzj}|dz|z |dz|z z}||z |dzz }dt |||z dz|z z z}||z } | dk(r|dfS|| dzz } dtjt| z} || fS)z=Calculate Kendall's tau-b and p-value from contingency table.rrr,r!rr") shaper4nanru_P_Qrr sfrt) ANAPAQASri2Scj2 denominatortau numerator s02_tau_bZrbs rc_tau_brs  wwqzQ!''!*/vvrvv~ B AB AB EEqEM1  ! ! #D EEqEM1  ! ! #Dq54<"a%$,/K b5;$ $C>!$R!|b'889I+%IA~Av  IsNA $''#a&/A 6MrdcF|jddks|jddkr tjtjfS|j}|dz}t |}t |}|jddzj}||z ||z z }t |||z dz|z z }tjd5||z d|zdzz } d d d tj} tj | |t } || fS#1swY>xYw) z7Calculate Somers' D and p-value from contingency table.rrr!r,rh)rjr"rN)r3) rr4rrurrrrsr _SimpleNormalrN) rr1rNA2rrrdSrr rbs rc _somers_drs   wwqzQ!''!*/vvrvv~ B a%C AB AB EEqEM1  ! ! #D b3:AqRUQJrM)A H %# "Wq!usl "#  " " $Da{r:A a4K ##s DD c@eZdZUeed<eed<ej ed<y) SomersDResultrr tableN)rrrr__annotations__r4ndarrayrrdrcrrs M ::rdrctj|tj|}}|jdk(rR|j|jk7r t dt j jj||d}n|jdk(rtj|dkr t dtj||jtk7r t d|jdjdkr t d|}n t dt|jt|\}}t|||}||_|S) aCalculates Somers' D, an asymmetric measure of ordinal association. Like Kendall's :math:`\tau`, Somers' :math:`D` is a measure of the correspondence between two rankings. Both statistics consider the difference between the number of concordant and discordant pairs in two rankings :math:`X` and :math:`Y`, and both are normalized such that values close to 1 indicate strong agreement and values close to -1 indicate strong disagreement. They differ in how they are normalized. To show the relationship, Somers' :math:`D` can be defined in terms of Kendall's :math:`\tau_a`: .. math:: D(Y|X) = \frac{\tau_a(X, Y)}{\tau_a(X, X)} Suppose the first ranking :math:`X` has :math:`r` distinct ranks and the second ranking :math:`Y` has :math:`s` distinct ranks. These two lists of :math:`n` rankings can also be viewed as an :math:`r \times s` contingency table in which element :math:`i, j` is the number of rank pairs with rank :math:`i` in ranking :math:`X` and rank :math:`j` in ranking :math:`Y`. Accordingly, `somersd` also allows the input data to be supplied as a single, 2D contingency table instead of as two separate, 1D rankings. Note that the definition of Somers' :math:`D` is asymmetric: in general, :math:`D(Y|X) \neq D(X|Y)`. ``somersd(x, y)`` calculates Somers' :math:`D(Y|X)`: the "row" variable :math:`X` is treated as an independent variable, and the "column" variable :math:`Y` is dependent. For Somers' :math:`D(X|Y)`, swap the input lists or transpose the input table. Parameters ---------- x : array_like 1D array of rankings, treated as the (row) independent variable. Alternatively, a 2D contingency table. y : array_like, optional If `x` is a 1D array of rankings, `y` is a 1D array of rankings of the same length, treated as the (column) dependent variable. If `x` is 2D, `y` is ignored. alternative : {'two-sided', 'less', 'greater'}, optional Defines the alternative hypothesis. Default is 'two-sided'. The following options are available: * 'two-sided': the rank correlation is nonzero * 'less': the rank correlation is negative (less than zero) * 'greater': the rank correlation is positive (greater than zero) Returns ------- res : SomersDResult A `SomersDResult` object with the following fields: statistic : float The Somers' :math:`D` statistic. pvalue : float The p-value for a hypothesis test whose null hypothesis is an absence of association, :math:`D=0`. See notes for more information. table : 2D array The contingency table formed from rankings `x` and `y` (or the provided contingency table, if `x` is a 2D array) See Also -------- kendalltau : Calculates Kendall's tau, another correlation measure. weightedtau : Computes a weighted version of Kendall's tau. spearmanr : Calculates a Spearman rank-order correlation coefficient. pearsonr : Calculates a Pearson correlation coefficient. Notes ----- This function follows the contingency table approach of [2]_ and [3]_. *p*-values are computed based on an asymptotic approximation of the test statistic distribution under the null hypothesis :math:`D=0`. Theoretically, hypothesis tests based on Kendall's :math:`tau` and Somers' :math:`D` should be identical. However, the *p*-values returned by `kendalltau` are based on the null hypothesis of *independence* between :math:`X` and :math:`Y` (i.e. the population from which pairs in :math:`X` and :math:`Y` are sampled contains equal numbers of all possible pairs), which is more specific than the null hypothesis :math:`D=0` used here. If the null hypothesis of independence is desired, it is acceptable to use the *p*-value returned by `kendalltau` with the statistic returned by `somersd` and vice versa. For more information, see [2]_. Contingency tables are formatted according to the convention used by SAS and R: the first ranking supplied (``x``) is the "row" variable, and the second ranking supplied (``y``) is the "column" variable. This is opposite the convention of Somers' original paper [1]_. References ---------- .. [1] Robert H. Somers, "A New Asymmetric Measure of Association for Ordinal Variables", *American Sociological Review*, Vol. 27, No. 6, pp. 799--811, 1962. .. [2] Morton B. Brown and Jacqueline K. Benedetti, "Sampling Behavior of Tests for Correlation in Two-Way Contingency Tables", *Journal of the American Statistical Association* Vol. 72, No. 358, pp. 309--315, 1977. .. [3] SAS Institute, Inc., "The FREQ Procedure (Book Excerpt)", *SAS/STAT 9.2 User's Guide, Second Edition*, SAS Publishing, 2009. .. [4] Laerd Statistics, "Somers' d using SPSS Statistics", *SPSS Statistics Tutorials and Statistical Guides*, https://statistics.laerd.com/spss-tutorials/somers-d-using-spss-statistics.php, Accessed July 31, 2020. Examples -------- We calculate Somers' D for the example given in [4]_, in which a hotel chain owner seeks to determine the association between hotel room cleanliness and customer satisfaction. The independent variable, hotel room cleanliness, is ranked on an ordinal scale: "below average (1)", "average (2)", or "above average (3)". The dependent variable, customer satisfaction, is ranked on a second scale: "very dissatisfied (1)", "moderately dissatisfied (2)", "neither dissatisfied nor satisfied (3)", "moderately satisfied (4)", or "very satisfied (5)". 189 customers respond to the survey, and the results are cast into a contingency table with the hotel room cleanliness as the "row" variable and customer satisfaction as the "column" variable. +-----+-----+-----+-----+-----+-----+ | | (1) | (2) | (3) | (4) | (5) | +=====+=====+=====+=====+=====+=====+ | (1) | 27 | 25 | 14 | 7 | 0 | +-----+-----+-----+-----+-----+-----+ | (2) | 7 | 14 | 18 | 35 | 12 | +-----+-----+-----+-----+-----+-----+ | (3) | 1 | 3 | 2 | 7 | 17 | +-----+-----+-----+-----+-----+-----+ For example, 27 customers assigned their room a cleanliness ranking of "below average (1)" and a corresponding satisfaction of "very dissatisfied (1)". We perform the analysis as follows. >>> from scipy.stats import somersd >>> table = [[27, 25, 14, 7, 0], [7, 14, 18, 35, 12], [1, 3, 2, 7, 17]] >>> res = somersd(table) >>> res.statistic 0.6032766111513396 >>> res.pvalue 1.0007091191074533e-27 The value of the Somers' D statistic is approximately 0.6, indicating a positive correlation between room cleanliness and customer satisfaction in the sample. The *p*-value is very small, indicating a very small probability of observing such an extreme value of the statistic under the null hypothesis that the statistic of the entire population (from which our sample of 189 customers is drawn) is zero. This supports the alternative hypothesis that the true value of Somers' D for the population is nonzero. rz!Rankings must be of equal length.r!rz;All elements of the contingency table must be non-negative.z6All elements of the contingency table must be integer.z?At least two elements of the contingency table must be nonzero.z!x must be either a 1D or 2D array)r4arrayr:rr7scipystats contingencycrosstabr<astypernonzerorrr correlation)rOrPr1rr rbrs rcrrs-v 88A; qAvv{ 66QVV @A A ''00A6q9 1 66!a%=-. . 66!qxx}$ %() ) 99;q>   "01 1<== U\\%(+ 6DAq 1e $CCO Jrdc#Ktj||z}t||D]D}tj|}tj||zt }d||<||}||fFyw)z Partition a set of indices into two fixed-length sets in all possible ways Partition a set of indices 0 ... nx + ny - 1 into two sets of length nx and ny in all possible ways (ignoring order of elements). FN)r4rqrrrr)rRrSrrrOmaskrPs rc_all_partitionsrsl "R%A !R  HHQKwwr"ud#Q dGd sA-A/c~ttj|dzdz}t|dz|z |dddz S)z'Compute all log combination of C(n, k).rNr))rr4rq)rT gammaln_arrs rc_compute_log_combinationsr"s?"))AE*Q./K 1q5>K '+dd*; ;;rdc"eZdZUeed<eed<y)BarnardExactResultrr Nrrrrrrrdrcr$r$  Mrdr$TcJ|dkrtd|tj|tj}|jdk(s tdtj |dkr tdd|j dvrttjdS|j d\}}tj|d ztjjd d }tj|d ztjjd d }||z ||z } }|r ||z||zz } | d | z zd |z d |z zz} n|d |z z|z | d | z z|z z} tjd d 5tj|| z tj| } d d d d || k(<| |d|df} |dk(r"tj| t| k\}n&|dk(r| | k}n|dk(r| | k\}nd|}t|||z}t|}t|}||||z}t!t"|||fd|d}tj$tj&|j( dd }t| |S#1swYxYw)aPerform a Barnard exact test on a 2x2 contingency table. Parameters ---------- table : array_like of ints A 2x2 contingency table. Elements should be non-negative integers. alternative : {'two-sided', 'less', 'greater'}, optional Defines the null and alternative hypotheses. Default is 'two-sided'. Please see explanations in the Notes section below. pooled : bool, optional Whether to compute score statistic with pooled variance (as in Student's t-test, for example) or unpooled variance (as in Welch's t-test). Default is ``True``. n : int, optional Number of sampling points used in the construction of the sampling method. Note that this argument will automatically be converted to the next higher power of 2 since `scipy.stats.qmc.Sobol` is used to select sample points. Default is 32. Must be positive. In most cases, 32 points is enough to reach good precision. More points comes at performance cost. Returns ------- ber : BarnardExactResult A result object with the following attributes. statistic : float The Wald statistic with pooled or unpooled variance, depending on the user choice of `pooled`. pvalue : float P-value, the probability of obtaining a distribution at least as extreme as the one that was actually observed, assuming that the null hypothesis is true. See Also -------- chi2_contingency : Chi-square test of independence of variables in a contingency table. fisher_exact : Fisher exact test on a 2x2 contingency table. boschloo_exact : Boschloo's exact test on a 2x2 contingency table, which is an uniformly more powerful alternative to Fisher's exact test. Notes ----- Barnard's test is an exact test used in the analysis of contingency tables. It examines the association of two categorical variables, and is a more powerful alternative than Fisher's exact test for 2x2 contingency tables. Let's define :math:`X_0` a 2x2 matrix representing the observed sample, where each column stores the binomial experiment, as in the example below. Let's also define :math:`p_1, p_2` the theoretical binomial probabilities for :math:`x_{11}` and :math:`x_{12}`. When using Barnard exact test, we can assert three different null hypotheses : - :math:`H_0 : p_1 \geq p_2` versus :math:`H_1 : p_1 < p_2`, with `alternative` = "less" - :math:`H_0 : p_1 \leq p_2` versus :math:`H_1 : p_1 > p_2`, with `alternative` = "greater" - :math:`H_0 : p_1 = p_2` versus :math:`H_1 : p_1 \neq p_2`, with `alternative` = "two-sided" (default one) In order to compute Barnard's exact test, we are using the Wald statistic [3]_ with pooled or unpooled variance. Under the default assumption that both variances are equal (``pooled = True``), the statistic is computed as: .. math:: T(X) = \frac{ \hat{p}_1 - \hat{p}_2 }{ \sqrt{ \hat{p}(1 - \hat{p}) (\frac{1}{c_1} + \frac{1}{c_2}) } } with :math:`\hat{p}_1, \hat{p}_2` and :math:`\hat{p}` the estimator of :math:`p_1, p_2` and :math:`p`, the latter being the combined probability, given the assumption that :math:`p_1 = p_2`. If this assumption is invalid (``pooled = False``), the statistic is: .. math:: T(X) = \frac{ \hat{p}_1 - \hat{p}_2 }{ \sqrt{ \frac{\hat{p}_1 (1 - \hat{p}_1)}{c_1} + \frac{\hat{p}_2 (1 - \hat{p}_2)}{c_2} } } The p-value is then computed as: .. math:: \sum \binom{c_1}{x_{11}} \binom{c_2}{x_{12}} \pi^{x_{11} + x_{12}} (1 - \pi)^{t - x_{11} - x_{12}} where the sum is over all 2x2 contingency tables :math:`X` such that: * :math:`T(X) \leq T(X_0)` when `alternative` = "less", * :math:`T(X) \geq T(X_0)` when `alternative` = "greater", or * :math:`T(X) \geq |T(X_0)|` when `alternative` = "two-sided". Above, :math:`c_1, c_2` are the sum of the columns 1 and 2, and :math:`t` the total (sum of the 4 sample's element). The returned p-value is the maximum p-value taken over the nuisance parameter :math:`\pi`, where :math:`0 \leq \pi \leq 1`. This function's complexity is :math:`O(n c_1 c_2)`, where `n` is the number of sample points. References ---------- .. [1] Barnard, G. A. "Significance Tests for 2x2 Tables". *Biometrika*. 34.1/2 (1947): 123-138. :doi:`dpgkg3` .. [2] Mehta, Cyrus R., and Pralay Senchaudhuri. "Conditional versus unconditional exact tests for comparing two binomials." *Cytel Software Corporation* 675 (2003): 1-5. .. [3] "Wald Test". *Wikipedia*. https://en.wikipedia.org/wiki/Wald_test Examples -------- An example use of Barnard's test is presented in [2]_. Consider the following example of a vaccine efficacy study (Chan, 1998). In a randomized clinical trial of 30 subjects, 15 were inoculated with a recombinant DNA influenza vaccine and the 15 were inoculated with a placebo. Twelve of the 15 subjects in the placebo group (80%) eventually became infected with influenza whereas for the vaccine group, only 7 of the 15 subjects (47%) became infected. The data are tabulated as a 2 x 2 table:: Vaccine Placebo Yes 7 12 No 8 3 When working with statistical hypothesis testing, we usually use a threshold probability or significance level upon which we decide to reject the null hypothesis :math:`H_0`. Suppose we choose the common significance level of 5%. Our alternative hypothesis is that the vaccine will lower the chance of becoming infected with the virus; that is, the probability :math:`p_1` of catching the virus with the vaccine will be *less than* the probability :math:`p_2` of catching the virus without the vaccine. Therefore, we call `barnard_exact` with the ``alternative="less"`` option: >>> import scipy.stats as stats >>> res = stats.barnard_exact([[7, 12], [8, 3]], alternative="less") >>> res.statistic -1.894 >>> res.pvalue 0.03407 Under the null hypothesis that the vaccine will not lower the chance of becoming infected, the probability of obtaining test results at least as extreme as the observed data is approximately 3.4%. Since this p-value is less than our chosen significance level, we have evidence to reject :math:`H_0` in favor of the alternative. Suppose we had used Fisher's exact test instead: >>> _, pvalue = stats.fisher_exact([[7, 12], [8, 3]], alternative="less") >>> pvalue 0.0640 With the same threshold significance of 5%, we would not have been able to reject the null hypothesis in favor of the alternative. As stated in [2]_, Barnard's test is uniformly more powerful than Fisher's exact test because Barnard's test does not condition on any margin. Fisher's test should only be used when both sets of marginals are fixed. r6Number of points `n` must be strictly positive, found rr!r!*The input `table` must be of shape (2, 2).*All values in `table` must be nonnegative.r,r/rr)rhrjriNrrrrrerkr0zG`alternative` should be one of {'two-sided', 'less', 'greater'}, found r.sobolrboundsrTsampling_methoda_mina_max)r7r4r5int64rr<rur$rrqr?rsrjrnrtr"r-_get_binomial_log_p_value_with_nuisance_paramrrfun)rr1pooledrT total_col_1 total_col_2rrp1p2rb varianceswald_statistic wald_stat_obs index_arrmsg x1_sum_x2 x1_log_comb x2_log_combx1_sum_x2_log_combresultp_values rcrrs| Av E   JJuBHH -E ;;& EFF vveaiEFFEII1I ""&&#..$yyay0K ;?"(( 3 ; ;B BB ;?"(( 3 ; ;Ar BB+ rK/B "W{2 3QK1{?Q_#DE !b&MK/"B-+2MM  Hh 7BBGbggi.@AB !N28"5;d #;*c-.@@  "m3  !"m3  !_ & oRI+K8K+K8K$R;r?: 5+Y 7  Fggbfffjj[)! p_2`, with `alternative` = "greater" - :math:`H_0 : p_1=p_2` versus :math:`H_1 : p_1 \neq p_2`, with `alternative` = "two-sided" (default) There are multiple conventions for computing a two-sided p-value when the null distribution is asymmetric. Here, we apply the convention that the p-value of a two-sided test is twice the minimum of the p-values of the one-sided tests (clipped to 1.0). Note that `fisher_exact` follows a different convention, so for a given `table`, the statistic reported by `boschloo_exact` may differ from the p-value reported by `fisher_exact` when ``alternative='two-sided'``. .. versionadded:: 1.7.0 References ---------- .. [1] R.D. Boschloo. "Raised conditional level of significance for the 2 x 2-table when testing the equality of two probabilities", Statistica Neerlandica, 24(1), 1970 .. [2] "Boschloo's test", Wikipedia, https://en.wikipedia.org/wiki/Boschloo%27s_test .. [3] Lise M. Saari et al. "Employee attitudes and job satisfaction", Human Resource Management, 43(4), 395-407, 2004, :doi:`10.1002/hrm.20032`. Examples -------- In the following example, we consider the article "Employee attitudes and job satisfaction" [3]_ which reports the results of a survey from 63 scientists and 117 college professors. Of the 63 scientists, 31 said they were very satisfied with their jobs, whereas 74 of the college professors were very satisfied with their work. Is this significant evidence that college professors are happier with their work than scientists? The following table summarizes the data mentioned above:: college professors scientists Very Satisfied 74 31 Dissatisfied 43 32 When working with statistical hypothesis testing, we usually use a threshold probability or significance level upon which we decide to reject the null hypothesis :math:`H_0`. Suppose we choose the common significance level of 5%. Our alternative hypothesis is that college professors are truly more satisfied with their work than scientists. Therefore, we expect :math:`p_1` the proportion of very satisfied college professors to be greater than :math:`p_2`, the proportion of very satisfied scientists. We thus call `boschloo_exact` with the ``alternative="greater"`` option: >>> import scipy.stats as stats >>> res = stats.boschloo_exact([[74, 31], [43, 32]], alternative="greater") >>> res.statistic 0.0483 >>> res.pvalue 0.0355 Under the null hypothesis that scientists are happier in their work than college professors, the probability of obtaining test results at least as extreme as the observed data is approximately 3.55%. Since this p-value is less than our chosen significance level, we have evidence to reject :math:`H_0` in favor of the alternative hypothesis. rr(rr)r*r+r,rr)rkr0re)r1rTr!r4z`alternative` should be one of )rerkr0z, found r-r.g?r/r0r1)r hypergeomr7r4r5r7rr<rurKrrqr?rrCrr rrr"rr8rr9)rr1rTrMr;r<totalrrrDpvalues boschloo_lessboschloo_greaterrr rC fisher_statrBrErFrGrHrIs rcrrsF''IAv U   JJuBHH -E ;;& EFF vveaiEFFEII1I #26626622$yyay0K + %E ;?"(( 3 ; ;Ar BB ;?"(( 3 ; ;B BBRIf--E9kBDD  !--E9kBDD  #&u&AF )%Y!L+114D4K4KKM! SZZq:"3==&99..L-MN!_ & o%+uT{23K ;'22IbddIKKIB+K8K+K8K$R;r?: 5+Y 7  Fggbfffjj[)!L \ *F   v &E 88aS1#Je , -49!H =qRXXfE * = >B 1q5\hhvU+bM DAqA!TJJBB.."c!R%j1QU8345 #r1% !R#" C q51q5=Q&C Fcjj' 'F NN3   Q%KE4 ::bffT%4-01L@ AA% >s/Hc Ptjtj|}tjtj|}|jdks|jdkr t d|dvr t dt |}t |}|dk(rt ||dkDrd}nd}tj||g}tjj|d }|d |} ||d } |tj| tjd|dzz d zz} | |tj| tjd|dzz d zzz } ||z||z} } | | | zz d | zdz d| zz z }|dk(rt| ||}ndd| z zdz }| dzd | z| zd|d z|d zzzz d | zz z}|d| d zzd z| zz }d||z tjd|zz z}|dkrd}nt ddt|z }t!||S)u6Perform the two-sample Cramér-von Mises test for goodness of fit. This is the two-sample version of the Cramér-von Mises test ([1]_): for two independent samples :math:`X_1, ..., X_n` and :math:`Y_1, ..., Y_m`, the null hypothesis is that the samples come from the same (unspecified) continuous distribution. Parameters ---------- x : array_like A 1-D array of observed values of the random variables :math:`X_i`. Must contain at least two observations. y : array_like A 1-D array of observed values of the random variables :math:`Y_i`. Must contain at least two observations. method : {'auto', 'asymptotic', 'exact'}, optional The method used to compute the p-value, see Notes for details. The default is 'auto'. Returns ------- res : object with attributes statistic : float Cramér-von Mises statistic. pvalue : float The p-value. See Also -------- cramervonmises, anderson_ksamp, epps_singleton_2samp, ks_2samp Notes ----- .. versionadded:: 1.7.0 The statistic is computed according to equation 9 in [2]_. The calculation of the p-value depends on the keyword `method`: - ``asymptotic``: The p-value is approximated by using the limiting distribution of the test statistic. - ``exact``: The exact p-value is computed by enumerating all possible combinations of the test statistic, see [2]_. If ``method='auto'``, the exact approach is used if both samples contain equal to or less than 20 observations, otherwise the asymptotic distribution is used. If the underlying distribution is not continuous, the p-value is likely to be conservative (Section 6.2 in [3]_). When ranking the data to compute the test statistic, midranks are used if there are ties. References ---------- .. [1] https://en.wikipedia.org/wiki/Cramer-von_Mises_criterion .. [2] Anderson, T.W. (1962). On the distribution of the two-sample Cramer-von-Mises criterion. The Annals of Mathematical Statistics, pp. 1148-1159. .. [3] Conover, W.J., Practical Nonparametric Statistics, 1971. Examples -------- Suppose we wish to test whether two samples generated by ``scipy.stats.norm.rvs`` have the same distribution. We choose a significance level of alpha=0.05. >>> import numpy as np >>> from scipy import stats >>> rng = np.random.default_rng() >>> x = stats.norm.rvs(size=100, random_state=rng) >>> y = stats.norm.rvs(size=70, random_state=rng) >>> res = stats.cramervonmises_2samp(x, y) >>> res.statistic, res.pvalue (0.29376470588235293, 0.1412873014573014) The p-value exceeds our chosen significance level, so we do not reject the null hypothesis that the observed samples are drawn from the same distribution. For small sample sizes, one can compute the exact p-values: >>> x = stats.norm.rvs(size=7, random_state=rng) >>> y = stats.t.rvs(df=2, size=6, random_state=rng) >>> res = stats.cramervonmises_2samp(x, y, method='exact') >>> res.statistic, res.pvalue (0.197802197802198, 0.31643356643356646) The p-value based on the asymptotic distribution is a good approximation even though the sample size is small. >>> res = stats.cramervonmises_2samp(x, y, method='asymptotic') >>> res.statistic, res.pvalue (0.197802197802198, 0.2966041181527128) Independent of the method, one would not reject the null hypothesis at the chosen significance level in this example. rz/x and y must contain at least two observations.)autoexact asymptoticz0method must be either auto, exact or asymptotic.rrraverage)methodNr!r"rfr-gUUUUUU?g~jth?r/rr)r4rr5rr7r6rLrmrrrankdatarurqrrnrr)rOrPrxayarRrSrr]rxryrrNrQrbetvttns rcrr s<J A B A B ww!|rww!|JKK 44KLL RB RB  r2; !FF Bx A Qy1A 3BB 23B RVVR"))Ar!t,,q0 11Abffb299Q1--12 22A b5"r'qA QqS QqS1WqsO#A  !!R ,!A#gq[cac!eaQQ//!A#5 6 219q=1$ %AFbggb2g.. . :AArL,,-A !A 66rdc$eZdZdZdZdZddZy)TukeyHSDResultaResult of `scipy.stats.tukey_hsd`. Attributes ---------- statistic : float ndarray The computed statistic of the test for each comparison. The element at index ``(i, j)`` is the statistic for the comparison between groups ``i`` and ``j``. pvalue : float ndarray The associated p-value from the studentized range distribution. The element at index ``(i, j)`` is the p-value for the comparison between groups ``i`` and ``j``. Notes ----- The string representation of this object displays the most recently calculated confidence interval, and if none have been previously calculated, it will evaluate ``confidence_interval()``. References ---------- .. [1] NIST/SEMATECH e-Handbook of Statistical Methods, "7.4.7.1. Tukey's Method." https://www.itl.nist.gov/div898/handbook/prc/section4/prc471.htm, 28 November 2020. .. [2] P. A. Games and J. F. Howell, "Pairwise Multiple Comparison Procedures with Unequal N's and/or Variances: A Monte Carlo Study," Journal of Educational Statistics, vol. 1, no. 2, pp. 113-125, Jun. 1976, doi: https://doi.org/10.3102/10769986001002113. cf||_||_||_||_||_d|_d|_yr)rr _ntreatments_df _stand_err_ci_ci_cl)rrr rrrs rcrzTukeyHSDResult.__init__s4" ($ rdc|j|jdd|jdzdd}|dz }t|jj dD]}t|jj dD]q}||k7s |d |d |d |j ||fd |j||fd |jj||fd |jj||fd d z }s|S)Nffffff?)confidence_levelzPairwise Group Comparisons (dz.1fz% Confidence Interval) z3Comparison Statistic p-value Lower CI Upper CI rz (z - z) z>10.3f ) rconfidence_intervalrrr rrlowhigh)rrqirs rc__str__zTukeyHSDResult.__str__s 88   $ $c $ :++c/#&&>@ CCt{{((+, =A4;;,,Q/0 =6BqcQCr$..A*>v)F![[A.v6!XX\\!Q$/7!XX]]1a408<=A = =rdc|j'|j||jk(r |jSd|cxkrdkstdtd||j|jf}t j j|}||jz}|j|z}|j|z }t|||_||_|jS)aiCompute the confidence interval for the specified confidence level. Parameters ---------- confidence_level : float, optional Confidence level for the computed confidence interval of the estimated proportion. Default is .95. Returns ------- ci : ``ConfidenceInterval`` object The object has attributes ``low`` and ``high`` that hold the lower and upper bounds of the confidence intervals for each comparison. The high and low values are accessible for each comparison at index ``(i, j)`` between groups ``i`` and ``j``. References ---------- .. [1] NIST/SEMATECH e-Handbook of Statistical Methods, "7.4.7.1. Tukey's Method." https://www.itl.nist.gov/div898/handbook/prc/section4/prc471.htm, 28 November 2020. .. [2] P. A. Games and J. F. Howell, "Pairwise Multiple Comparison Procedures with Unequal N's and/or Variances: A Monte Carlo Study," Journal of Educational Statistics, vol. 1, no. 2, pp. 113-125, Jun. 1976, doi: https://doi.org/10.3102/10769986001002113. Examples -------- >>> from scipy.stats import tukey_hsd >>> group0 = [24.5, 23.5, 26.4, 27.1, 29.9] >>> group1 = [28.4, 34.2, 29.5, 32.2, 30.1] >>> group2 = [26.1, 28.3, 24.3, 26.2, 27.8] >>> result = tukey_hsd(group0, group1, group2) >>> ci = result.confidence_interval() >>> ci.low array([[-3.649159, -8.249159, -3.909159], [ 0.950841, -3.649159, 0.690841], [-3.389159, -7.989159, -3.649159]]) >>> ci.high array([[ 3.649159, -0.950841, 3.389159], [ 8.249159, 3.649159, 7.989159], [ 3.909159, -0.690841, 3.649159]]) rrz)Confidence level must be between 0 and 1.)rr) rrr7rrr studentized_rangerprrr )rrparamssrdconfidence_radius upper_conf lower_confs rcrz"TukeyHSDResult.confidence_intervals^ HH T[[%< DKK/88O#'a'HI I(HI I #D$5$5txx@--116: $//1^^&77 ^^&77 %*:F& xxrdN)r)rrr__doc__rrrrrdrcrrs>$Frdrct|dkr tdt|ts t d|Dcgc]}t j |}}|D]d}|jdk7r td|jdkr tdt j|js[td|Scc}w)Nr!z$There must be more than 1 treatment.z(Expected a boolean value for 'equal_var'rz&Input samples must be one-dimensional.z+Input sample size must be greater than one.zInput samples must be finite.) r6r7rrrr4r5r:risinfr<)r equal_varargs rc _tukey_hsd_ivr*s D Q?@@ i &BCC'+ ,BJJsO ,D ,> 88q=EF F 88q=JK K 88C=   <= = > K -sC)rc Jt||}t|}tj|Dcgc]}tj|c}}tj|Dcgc]}|j c}}tj |}tj|Dcgc]}tj|dc}}|rtj ||dz z||z z } tj|j dk(r d|dz } nd|z d|djz z} tj| | zdz } ||z } nm||z } | ddtjf}tj|| zdz } |dz }|ddtjf}|| zdz|dz|z | dz|z zz } |dj|z }tj|| z }||| f}tjj|}t!|||| | Scc}wcc}wcc}w)aNPerform Tukey's HSD test for equality of means over multiple treatments. Tukey's honestly significant difference (HSD) test performs pairwise comparison of means for a set of samples. Whereas ANOVA (e.g. `f_oneway`) assesses whether the true means underlying each sample are identical, Tukey's HSD is a post hoc test used to compare the mean of each sample to the mean of each other sample. The null hypothesis is that the distributions underlying the samples all have the same mean. The test statistic, which is computed for every possible pairing of samples, is simply the difference between the sample means. For each pair, the p-value is the probability under the null hypothesis (and other assumptions; see notes) of observing such an extreme value of the statistic, considering that many pairwise comparisons are being performed. Confidence intervals for the difference between each pair of means are also available. Parameters ---------- sample1, sample2, ... : array_like The sample measurements for each group. There must be at least two arguments. equal_var: bool, optional If True (default) and equal sample size, perform Tukey-HSD test [6]. If True and unequal sample size, perform Tukey-Kramer test [4]_. If False, perform Games-Howell test [7]_, which does not assume equal variances. Returns ------- result : `~scipy.stats._result_classes.TukeyHSDResult` instance The return value is an object with the following attributes: statistic : float ndarray The computed statistic of the test for each comparison. The element at index ``(i, j)`` is the statistic for the comparison between groups ``i`` and ``j``. pvalue : float ndarray The computed p-value of the test for each comparison. The element at index ``(i, j)`` is the p-value for the comparison between groups ``i`` and ``j``. The object has the following methods: confidence_interval(confidence_level=0.95): Compute the confidence interval for the specified confidence level. See Also -------- dunnett : performs comparison of means against a control group. Notes ----- The use of this test relies on several assumptions. 1. The observations are independent within and among groups. 2. The observations within each group are normally distributed. 3. The distributions from which the samples are drawn have the same finite variance. The original formulation of the test was for samples of equal size drawn from populations assumed to have equal variances [6]_. In case of unequal sample sizes, the test uses the Tukey-Kramer method [4]_. When equal variances are not assumed (``equal_var=False``), the test uses the Games-Howell method [7]_. References ---------- .. [1] NIST/SEMATECH e-Handbook of Statistical Methods, "7.4.7.1. Tukey's Method." https://www.itl.nist.gov/div898/handbook/prc/section4/prc471.htm, 28 November 2020. .. [2] Abdi, Herve & Williams, Lynne. (2021). "Tukey's Honestly Significant Difference (HSD) Test." https://personal.utdallas.edu/~herve/abdi-HSD2010-pretty.pdf .. [3] "One-Way ANOVA Using SAS PROC ANOVA & PROC GLM." SAS Tutorials, 2007, www.stattutorials.com/SAS/TUTORIAL-PROC-GLM.htm. .. [4] Kramer, Clyde Young. "Extension of Multiple Range Tests to Group Means with Unequal Numbers of Replications." Biometrics, vol. 12, no. 3, 1956, pp. 307-310. JSTOR, www.jstor.org/stable/3001469. Accessed 25 May 2021. .. [5] NIST/SEMATECH e-Handbook of Statistical Methods, "7.4.3.3. The ANOVA table and tests of hypotheses about means" https://www.itl.nist.gov/div898/handbook/prc/section4/prc433.htm, 2 June 2021. .. [6] Tukey, John W. "Comparing Individual Means in the Analysis of Variance." Biometrics, vol. 5, no. 2, 1949, pp. 99-114. JSTOR, www.jstor.org/stable/3001913. Accessed 14 June 2021. .. [7] P. A. Games and J. F. Howell, "Pairwise Multiple Comparison Procedures with Unequal N's and/or Variances: A Monte Carlo Study," Journal of Educational Statistics, vol. 1, no. 2, pp. 113-125, Jun. 1976, doi: https://doi.org/10.3102/10769986001002113. Examples -------- Here are some data comparing the time to relief of three brands of headache medicine, reported in minutes. Data adapted from [3]_. >>> import numpy as np >>> from scipy.stats import tukey_hsd >>> group0 = [24.5, 23.5, 26.4, 27.1, 29.9] >>> group1 = [28.4, 34.2, 29.5, 32.2, 30.1] >>> group2 = [26.1, 28.3, 24.3, 26.2, 27.8] We would like to see if the means between any of the groups are significantly different. First, visually examine a box and whisker plot. >>> import matplotlib.pyplot as plt >>> fig, ax = plt.subplots(1, 1) >>> ax.boxplot([group0, group1, group2]) >>> ax.set_xticklabels(["group0", "group1", "group2"]) # doctest: +SKIP >>> ax.set_ylabel("mean") # doctest: +SKIP >>> plt.show() From the box and whisker plot, we can see overlap in the interquartile ranges group 1 to group 2 and group 3, but we can apply the ``tukey_hsd`` test to determine if the difference between means is significant. We set a significance level of .05 to reject the null hypothesis. >>> res = tukey_hsd(group0, group1, group2) >>> print(res) Pairwise Group Comparisons (95.0% Confidence Interval) Comparison Statistic p-value Lower CI Upper CI (0 - 1) -4.600 0.014 -8.249 -0.951 (0 - 2) -0.260 0.980 -3.909 3.389 (1 - 0) 4.600 0.014 0.951 8.249 (1 - 2) 4.340 0.020 0.691 7.989 (2 - 0) 0.260 0.980 -3.389 3.909 (2 - 1) -4.340 0.020 -7.989 -0.691 The null hypothesis is that each group has the same mean. The p-value for comparisons between ``group0`` and ``group1`` as well as ``group1`` and ``group2`` do not exceed .05, so we reject the null hypothesis that they have the same means. The p-value of the comparison between ``group0`` and ``group2`` exceeds .05, so we accept the null hypothesis that there is not a significant difference between their means. We can also compute the confidence interval associated with our chosen confidence level. >>> group0 = [24.5, 23.5, 26.4, 27.1, 29.9] >>> group1 = [28.4, 34.2, 29.5, 32.2, 30.1] >>> group2 = [26.1, 28.3, 24.3, 26.2, 27.8] >>> result = tukey_hsd(group0, group1, group2) >>> conf = res.confidence_interval(confidence_level=.99) >>> for ((i, j), l) in np.ndenumerate(conf.low): ... # filter out self comparisons ... if i != j: ... h = conf.high[i,j] ... print(f"({i} - {j}) {l:>6.3f} {h:>6.3f}") (0 - 1) -9.480 0.280 (0 - 2) -5.140 4.620 (1 - 0) -0.280 9.480 (1 - 2) -0.540 9.220 (2 - 0) -4.620 5.140 (2 - 1) -9.220 0.540 r)ddofr!rNg;f?)rr6r4r5rJrrur{uniquerCrnnewaxisrtr rrr)rr ntreatmentsrmeansrrnsamples_treatmentsnobsvars_mse normalize stand_errdfsj2_njsi2_ninjm1nim1mean_differencest_statrrOs rcrr:sz y )Dd)K JJ5 5 6E**d%;aff%;< 66% &D JJt<s+< =Evve2Q678D;rs"!"'$,,*7! .((D(?A4QOv,Pv,r01kv8rJ(**/d!H B%.!q*>@q7@q7h "666   sn  <    F6R   N5bXv2Bj.!q*>@V7@V7rAAH  $R)rd