a
    a\                  	   @  s4  d Z ddlmZ ddlZddlZddlZddlmZmZ ddl	Z	ddl
mZmZmZmZmZ ddlZddlZerddlm
Z ddlmZ ddlmZmZmZmZ ddlmZ ddlmZ dd	lm Z m!Z!m"Z"m#Z#m$Z$m%Z%m&Z&m'Z'm(Z( dd
l)m*Z*m+Z+m,Z,m-Z-m.Z. g dZ/edCdddddZ0edddddZ0dDddZ0ddddddddddZ1ddddddd d!d"d#d$d%Z2ddd&d"d'd(d)Z3d*dd+d,d-Z4d!d.d+d/d0Z5dEdddd2d!d!d!dd3dd4d5d6Z6G d7d8 d8eZ7G d9d: d:e7Z8G d;d< d<e7Z9G d=d> d>e7Z:G d?d@ d@e7Z;G dAdB dBe7Z<dS )Fz&Quasi-Monte Carlo engines and helpers.    )annotationsN)ABCabstractmethod)ClassVarListOptionaloverloadTYPE_CHECKING)Literal)DecimalNumberGeneratorType	IntNumberSeedType)rng_integers)	initialize_v
_cscramble_fill_p_cumulative_draw_fast_forward_categorizeinitialize_direction_numbers_MAXDIM_MAXBIT) _cy_wrapper_centered_discrepancy#_cy_wrapper_wrap_around_discrepancy_cy_wrapper_mixture_discrepancy_cy_wrapper_l2_star_discrepancy_cy_wrapper_update_discrepancy)	scalediscrepancyupdate_discrepancy	QMCEngineSobolHaltonLatinHypercubeMultinomialQMCMultivariateNormalQMC.zOptional[IntNumber]znp.random.Generator)seedreturnc                 C  s   d S N r'   r*   r*   `/Users/vegardjervell/Documents/master/model/venv/lib/python3.9/site-packages/scipy/stats/_qmc.pycheck_random_state0   s    r-   r   c                 C  s   d S r)   r*   r+   r*   r*   r,   r-   4   s    c                 C  sr   | du st | tjtjfr>ttjds2d}t|tj| S t | tjj	rP| S t | tjj
rb| S td|  dS )aP  Turn `seed` into a `numpy.random.Generator` instance.

    Parameters
    ----------
    seed : {None, int, `numpy.random.Generator`,
            `numpy.random.RandomState`}, optional

        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` or ``RandomState`` instance then
        that instance is used.

    Returns
    -------
    seed : {`numpy.random.Generator`, `numpy.random.RandomState`}
        Random number generator.

    N	GeneratorzaNumPy 1.16 doesn't have Generator, use either NumPy >= 1.17 or `seed=np.random.RandomState(seed)`z;%r cannot be used to seed a numpy.random.Generator instance)
isinstancenumbersIntegralnpintegerhasattrrandom
ValueErrorZdefault_rngZRandomStater.   )r'   msgr*   r*   r,   r-   :   s    F)reversenpt.ArrayLikebool
np.ndarray)samplel_boundsu_boundsr8   r(   c                C  s   t | } t |}t |}| jdks0tdt ||\}}t ||k sVtdt|| jd krptd|st | dkrt | dkstd| ||  | S t | |krt | |kstd| | ||  S d	S )
a  Sample scaling from unit hypercube to different bounds.

    To convert a sample from :math:`[0, 1)` to :math:`[a, b), b>a`,
    with :math:`a` the lower bounds and :math:`b` the upper bounds.
    The following transformation is used:

    .. math::

        (b - a) \cdot \text{sample} + a

    Parameters
    ----------
    sample : array_like (n, d)
        Sample to scale.
    l_bounds, u_bounds : array_like (d,)
        Lower and upper bounds (resp. :math:`a`, :math:`b`) of transformed
        data. If `reverse` is True, range of the original data to transform
        to the unit hypercube.
    reverse : bool, optional
        Reverse the transformation from different bounds to the unit hypercube.
        Default is False.

    Returns
    -------
    sample : array_like (n, d)
        Scaled sample.

    Examples
    --------
    Transform 3 samples in the unit hypercube to bounds:

    >>> from scipy.stats import qmc
    >>> l_bounds = [-2, 0]
    >>> u_bounds = [6, 5]
    >>> sample = [[0.5 , 0.75],
    ...           [0.5 , 0.5],
    ...           [0.75, 0.25]]
    >>> sample_scaled = qmc.scale(sample, l_bounds, u_bounds)
    >>> sample_scaled
    array([[2.  , 3.75],
           [2.  , 2.5 ],
           [4.  , 1.25]])

    And convert back to the unit hypercube:

    >>> sample_ = qmc.scale(sample_scaled, l_bounds, u_bounds, reverse=True)
    >>> sample_
    array([[0.5 , 0.75],
           [0.5 , 0.5 ],
           [0.75, 0.25]])

       Sample is not a 2D arrayzBounds are not consistent a < b   z3Sample dimension is different than bounds dimensionr   Sample is not in unit hypercubezSample is out of boundsN)	r2   asarrayZ
atleast_1dndimr6   Zbroadcast_arraysalllenshape)r<   r=   r>   r8   lowerupperr*   r*   r,   r   _   s"    ;



r   CDrA   )	iterativemethodworkersz$Literal['CD', 'WD', 'MD', 'L2-star']r   float)r<   rK   rL   rM   r(   c                C  s   t j| t jdd} | jdks$tdt | dkr@t | dksHtdt|}|dkrrt }|d	u rt	d
n|dkrtd| dt
tttd}||v r|| | ||dS t|dt|d	S )a  Discrepancy of a given sample.

    Parameters
    ----------
    sample : array_like (n, d)
        The sample to compute the discrepancy from.
    iterative : bool, optional
        Must be False if not using it for updating the discrepancy.
        Default is False. Refer to the notes for more details.
    method : str, optional
        Type of discrepancy, can be ``CD``, ``WD``, ``MD`` or ``L2-star``.
        Refer to the notes for more details. Default is ``CD``.
    workers : int, optional
        Number of workers to use for parallel processing. If -1 is given all
        CPU threads are used. Default is 1.

    Returns
    -------
    discrepancy : float
        Discrepancy.

    Notes
    -----
    The discrepancy is a uniformity criterion used to assess the space filling
    of a number of samples in a hypercube. A discrepancy quantifies the
    distance between the continuous uniform distribution on a hypercube and the
    discrete uniform distribution on :math:`n` distinct sample points.

    The lower the value is, the better the coverage of the parameter space is.

    For a collection of subsets of the hypercube, the discrepancy is the
    difference between the fraction of sample points in one of those
    subsets and the volume of that subset. There are different definitions of
    discrepancy corresponding to different collections of subsets. Some
    versions take a root mean square difference over subsets instead of
    a maximum.

    A measure of uniformity is reasonable if it satisfies the following
    criteria [1]_:

    1. It is invariant under permuting factors and/or runs.
    2. It is invariant under rotation of the coordinates.
    3. It can measure not only uniformity of the sample over the hypercube,
       but also the projection uniformity of the sample over non-empty
       subset of lower dimension hypercubes.
    4. There is some reasonable geometric meaning.
    5. It is easy to compute.
    6. It satisfies the Koksma-Hlawka-like inequality.
    7. It is consistent with other criteria in experimental design.

    Four methods are available:

    * ``CD``: Centered Discrepancy - subspace involves a corner of the
      hypercube
    * ``WD``: Wrap-around Discrepancy - subspace can wrap around bounds
    * ``MD``: Mixture Discrepancy - mix between CD/WD covering more criteria
    * ``L2-star``: L2-star discrepancy - like CD BUT variant to rotation

    See [2]_ for precise definitions of each method.

    Lastly, using ``iterative=True``, it is possible to compute the
    discrepancy as if we had :math:`n+1` samples. This is useful if we want
    to add a point to a sampling and check the candidate which would give the
    lowest discrepancy. Then you could just update the discrepancy with
    each candidate using `update_discrepancy`. This method is faster than
    computing the discrepancy for a large number of candidates.

    References
    ----------
    .. [1] Fang et al. "Design and modeling for computer experiments".
       Computer Science and Data Analysis Series, 2006.
    .. [2] Zhou Y.-D. et al. Mixture discrepancy for quasi-random point sets.
       Journal of Complexity, 29 (3-4) , pp. 283-301, 2013.
    .. [3] T. T. Warnock. "Computational investigations of low discrepancy
       point sets". Applications of Number Theory to Numerical
       Analysis, Academic Press, pp. 319-343, 1972.

    Examples
    --------
    Calculate the quality of the sample using the discrepancy:

    >>> from scipy.stats import qmc
    >>> space = np.array([[1, 3], [2, 6], [3, 2], [4, 5], [5, 1], [6, 4]])
    >>> l_bounds = [0.5, 0.5]
    >>> u_bounds = [6.5, 6.5]
    >>> space = qmc.scale(space, l_bounds, u_bounds, reverse=True)
    >>> space
    array([[0.08333333, 0.41666667],
           [0.25      , 0.91666667],
           [0.41666667, 0.25      ],
           [0.58333333, 0.75      ],
           [0.75      , 0.08333333],
           [0.91666667, 0.58333333]])
    >>> qmc.discrepancy(space)
    0.008142039609053464

    We can also compute iteratively the ``CD`` discrepancy by using
    ``iterative=True``.

    >>> disc_init = qmc.discrepancy(space[:-1], iterative=True)
    >>> disc_init
    0.04769081147119336
    >>> qmc.update_discrepancy(space[-1], space[:-1], disc_init)
    0.008142039609053513

    Cdtypeorderr?   r@   r   rA   rB   NzaCannot determine the number of cpus using os.cpu_count(), cannot use -1 for the number of workerszInvalid number of workers: z, must be -1 or > 0)rJ   ZWDZMDzL2-star)rM   z* is not a valid method. It must be one of )r2   rC   float64rD   r6   rE   intos	cpu_countNotImplementedErrorr   r   r   r   set)r<   rK   rL   rM   methodsr*   r*   r,   r      s0    p
r   r   )x_newr<   initial_discr(   c                 C  s   t j|t jdd}t j| t jdd} |jdks6tdt |dkrRt |dksZtd| jdksltdt | dkrt | dkstd	| jd |jd krtd
t| ||S )a  Update the centered discrepancy with a new sample.

    Parameters
    ----------
    x_new : array_like (1, d)
        The new sample to add in `sample`.
    sample : array_like (n, d)
        The initial sample.
    initial_disc : float
        Centered discrepancy of the `sample`.

    Returns
    -------
    discrepancy : float
        Centered discrepancy of the sample composed of `x_new` and `sample`.

    Examples
    --------
    We can also compute iteratively the discrepancy by using
    ``iterative=True``.

    >>> from scipy.stats import qmc
    >>> space = np.array([[1, 3], [2, 6], [3, 2], [4, 5], [5, 1], [6, 4]])
    >>> l_bounds = [0.5, 0.5]
    >>> u_bounds = [6.5, 6.5]
    >>> space = qmc.scale(space, l_bounds, u_bounds, reverse=True)
    >>> disc_init = qmc.discrepancy(space[:-1], iterative=True)
    >>> disc_init
    0.04769081147119336
    >>> qmc.update_discrepancy(space[-1], space[:-1], disc_init)
    0.008142039609053513

    rO   rP   r?   r@   r   rA   rB   zx_new is not a 1D arrayzx_new is not in unit hypercubez&x_new and sample must be broadcastable)r2   rC   rT   rD   r6   rE   rG   r   )r[   r<   r\   r*   r*   r,   r    K  s    %

r    rU   nr(   c                 C  s   t j| d | d dk td}tdt| d d d D ]X}d| d dB }d||| d dd| < d|||d|d@   d	  d dd| < q8t jdddt |d
 dd  d dB f S )a  Prime numbers from 2 to *n*.

    Parameters
    ----------
    n : int
        Sup bound with ``n >= 6``.

    Returns
    -------
    primes : list(int)
        Primes in ``2 <= p < n``.

    Notes
    -----
    Taken from [1]_ by P.T. Roy, written consent given on 23.04.2021
    by the original author, Bruno Astrolino, for free use in SciPy under
    the 3-clause BSD.

    References
    ----------
    .. [1] `StackOverflow <https://stackoverflow.com/questions/2068372>`_.

          r?   rQ   rA         ?FN   r   )r2   Zonesr:   rangerU   Zr_Znonzero)r^   Zsieveikr*   r*   r,   primes_from_2_to  s    ,rg   z	List[int]c                 C  sL   g dd|  }t || k rHd}t|d|  }t || kr>qH|d7 }q |S )zList of the n-first prime numbers.

    Parameters
    ----------
    n : int
        Number of prime numbers wanted.

    Returns
    -------
    primes : list(int)
        List of primes.

    )r?   r_                              %   )   +   /   5   ;   =   C   G   I   O   S   Y   a   e   g   k   m   q                                                                           i  i  i  i  i  i  i  i%  i3  i7  i9  i=  iK  iQ  i[  i]  ia  ig  io  iu  i{  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i	  i  i  i#  i-  i3  i9  i;  iA  iK  iQ  iW  iY  i_  ie  ii  ik  iw  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i  i)  i+  i5  i7  i;  i=  iG  iU  iY  i[  i_  im  iq  is  iw  i  i  i  i  i  i  i  i  i  i  i  i  i  i  Ni  i  )rF   rg   )r^   ZprimesZ
big_numberr*   r*   r,   n_primes  s    
r   r?   start_indexscrambler'   r   )r^   baser   r   r'   r(   c                C  s   t |}t| }t|||  }d| }d| dk r|| }	|r`||}
|
t|	t }	||	| 7 }|| }||	 | }q*|S )a  Van der Corput sequence.

    Pseudo-random number generator based on a b-adic expansion.

    Scrambling uses permutations of the remainders (see [1]_). Multiple
    permutations are applied to construct a point. The sequence of
    permutations has to be the same for all points of the sequence.

    Parameters
    ----------
    n : int
        Number of element of the sequence.
    base : int, optional
        Base of the sequence. Default is 2.
    start_index : int, optional
        Index to start the sequence from. Default is 0.
    scramble : bool, optional
        If True, use Owen scrambling. Otherwise no scrambling is done.
        Default is True.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Returns
    -------
    sequence : list (n,)
        Sequence of Van der Corput.

    References
    ----------
    .. [1] A. B. Owen. "A randomized Halton algorithm in R",
       arXiv:1706.02808, 2017.

    rA   )r-   r2   zerosarangeZpermutationarrayZastyperU   )r^   r   r   r   r'   rngsequenceZquotientZb2r	remainderpermr*   r*   r,   van_der_corput  s    ,

r   c                   @  s`   e Zd ZdZedddddddd	ZeddddddZd dddZdd dddZdS )r!   a  A generic Quasi-Monte Carlo sampler class meant for subclassing.

    QMCEngine is a base class to construct a specific Quasi-Monte Carlo
    sampler. It cannot be used directly as a sampler.

    Parameters
    ----------
    d : int
        Dimension of the parameter space.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Notes
    -----
    By convention samples are distributed over the half-open interval
    ``[0, 1)``. Instances of the class can access the attributes: ``d`` for
    the dimension; and ``rng`` for the random number generator (used for the
    ``seed``).

    **Subclassing**

    When subclassing `QMCEngine` to create a new sampler,  ``__init__`` and
    ``random`` must be redefined.

    * ``__init__(d, seed=None)``: at least fix the dimension. If the sampler
      does not take advantage of a ``seed`` (deterministic methods like
      Halton), this parameter can be omitted.
    * ``random(n)``: draw ``n`` from the engine and increase the counter
      ``num_generated`` by ``n``.

    Optionally, two other methods can be overwritten by subclasses:

    * ``reset``: Reset the engine to it's original state.
    * ``fast_forward``: If the sequence is deterministic (like Halton
      sequence), then ``fast_forward(n)`` is skipping the ``n`` first draw.

    Examples
    --------
    To create a random sampler based on ``np.random.random``, we would do the
    following:

    >>> from scipy.stats import qmc
    >>> class RandomEngine(qmc.QMCEngine):
    ...     def __init__(self, d, seed=None):
    ...         super().__init__(d=d, seed=seed)
    ...
    ...
    ...     def random(self, n=1):
    ...         self.num_generated += n
    ...         return self.rng.random((n, self.d))
    ...
    ...
    ...     def reset(self):
    ...         super().__init__(d=self.d, seed=self.rng_seed)
    ...         return self
    ...
    ...
    ...     def fast_forward(self, n):
    ...         self.random(n)
    ...         return self

    After subclassing `QMCEngine` to define the sampling strategy we want to
    use, we can create an instance to sample from.

    >>> engine = RandomEngine(2)
    >>> engine.random(5)
    array([[0.22733602, 0.31675834],  # random
           [0.79736546, 0.67625467],
           [0.39110955, 0.33281393],
           [0.59830875, 0.18673419],
           [0.67275604, 0.94180287]])

    We can also reset the state of the generator and resample again.

    >>> _ = engine.reset()
    >>> engine.random(5)
    array([[0.22733602, 0.31675834],  # random
           [0.79736546, 0.67625467],
           [0.39110955, 0.33281393],
           [0.59830875, 0.18673419],
           [0.67275604, 0.94180287]])

    Nr+   r   r   None)dr'   r(   c                C  s@   t t|t jstd|| _t|| _t	|| _
d| _d S )Nzd must be an integer valuer   )r2   Z
issubdtypetyper3   r6   r   r-   r   copydeepcopyrng_seednum_generated)selfr   r'   r*   r*   r,   __init__h  s    
zQMCEngine.__init__rA   r;   r]   c                 C  s   dS )a1  Draw `n` in the half-open interval ``[0, 1)``.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space.
            Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            QMC sample.

        Nr*   r   r^   r*   r*   r,   r5   w  s    zQMCEngine.randomr(   c                 C  s    t | j}t|| _d| _| S )zReset the engine to base state.

        Returns
        -------
        engine : QMCEngine
            Engine reset to its base state.

        r   )r   r   r   r-   r   r   )r   r'   r*   r*   r,   reset  s    	
zQMCEngine.resetc                 C  s   | j |d | S )a
  Fast-forward the sequence by `n` positions.

        Parameters
        ----------
        n : int
            Number of points to skip in the sequence.

        Returns
        -------
        engine : QMCEngine
            Engine reset to its base state.

        )r^   )r5   r   r*   r*   r,   fast_forward  s    zQMCEngine.fast_forward)rA   )	__name__
__module____qualname____doc__r   r   r5   r   r   r*   r*   r*   r,   r!     s   Xr!   c                      sF   e Zd ZdZdddddddd	 fd
dZddddddZ  ZS )r#   a
  Halton sequence.

    Pseudo-random number generator that generalize the Van der Corput sequence
    for multiple dimensions. The Halton sequence uses the base-two Van der
    Corput sequence for the first dimension, base-three for its second and
    base-:math:`n` for its n-dimension.

    Parameters
    ----------
    d : int
        Dimension of the parameter space.
    scramble : bool, optional
        If True, use Owen scrambling. Otherwise no scrambling is done.
        Default is True.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Notes
    -----
    The Halton sequence has severe striping artifacts for even modestly
    large dimensions. These can be ameliorated by scrambling. Scrambling
    also supports replication-based error estimates and extends
    applicabiltiy to unbounded integrands.

    References
    ----------
    .. [1] Halton, "On the efficiency of certain quasi-random sequences of
       points in evaluating multi-dimensional integrals", Numerische
       Mathematik, 1960.
    .. [2] A. B. Owen. "A randomized Halton algorithm in R",
       arXiv:1706.02808, 2017.

    Examples
    --------
    Generate samples from a low discrepancy sequence of Halton.

    >>> from scipy.stats import qmc
    >>> sampler = qmc.Halton(d=2, scramble=False)
    >>> sample = sampler.random(n=5)
    >>> sample
    array([[0.        , 0.        ],
           [0.5       , 0.33333333],
           [0.25      , 0.66666667],
           [0.75      , 0.11111111],
           [0.125     , 0.44444444]])

    Compute the quality of the sample using the discrepancy criterion.

    >>> qmc.discrepancy(sample)
    0.088893711419753

    If some wants to continue an existing design, extra points can be obtained
    by calling again `random`. Alternatively, you can skip some points like:

    >>> _ = sampler.fast_forward(5)
    >>> sample_continued = sampler.random(n=5)
    >>> sample_continued
    array([[0.3125    , 0.37037037],
           [0.8125    , 0.7037037 ],
           [0.1875    , 0.14814815],
           [0.6875    , 0.48148148],
           [0.4375    , 0.81481481]])

    Finally, samples can be scaled to bounds.

    >>> l_bounds = [0, 2]
    >>> u_bounds = [10, 5]
    >>> qmc.scale(sample_continued, l_bounds, u_bounds)
    array([[3.125     , 3.11111111],
           [8.125     , 4.11111111],
           [1.875     , 2.44444444],
           [6.875     , 3.44444444],
           [4.375     , 4.44444444]])

    TNr   r'   r   r:   r   r   r   r   r'   r(   c                  s*   t  j||d || _t|| _|| _d S Nr   r'   )superr   r'   r   r   r   r   r   r   r'   	__class__r*   r,   r     s    
zHalton.__init__rA   r;   r]   c                   s:    fddj D } j 7  _t|j jS )a%  Draw `n` in the half-open interval ``[0, 1)``.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            QMC sample.

        c              
     s.   g | ]&}t  t|jjtjd qS )r   )r   rU   r   r   r   r   r'   ).0Zbdimr^   r   r*   r,   
<listcomp>  s
   
z!Halton.random.<locals>.<listcomp>)r   r   r2   r   Treshaper   r   r^   r<   r*   r   r,   r5     s
    zHalton.random)rA   r   r   r   r   r   r5   __classcell__r*   r*   r   r,   r#     s
   Q	r#   c                      sF   e Zd ZdZdddddddd	 fd
dZddddddZ  ZS )r$   a
  Latin hypercube sampling (LHS).

    A Latin hypercube sample [1]_ generates :math:`n` points in
    :math:`[0,1)^{d}`. Each univariate marginal distribution is stratified,
    placing exactly one point in :math:`[j/n, (j+1)/n)` for
    :math:`j=0,1,...,n-1`. They are still applicable when :math:`n << d`.
    LHS is extremely effective on integrands that are nearly additive [2]_.
    LHS on :math:`n` points never has more variance than plain MC on
    :math:`n-1` points [3]_. There is a central limit theorem for LHS [4]_,
    but not necessarily for optimized LHS.

    Parameters
    ----------
    d : int
        Dimension of the parameter space.
    centered : bool, optional
        Center the point within the multi-dimensional grid. Default is False.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    References
    ----------
    .. [1] Mckay et al., "A Comparison of Three Methods for Selecting Values
       of Input Variables in the Analysis of Output from a Computer Code",
       Technometrics, 1979.
    .. [2] M. Stein, "Large sample properties of simulations using Latin
       hypercube sampling." Technometrics 29, no. 2: 143-151, 1987.
    .. [3] A. B. Owen, "Monte Carlo variance of scrambled net quadrature."
       SIAM Journal on Numerical Analysis 34, no. 5: 1884-1910, 1997
    .. [4]  Loh, W.-L. "On Latin hypercube sampling." The annals of statistics
       24, no. 5: 2058-2080, 1996.

    Examples
    --------
    Generate samples from a Latin hypercube generator.

    >>> from scipy.stats import qmc
    >>> sampler = qmc.LatinHypercube(d=2)
    >>> sample = sampler.random(n=5)
    >>> sample
    array([[0.1545328 , 0.53664833],  # random
           [0.84052691, 0.06474907],
           [0.52177809, 0.93343721],
           [0.68033825, 0.36265316],
           [0.26544879, 0.61163943]])

    Compute the quality of the sample using the discrepancy criterion.

    >>> qmc.discrepancy(sample)
    0.019558034794794565  # random

    Finally, samples can be scaled to bounds.

    >>> l_bounds = [0, 2]
    >>> u_bounds = [10, 5]
    >>> qmc.scale(sample, l_bounds, u_bounds)
    array([[1.54532796, 3.609945  ],  # random
           [8.40526909, 2.1942472 ],
           [5.2177809 , 4.80031164],
           [6.80338249, 3.08795949],
           [2.65448791, 3.83491828]])

    FN)centeredr'   r   r:   r   r   )r   r   r'   r(   c                  s   t  j||d || _d S r   )r   r   r   )r   r   r   r'   r   r*   r,   r   a  s    zLatinHypercube.__init__rA   r;   r]   c                 C  s   | j rd}n| jj|| jfd}ttd|d | jdf}t| jD ]}| j||ddf  qH|j	}|| | }|  j
|7  _
|S )a%  Draw `n` in the half-open interval ``[0, 1)``.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            LHS sample.

        rb   )sizerA   N)r   r   uniformr   r2   Ztiler   rd   shuffler   r   )r   r^   samplesZpermsre   r*   r*   r,   r5   h  s    zLatinHypercube.random)rA   r   r*   r*   r   r,   r$     s
   Er$   c                      s   e Zd ZU dZeZded< eZded< ddddd	d
dd fddZ	ddddZ
ddddddZdddddZd d fddZdd dddZ  ZS )r"   a  Engine for generating (scrambled) Sobol' sequences.

    Sobol' sequences are low-discrepancy, quasi-random numbers. Points
    can be drawn using two methods:

    * `random_base2`: safely draw :math:`n=2^m` points. This method
      guarantees the balance properties of the sequence.
    * `random`: draw an arbitrary number of points from the
      sequence. See warning below.

    Parameters
    ----------
    d : int
        Dimensionality of the sequence. Max dimensionality is 21201.
    scramble : bool, optional
        If True, use Owen scrambling. Otherwise no scrambling is done.
        Default is True.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Notes
    -----
    Sobol' sequences [1]_ provide :math:`n=2^m` low discrepancy points in
    :math:`[0,1)^{d}`. Scrambling them [2]_ makes them suitable for singular
    integrands, provides a means of error estimation, and can improve their
    rate of convergence.

    There are many versions of Sobol' sequences depending on their
    'direction numbers'. This code uses direction numbers from [3]_. Hence,
    the maximum number of dimension is 21201. The direction numbers have been
    precomputed with search criterion 6 and can be retrieved at
    https://web.maths.unsw.edu.au/~fkuo/sobol/.

    .. warning::

       Sobol' sequences are a quadrature rule and they lose their balance
       properties if one uses a sample size that is not a power of 2, or skips
       the first point, or thins the sequence [4]_.

       If :math:`n=2^m` points are not enough then one should take :math:`2^M`
       points for :math:`M>m`. When scrambling, the number R of independent
       replicates does not have to be a power of 2.

       Sobol' sequences are generated to some number :math:`B` of bits.
       After :math:`2^B` points have been generated, the sequence will repeat.
       Currently :math:`B=30`.

    References
    ----------
    .. [1] I. M. Sobol. The distribution of points in a cube and the accurate
       evaluation of integrals. Zh. Vychisl. Mat. i Mat. Phys., 7:784-802,
       1967.

    .. [2] Art B. Owen. Scrambling Sobol and Niederreiter-Xing points.
       Journal of Complexity, 14(4):466-489, December 1998.

    .. [3] S. Joe and F. Y. Kuo. Constructing sobol sequences with better
       two-dimensional projections. SIAM Journal on Scientific Computing,
       30(5):2635-2654, 2008.

    .. [4] Art B. Owen. On dropping the first Sobol' point. arXiv 2008.08051,
       2020.

    Examples
    --------
    Generate samples from a low discrepancy sequence of Sobol'.

    >>> from scipy.stats import qmc
    >>> sampler = qmc.Sobol(d=2, scramble=False)
    >>> sample = sampler.random_base2(m=3)
    >>> sample
    array([[0.   , 0.   ],
           [0.5  , 0.5  ],
           [0.75 , 0.25 ],
           [0.25 , 0.75 ],
           [0.375, 0.375],
           [0.875, 0.875],
           [0.625, 0.125],
           [0.125, 0.625]])

    Compute the quality of the sample using the discrepancy criterion.

    >>> qmc.discrepancy(sample)
    0.013882107204860938

    To continue an existing design, extra points can be obtained
    by calling again `random_base2`. Alternatively, you can skip some
    points like:

    >>> _ = sampler.reset()
    >>> _ = sampler.fast_forward(4)
    >>> sample_continued = sampler.random_base2(m=2)
    >>> sample_continued
    array([[0.375, 0.375],
           [0.875, 0.875],
           [0.625, 0.125],
           [0.125, 0.625]])

    Finally, samples can be scaled to bounds.

    >>> l_bounds = [0, 2]
    >>> u_bounds = [10, 5]
    >>> qmc.scale(sample_continued, l_bounds, u_bounds)
    array([[3.75 , 3.125],
           [8.75 , 4.625],
           [6.25 , 2.375],
           [1.25 , 3.875]])

    zClassVar[int]MAXDIMMAXBITTNr   r   r:   r   r   r   c                  s   t  j||d || jkr*td| jt  tj|| jft	d| _
t| j
| |shtj|t	d| _n|   | j | _| jd| j  dd| _d S )Nr   z'Maximum supported dimensionality is {}.ra   r?   rA   rS   )r   r   r   r6   formatr   r2   r   r   rU   _svr   _shift	_scrambler   _quasir   _first_pointr   r   r*   r,   r     s    

zSobol.__init__r   c                 C  s~   t t| jd| j| jftddt j| jtd | _| j	 | _
t t| jd| j| j| jftd}t| j|| j d| _dS )zScramble the sequence.r?   )r   rQ   ra   r   N)r2   dotr   r   r   r   rU   r   r   r   r   Ztrilr   r   r   )r   Zltmr*   r*   r,   r     s    zSobol._scramblerA   r;   r]   c                 C  s   t j|| jftd}| jdkr||d @ dks8td |dkrH| j}qt|d | j| j| j	| j
| t | j|gd| }nt|| jd | j| j	| j
| |  j|7  _|S )a$  Draw next point(s) in the Sobol' sequence.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            Sobol' sample.

        ra   r   rA   zEThe balance properties of Sobol' points require n to be a power of 2.N)r2   emptyr   rN   r   warningswarnr   r   r   r   Zconcatenater   r*   r*   r,   r5   #  s    

zSobol.random)mr(   c                 C  s@   d| }| j | }||d @ dks6td| j ||| |S )a  Draw point(s) from the Sobol' sequence.

        This function draws :math:`n=2^m` points in the parameter space
        ensuring the balance properties of the sequence.

        Parameters
        ----------
        m : int
            Logarithm in base 2 of the number of samples; i.e., n = 2^m.

        Returns
        -------
        sample : array_like (n, d)
            Sobol' sample.

        r?   rA   r   zThe balance properties of Sobol' points require n to be a power of 2. {0} points have been previously generated, then: n={0}+2**{1}={2}. If you still want to do this, the function 'Sobol.random()' can be used.)r   r6   r   r5   )r   r   r^   Ztotal_nr*   r*   r,   random_base2F  s    
zSobol.random_base2c                   s   t    | j | _| S )zReset the engine to base state.

        Returns
        -------
        engine : Sobol
            Engine reset to its base state.

        )r   r   r   r   r   r   r   r*   r,   r   d  s    	
zSobol.resetc                 C  sV   | j dkr(t|d | j | j| j| j nt|| j d | j| j| j |  j |7  _ | S )a   Fast-forward the sequence by `n` positions.

        Parameters
        ----------
        n : int
            Number of points to skip in the sequence.

        Returns
        -------
        engine: Sobol
            The fast-forwarded engine.

        r   rA   )r   r   r   r   r   r   r*   r*   r,   r   q  s    
zSobol.fast_forward)rA   )r   r   r   r   r   r   __annotations__r   r   r   r   r5   r   r   r   r   r*   r*   r   r,   r"     s   
r#r"   c                
      s   e Zd ZdZdddddddddddd	d
d fddZddddddZd d fddZdddddZddddddZ  Z	S )r&   ai  QMC sampling from a multivariate Normal :math:`N(\mu, \Sigma)`.

    Parameters
    ----------
    mean : array_like (d,)
        The mean vector. Where ``d`` is the dimension.
    cov : array_like (d, d), optional
        The covariance matrix. If omitted, use `cov_root` instead.
        If both `cov` and `cov_root` are omitted, use the identity matrix.
    cov_root : array_like (d, d'), optional
        A root decomposition of the covariance matrix, where ``d'`` may be less
        than ``d`` if the covariance is not full rank. If omitted, use `cov`.
    inv_transform : bool, optional
        If True, use inverse transform instead of Box-Muller. Default is True.
    engine : QMCEngine, optional
        Quasi-Monte Carlo engine sampler. If None, `Sobol` is used.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Examples
    --------
    >>> import matplotlib.pyplot as plt
    >>> from scipy.stats import qmc
    >>> engine = qmc.MultivariateNormalQMC(mean=[0, 5], cov=[[1, 0], [0, 1]])
    >>> sample = engine.random(512)
    >>> _ = plt.scatter(sample[:, 0], sample[:, 1])
    >>> plt.show()

    NT)cov_rootinv_transformenginer'   r9   zOptional[npt.ArrayLike]r:   Optional[QMCEngine]r   r   )meancovr   r   r   r'   r(   c                  s  t j|ddd}|jd }|d urt j|ddd}|jd |jd ksNtdt || sftdzt j| }W n\ t jjy   t j	|\}}	t 
|dkstd	t |d
d }|	t |  }Y n0 n8|d urt |}|jd |jd kstdnd }t j||d || _|sBdt|d  }
n|}
|d u rbt|
d|d| _n<t|tr|jdkr|j|krtd|| _ntd|| _|| _d S )NFrA   r   Zndminr   r?   z/Dimension mismatch between mean and covariance.z#Covariance matrix is not symmetric.g:0yEzCovariance matrix not PSD.g        r   Tr   r   r'   zPDimension of `engine` must be consistent with dimensions of mean and covariance.F`engine` must be an instance of `scipy.stats.qmc.QMCEngine` or `None`.)r2   r   rG   r6   ZallcloseZ	transposeZlinalgZcholeskyZLinAlgErrorZeighrE   ZclipsqrtZ
atleast_2dr   r   _inv_transformmathceilr"   r   r/   r!   r   _mean_corr_matrix)r   r   r   r   r   r   r'   r   ZeigvalZeigvecZ
engine_dimr   r*   r,   r     sF    




zMultivariateNormalQMC.__init__rA   r   r;   r]   c                 C  s"   |  |}|  j|7  _| |S )a%  Draw `n` QMC samples from the multivariate Normal.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            Sample.

        )_standard_normal_samplesr   
_correlate)r   r^   base_samplesr*   r*   r,   r5     s    
zMultivariateNormalQMC.randomr   c                   s   t    | j  | S )zReset the engine to base state.

        Returns
        -------
        engine : MultivariateNormalQMC
            Engine reset to its base state.

        r   r   r   r   r   r*   r,   r     s    	

zMultivariateNormalQMC.reset)r   r(   c                 C  s(   | j d ur|| j  | j S || j S d S r)   )r   r   )r   r   r*   r*   r,   r     s    
z MultivariateNormalQMC._correlatec           	      C  s   | j |}| jr*tjdd|d   S td|jd d}t	dt
|dd|f  }dtj |ddd| f  }t|}t|}t|| || gd|d}|ddd| jf S dS )	a3  Draw `n` QMC samples from the standard Normal :math:`N(0, I_d)`.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        sample : array_like (n, d)
            Sample.

        rb   gA?r   rS   r?   NrA   )r   r5   r   statsZnormZppfr2   r   rG   r   logr   picossinstackr   r   )	r   r^   r   ZevenZRsZthetasr   r   Ztransf_samplesr*   r*   r,   r     s     

z.MultivariateNormalQMC._standard_normal_samples)N)rA   )rA   )
r   r   r   r   r   r5   r   r   r   r   r*   r*   r   r,   r&     s   # "<r&   c                      sX   e Zd ZdZdddddddd fd	d
ZddddddZd d fddZ  ZS )r%   a:  QMC sampling from a multinomial distribution.

    Parameters
    ----------
    pvals : array_like (k,)
        Vector of probabilities of size ``k``, where ``k`` is the number
        of categories. Elements must be non-negative and sum to 1.
    engine : QMCEngine, optional
        Quasi-Monte Carlo engine sampler. If None, `Sobol` is used.
    seed : {None, int, `numpy.random.Generator`}, optional
        If `seed` is None the `numpy.random.Generator` singleton is used.
        If `seed` is an int, a new ``Generator`` instance is used,
        seeded with `seed`.
        If `seed` is already a ``Generator`` instance then that instance is
        used.

    Examples
    --------
    >>> from scipy.stats import qmc
    >>> engine = qmc.MultinomialQMC(pvals=[0.2, 0.4, 0.4])
    >>> sample = engine.random(10)

    N)r   r'   r9   r   r   r   )pvalsr   r'   r(   c                  s   t j|ddd| _t |dk r(tdt t |dsBtd|d u r\tdd|d| _n,t	|t
r|jdkrxtd	|| _ntd
t jd|d d S )NFrA   r   r   z'Elements of pvals must be non-negative.z Elements of pvals must sum to 1.Tr   z Dimension of `engine` must be 1.r   r   )r2   r   r   minr6   isclosesumr"   r   r/   r!   r   r   r   )r   r   r   r'   r   r*   r,   r   H  s    

zMultinomialQMC.__init__rA   r   r;   r]   c                 C  sd   | j | }tj| jtd}ttj| jtd| tj	| jt
d}t||| |  j|7  _|S )aJ  Draw `n` QMC samples from the multinomial distribution.

        Parameters
        ----------
        n : int, optional
            Number of samples to generate in the parameter space. Default is 1.

        Returns
        -------
        samples : array_like (pvals,)
            Vector of size ``p`` summing to `n`.

        ra   )r   r5   Zravelr2   Z
empty_liker   rN   r   r   Z
zeros_likerU   r   r   )r   r^   Z
base_drawsZp_cumulativer<   r*   r*   r,   r5   ]  s    zMultinomialQMC.randomr   c                   s   t    | j  | S )zReset the engine to base state.

        Returns
        -------
        engine : MultinomialQMC
            Engine reset to its base state.

        r   r   r   r*   r,   r   s  s    	

zMultinomialQMC.reset)rA   )r   r   r   r   r   r5   r   r   r*   r*   r   r,   r%   /  s   r%   ).)N)r?   )=r   
__future__r   rV   r   r0   abcr   r   r   typingr   r   r   r   r	   r   Znumpyr2   Znumpy.typingZnptZtyping_extensionsr
   Zscipy._lib._utilr   r   r   r   Zscipy.statsr   r   Zscipy.stats._sobolr   r   r   r   r   r   r   r   r   Zscipy.stats._qmc_cyr   r   r   r   r   __all__r-   r   r   r    rg   r   r   r!   r#   r$   r"   r&   r%   r*   r*   r*   r,   <module>   sb   ,	
*\ < ) A si   '