o
    ҷh}                     @  sz  d Z ddlmZ ddlmZmZ ddlmZmZm	Z	m
Z
 ddlZddlmZmZmZ ddlmZ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  ddl!m"Z" ddl#m$Z$m%Z%m&Z& erjddl'm(Z( dddZ)dddZ*ddddZ+g d Z,g d!Z-dd$d%Z.dd)d*Z/dd-d.Z0dd2d3Z1d4d5 Z2dd6d7Z3	8		9		dddBdCZ4ddDdEZ5	8		9				dddJdKZ6			dddOdPZ7			dddVdWZ8		dddXdYZ9		Z	ddd]d^Z:ddbdcZ;	d			dddedfZ<	dddhdiZ=ddldmZ>e>		dddodpZ?e>		dddqdrZ@e>		dddsdtZAe>	dddudvZBe?e@dwZCdddzd{ZDdd}d~ZEdddZFdddZGdS )z$
Routines for filling missing data.
    )annotations)partialwraps)TYPE_CHECKINGAnyLiteralcastN)NaTalgoslib)	ArrayLikeAxisIntFReindexMethodnpt)import_optional_dependency)infer_dtype_from)is_array_likeis_numeric_dtypeis_numeric_v_string_likeis_object_dtypeneeds_i8_conversion)DatetimeTZDtype)is_valid_na_for_dtypeisnana_value_for_dtypeIndexmasknpt.NDArray[np.bool_]lengthintc                 C  s8   t | rt| |krtdt|  d| | | } | S )zJ
    Validate the size of the values passed to ExtensionArray.fillna.
    z'Length of 'value' does not match. Got (z)  expected )r   len
ValueError)valuer   r     r%   F/var/www/html/venv/lib/python3.10/site-packages/pandas/core/missing.pycheck_value_size4   s   r'   arrr   returnc                 C  s  t |\}}t|tjrtj||d}n| }t|s |g}|j||dd}d}t	| jr6d}t
|  }t
|}||  }tj| jtd}|D ]1}	t| |	rQqI|retj| jtjd}
| | |	k|
|< n| |	k}
t|
tjsv|
jtdd}
||
O }qI| r|t
| O }|S )a	  
    Return a masking array of same size/shape as arr
    with entries equaling any member of values_to_mask set to True

    Parameters
    ----------
    arr : ArrayLike
    values_to_mask: list, tuple, or scalar

    Returns
    -------
    np.ndarray[bool]
    )dtypeF)r*   copyT)r*   na_value)r   
isinstancenpr*   arrayconstruct_array_typer   is_list_like_from_sequencer   r   zerosshapeboolr   bool_ndarrayto_numpyany)r(   values_to_maskr*   clspotential_naarr_maskna_masknonnar   xnew_maskr%   r%   r&   mask_missingC   s6   





rB   Fmethodstrallow_nearestr5   c                 C  sj   t | tr|  } | dkrd} n| dkrd} ddg}d}|r%|d d}| |vr3td| d	|  | S )
Nffillpadbfillbackfillzpad (ffill) or backfill (bfill)nearestz(pad (ffill), backfill (bfill) or nearestzInvalid fill method. Expecting z. Got )r-   rD   lowerappendr#   )rC   rE   valid_methods	expectingr%   r%   r&   clean_fill_method   s   

rO   )lineartimeindexvalues)rJ   zeroslinear	quadraticcubicbarycentrickroghspline
polynomialfrom_derivativespiecewise_polynomialpchipakimacubicsplinerR   r   c                 K  sh   | d}| dv r|d u rtdtt }| |vr$td| d|  d| dv r2|js2t|  d| S )	Norder)rZ   r[   z7You must specify the order of the spline or polynomial.zmethod must be one of z. Got 'z
' instead.)rY   r]   r^   z4 interpolation requires that the index be monotonic.)getr#   
NP_METHODS
SP_METHODSis_monotonic_increasing)rC   rR   kwargsra   validr%   r%   r&   clean_interp_method   s   
rh   howis_valid
int | Nonec                 C  s   | dv sJ t |dkrdS |jdkr|jdd}| dkr&|dd  }n| dkr9t |d |ddd	   }|| }|sAdS |S )
a+  
    Retrieves the positional index of the first valid value.

    Parameters
    ----------
    how : {'first', 'last'}
        Use this parameter to change between the first or last valid index.
    is_valid: np.ndarray
        Mask to find na_values.

    Returns
    -------
    int or None
    )firstlastr   N      axisrl   rm   )r"   ndimr9   argmax)ri   rj   idxpos	chk_notnar%   r%   r&   find_valid_index   s   
rw   limit_direction&Literal['forward', 'backward', 'both']c                 C  s2   g d}|   } | |vrtd| d|  d| S )N)forwardbackwardbothz*Invalid limit_direction: expecting one of z, got 'z'.rK   r#   )rx   valid_limit_directionsr%   r%   r&   validate_limit_direction   s   r   
limit_area
str | None#Literal['inside', 'outside'] | Nonec                 C  s:   | d urddg}|   } | |vrtd| d|  d| S )Ninsideoutsidez%Invalid limit_area: expecting one of z, got .r}   )r   valid_limit_areasr%   r%   r&   validate_limit_area   s   r   c                 C  sd   | d u r|dv rd} | S d} | S |dv r | dkr t d| d|dv r0| dkr0t d| d| S )N)rI   rH   r{   rz   )rG   rF   z0`limit_direction` must be 'forward' for method ``z1`limit_direction` must be 'backward' for method `)r#   )rx   rC   r%   r%   r&   infer_limit_direction   s   


r   c                 C  s   | dkrddl m} |tt|}n$h d}t|jp)t|jtp)t	
|jd}| |vr8|s8td|  dt| rBtd|S )	NrP   r   r   >   rQ   rR   rS   rJ   mMz9Index column must be numeric or datetime type when using z_ method other than linear. Try setting a numeric or datetime index column before interpolating.zkInterpolation with NaNs in the index has not been implemented. Try filling those NaNs before interpolating.)pandasr   r.   aranger"   r   r*   r-   r   r   is_np_dtyper#   r   r9   NotImplementedError)rC   rR   r   methodsis_numeric_or_datetimer%   r%   r&   get_interp_index  s(   

r   rP   rz   data
np.ndarrayrq   r   limit
fill_value
Any | NoneNonec           
        s   t |fi  t | jrt| jdd dkr%t|js#tddtt|tj	ddt
|d fdd}	t|	||  dS )z
    Column-wise application of _interpolate_1d.

    Notes
    -----
    Alters 'data' in-place.

    The signature does differ from _interpolate_1d because it only
    includes what is needed for Block.interpolate.
    F)compatrQ   zStime-weighted interpolation only works on Series or DataFrames with a DatetimeIndexrS   N)nobsr   yvaluesr   r)   r   c                   s$   t d|  dd d S )NF)indicesr   rC   r   rx   r   r   bounds_errorr%   )_interpolate_1d)r   r   r   rf   r   limit_area_validatedrx   rC   r%   r&   func]  s   	
z$interpolate_2d_inplace.<locals>.func)r   r   r)   r   )rh   r   r*   r   r   r#   r   r   r
   validate_limit_index_to_interp_indicesr.   apply_along_axis)
r   rR   rq   rC   r   rx   r   r   rf   r   r%   r   r&   interpolate_2d_inplace1  s   

r   c                 C  sb   | j }t|jr|d}|dkr|}ttj|}|S t|}|dv r/|jtjkr/t	
|}|S )zE
    Convert Index to ndarray of indices to pass to NumPy/SciPy.
    i8rP   )rS   rR   )_valuesr   r*   viewr   r.   r7   asarrayobject_r   maybe_convert_objects)rR   rC   xarrindsr%   r%   r&   r   u  s   



r   r   r   r   ra   c	                 K  s  t |}
|
 }| sdS | rdS tt|
}td|d}|du r&d}tt|}td|d}|du r:t|}ttd| t|}|dkrT|tt	|
|dB }n|dkrc|tt	|
d|B }ntt	|
||}|d	krv|||B O }n|d
kr|| | }||O }t
|}|jjdv }|r|d}|tv rt| | }t| |
 | | | || | ||
< nt| | || | |
 f||||d|	||
< |rtj||< dS tj||< dS )a  
    Logic for the 1-d interpolation.  The input
    indices and yvalues will each be 1-d arrays of the same length.

    Bounds_error is currently hardcoded to False since non-scipy ones don't
    take it as an argument.

    Notes
    -----
    Fills 'yvalues' in-place.
    Nrl   ri   rj   r   rm   ro   rz   r{   r   r   r   r   )rC   r   r   ra   )r   r9   allsetr.   flatnonzerorw   ranger"   _interp_limitsortedr*   kindr   rc   argsortinterp_interpolate_scipy_wrapperr	   r$   nan)r   r   rC   r   rx   r   r   r   ra   rf   invalidrg   all_nansfirst_valid_index
start_nanslast_valid_indexend_nanspreserve_nansmid_nansis_datetimelikeindexerr%   r%   r&   r     sf   




r   r@   ynew_xc                 K  s"  | d}t d|d ddlm}	 t|}|	j|	jtttt	|	j
d}
g d}||v rD|dkr2|}n|}|	j| ||||d	}||}|S |d
krit|sP|dkrWtd| |	j| |fd|i|}||}|S | jjsq|  } |jjsy| }|jjs| }|
| }|| ||fi |}|S )z
    Passed off to scipy.interpolate.interp1d. method is scipy's kind.
    Returns an array interpolated at new_x.  Add any new methods to
    the list in _clean_interp_method.
    z interpolation requires SciPy.scipy)extrar   interpolate)rX   rY   r\   r]   r`   r_   r^   )rJ   rT   rU   rV   rW   r[   r[   )r   r   r   rZ   z;order needs to be specified and greater than 0; got order: k)r   r   r   r.   r   barycentric_interpolatekrogh_interpolate_from_derivatives_cubicspline_interpolate_akima_interpolatepchip_interpolateinterp1dr   r#   UnivariateSplineflags	writeabler+   )r@   r   r   rC   r   r   ra   rf   r   r   alt_methodsinterp1d_methodsr   terpnew_yr%   r%   r&   r     sN   



r   xiyiderint | list[int] | Noneextrapolatec           	      C  s4   ddl m} |jj}|| |dd||d}||S )a  
    Convenience function for interpolate.BPoly.from_derivatives.

    Construct a piecewise polynomial in the Bernstein basis, compatible
    with the specified values and derivatives at breakpoints.

    Parameters
    ----------
    xi : array-like
        sorted 1D array of x-coordinates
    yi : array-like or list of array-likes
        yi[i][j] is the j-th derivative known at xi[i]
    order: None or int or array-like of ints. Default: None.
        Specifies the degree of local polynomials. If not None, some
        derivatives are ignored.
    der : int or list
        How many derivatives to extract; None for all potentially nonzero
        derivatives (that is a number equal to the number of points), or a
        list of derivatives to extract. This number includes the function
        value as 0th derivative.
     extrapolate : bool, optional
        Whether to extrapolate to ouf-of-bounds points based on first and last
        intervals, or to return NaNs. Default: True.

    See Also
    --------
    scipy.interpolate.BPoly.from_derivatives

    Returns
    -------
    y : scalar or array-like
        The result, of length R or length M or M by R.
    r   r   rr   ro   )ordersr   )r   r   BPolyr\   reshape)	r   r   r@   ra   r   r   r   rC   mr%   r%   r&   r   >  s   )r   c                 C  s(   ddl m} |j| ||d}|||dS )aQ  
    Convenience function for akima interpolation.
    xi and yi are arrays of values used to approximate some function f,
    with ``yi = f(xi)``.

    See `Akima1DInterpolator` for details.

    Parameters
    ----------
    xi : np.ndarray
        A sorted list of x-coordinates, of length N.
    yi : np.ndarray
        A 1-D array of real values.  `yi`'s length along the interpolation
        axis must be equal to the length of `xi`. If N-D array, use axis
        parameter to select correct axis.
    x : np.ndarray
        Of length M.
    der : int, optional
        How many derivatives to extract; None for all potentially
        nonzero derivatives (that is a number equal to the number
        of points), or a list of derivatives to extract. This number
        includes the function value as 0th derivative.
    axis : int, optional
        Axis in the yi array corresponding to the x-coordinate values.

    See Also
    --------
    scipy.interpolate.Akima1DInterpolator

    Returns
    -------
    y : scalar or array-like
        The result, of length R or length M or M by R,

    r   r   rp   )nu)r   r   Akima1DInterpolator)r   r   r@   r   rq   r   Pr%   r%   r&   r   p  s   *r   
not-a-knotbc_typestr | tuple[Any, Any]c                 C  s(   ddl m} |j| ||||d}||S )ag  
    Convenience function for cubic spline data interpolator.

    See `scipy.interpolate.CubicSpline` for details.

    Parameters
    ----------
    xi : np.ndarray, shape (n,)
        1-d array containing values of the independent variable.
        Values must be real, finite and in strictly increasing order.
    yi : np.ndarray
        Array containing values of the dependent variable. It can have
        arbitrary number of dimensions, but the length along ``axis``
        (see below) must match the length of ``x``. Values must be finite.
    x : np.ndarray, shape (m,)
    axis : int, optional
        Axis along which `y` is assumed to be varying. Meaning that for
        ``x[i]`` the corresponding values are ``np.take(y, i, axis=axis)``.
        Default is 0.
    bc_type : string or 2-tuple, optional
        Boundary condition type. Two additional equations, given by the
        boundary conditions, are required to determine all coefficients of
        polynomials on each segment [2]_.
        If `bc_type` is a string, then the specified condition will be applied
        at both ends of a spline. Available conditions are:
        * 'not-a-knot' (default): The first and second segment at a curve end
          are the same polynomial. It is a good default when there is no
          information on boundary conditions.
        * 'periodic': The interpolated functions is assumed to be periodic
          of period ``x[-1] - x[0]``. The first and last value of `y` must be
          identical: ``y[0] == y[-1]``. This boundary condition will result in
          ``y'[0] == y'[-1]`` and ``y''[0] == y''[-1]``.
        * 'clamped': The first derivative at curves ends are zero. Assuming
          a 1D `y`, ``bc_type=((1, 0.0), (1, 0.0))`` is the same condition.
        * 'natural': The second derivative at curve ends are zero. Assuming
          a 1D `y`, ``bc_type=((2, 0.0), (2, 0.0))`` is the same condition.
        If `bc_type` is a 2-tuple, the first and the second value will be
        applied at the curve start and end respectively. The tuple values can
        be one of the previously mentioned strings (except 'periodic') or a
        tuple `(order, deriv_values)` allowing to specify arbitrary
        derivatives at curve ends:
        * `order`: the derivative order, 1 or 2.
        * `deriv_value`: array-like containing derivative values, shape must
          be the same as `y`, excluding ``axis`` dimension. For example, if
          `y` is 1D, then `deriv_value` must be a scalar. If `y` is 3D with
          the shape (n0, n1, n2) and axis=2, then `deriv_value` must be 2D
          and have the shape (n0, n1).
    extrapolate : {bool, 'periodic', None}, optional
        If bool, determines whether to extrapolate to out-of-bounds points
        based on first and last intervals, or to return NaNs. If 'periodic',
        periodic extrapolation is used. If None (default), ``extrapolate`` is
        set to 'periodic' for ``bc_type='periodic'`` and to True otherwise.

    See Also
    --------
    scipy.interpolate.CubicHermiteSpline

    Returns
    -------
    y : scalar or array-like
        The result, of shape (m,)

    References
    ----------
    .. [1] `Cubic Spline Interpolation
            <https://en.wikiversity.org/wiki/Cubic_Spline_Interpolation>`_
            on Wikiversity.
    .. [2] Carl de Boor, "A Practical Guide to Splines", Springer-Verlag, 1978.
    r   r   )rq   r   r   )r   r   CubicSpline)r   r   r@   rq   r   r   r   r   r%   r%   r&   r     s
   M
r   rS   Literal['pad', 'backfill']Literal['inside', 'outside']c                 C  s   t | }| }| sWtd|d}|du rd}td|d}|du r%t| }t| ||d |dkr9d|||d	 < n|d
krLd |d|< ||d	 d< ntdtj| |< dS dS )a  
    Apply interpolation and limit_area logic to values along a to-be-specified axis.

    Parameters
    ----------
    values: np.ndarray
        Input array.
    method: str
        Interpolation method. Could be "bfill" or "pad"
    limit: int, optional
        Index limit on interpolation.
    limit_area: {'inside', 'outside'}
        Limit area for interpolation.

    Notes
    -----
    Modifies values in-place.
    rl   r   Nr   rm   )rC   r   r   Fro   r   z*limit_area should be 'inside' or 'outside')r   r   rw   r"   pad_or_backfill_inplacer#   r.   r   )rS   rC   r   r   r   rj   rl   rm   r%   r%   r&   _interpolate_with_limit_area  s*   r   rG   c                 C  s   |durt tt|||d||  dS |dkrdd ndd }| jdkr6|dkr,td| td	| j } t	|}|| }t
|d
d}|||d dS )a  
    Perform an actual interpolation of values, values will be make 2-d if
    needed fills inplace, returns the result.

    Parameters
    ----------
    values: np.ndarray
        Input array.
    method: str, default "pad"
        Interpolation method. Could be "bfill" or "pad"
    axis: 0 or 1
        Interpolation axis
    limit: int, optional
        Index limit on interpolation.
    limit_area: str, optional
        Limit area for interpolation. Can be "inside" or "outside"

    Notes
    -----
    Modifies values in-place.
    N)rC   r   r   r   c                 S  s   | S Nr%   r@   r%   r%   r&   <lambda>\  s    z)pad_or_backfill_inplace.<locals>.<lambda>c                 S  s   | j S r   )Tr   r%   r%   r&   r   \  s    ro   z0cannot interpolate on a ndim == 1 with axis != 0ro   rn   )rs   r   )r.   r   r   r   rs   AssertionErrorr   tupler4   rO   get_fill_func)rS   rC   rq   r   r   transftvaluesr   r%   r%   r&   r   +  s,   	
r   npt.NDArray[np.bool_] | Nonec                 C  s    |d u rt | }|tj}|S r   )r   r   r.   uint8)rS   r   r%   r%   r&   _fillna_prepm  s   r   r   r   c                   s"   t  dd fdd}tt|S )z>
    Wrapper to handle datetime64 and timedelta64 dtypes.
    Nr   rk   c                   sP   t | jr!|d u rt| } | d||d\}}|| j|fS  | ||dS )Nr   )r   r   )r   r*   r   r   )rS   r   r   resultr   r%   r&   new_func~  s   
z&_datetimelike_compat.<locals>.new_funcNN)r   rk   )r   r   r   )r   r   r%   r   r&   _datetimelike_compaty  s   
r   (tuple[np.ndarray, npt.NDArray[np.bool_]]c                 C  "   t | |}tj| ||d | |fS Nr   )r   r
   pad_inplacerS   r   r   r%   r%   r&   _pad_1d     
r  c                 C  r   r  )r   r
   backfill_inplacer  r%   r%   r&   _backfill_1d  r  r  c                 C  2   t | |}| jrtj| ||d | |fS 	 | |fS r  )r   sizer
   pad_2d_inplacer  r%   r%   r&   _pad_2d  s   
r  c                 C  r  r  )r   r	  r
   backfill_2d_inplacer  r%   r%   r&   _backfill_2d  s   
r  rG   rI   ro   rs   c                 C  s&   t | } |dkrt|  S ttd|  S )Nro   r  )rO   _fill_methodsr  r  )rC   rs   r%   r%   r&   r     s   r   ReindexMethod | Nonec                 C  s   | d u rd S t | ddS )NT)rE   )rO   )rC   r%   r%   r&   clean_reindex_fill_method  s   r  r   fw_limitbw_limitc                   s   t |  t }t }d	 fdd}|dur(|dkr#tt| d }n|| |}|durO|dkr2|S t|| ddd |}t d t| }|dkrO|S ||@ S )
ak  
    Get indexers of values that won't be filled
    because they exceed the limits.

    Parameters
    ----------
    invalid : np.ndarray[bool]
    fw_limit : int or None
        forward limit to index
    bw_limit : int or None
        backward limit to index

    Returns
    -------
    set of indexers

    Notes
    -----
    This is equivalent to the more readable, but slower

    .. code-block:: python

        def _interp_limit(invalid, fw_limit, bw_limit):
            for x in np.where(invalid)[0]:
                if invalid[max(0, x - fw_limit):x + bw_limit + 1].all():
                    yield x
    r   r!   c                   s`   t | }t| |d d}tt|d | tt| d |d    dkd B }|S )Nro   r   )min_rolling_windowr   r   r.   wherecumsum)r   r   windowedidxNr%   r&   inner  s   
"z_interp_limit.<locals>.innerNr   rr   ro   )r   r!   )r"   r   r.   r  listr   )r   r  r  f_idxb_idxr  	b_idx_invr%   r  r&   r     s    !
r   awindowc                 C  sJ   | j dd | j d | d |f }| j| jd f }tjjj| ||dS )z
    [True, True, False, True, False], 2 ->

    [
        [True,  True],
        [True, False],
        [False, True],
        [True, False],
    ]
    Nrr   ro   )r4   strides)r4   r#  r.   r   stride_tricks
as_strided)r!  r"  r4   r#  r%   r%   r&   r    s   $r  )r   r   r    r!   )r(   r   r)   r   )F)rC   rD   rE   r5   )rC   rD   rR   r   r)   rD   )ri   rD   rj   r   r)   rk   )rx   rD   r)   ry   )r   r   r)   r   )rR   r   r)   r   )rP   Nrz   NN)r   r   rR   r   rq   r   rC   rD   r   rk   rx   rD   r   r   r   r   r)   r   )rR   r   rC   rD   r)   r   )rP   Nrz   NNFN)r   r   r   r   rC   rD   r   rk   rx   rD   r   r   r   r   r   r5   ra   rk   r)   r   )NFN)
r@   r   r   r   r   r   rC   rD   r   r5   )Nr   F)
r   r   r   r   r@   r   r   r   r   r5   )r   r   )
r   r   r   r   r@   r   r   r   rq   r   )r   r   N)
r   r   r   r   r@   r   rq   r   r   r   )
rS   r   rC   r   r   rk   r   r   r)   r   )rG   r   NN)rS   r   rC   r   rq   r   r   rk   r   r   r)   r   r   )r   r   r)   r   )r   r   r)   r   r   )rS   r   r   rk   r   r   r)   r   )rS   r   r   rk   r   r   )r   rk   r   r   r   )rs   r!   )r)   r  )r   r   r  rk   r  rk   )r!  r   r"  r!   r)   r   )H__doc__
__future__r   	functoolsr   r   typingr   r   r   r   numpyr.   pandas._libsr	   r
   r   pandas._typingr   r   r   r   r   pandas.compat._optionalr   pandas.core.dtypes.castr   pandas.core.dtypes.commonr   r   r   r   r   pandas.core.dtypes.dtypesr   pandas.core.dtypes.missingr   r   r   r   r   r'   rB   rO   rc   rd   rh   rw   r   r   r   r   r   r   r   r   r   r   r   r   r   r   r   r  r  r  r  r  r   r  r   r  r%   r%   r%   r&   <module>   s    

<


&

#
DqK65
V6C





A