a
    hvg                     @   s
  d dl mZ d dlZd dlmZ d dlmZmZmZm	Z	 d dl
mZmZ d dlmZ d dlZddlmZ d	Zzd dlmZ W n ey   d
ZY n0 e Zg dZG dd deZdd Zdd Zdd ZdddZdddde fddZdddZ dd Z!d ddZ"dS )!    )warnN)asarray)issparseSparseEfficiencyWarning
csc_matrix
csr_matrix)is_pydata_spmatrixconvert_pydata_sparse_to_scipy)LinAlgError   )_superluFT)
use_solverspsolvespluspilu
factorizedMatrixRankWarningspsolve_triangularc                   @   s   e Zd ZdS )r   N)__name__
__module____qualname__ r   r   `/var/www/html/assistant/venv/lib/python3.9/site-packages/scipy/sparse/linalg/_dsolve/linsolve.pyr      s   r   c                  K   s6   d| v r| d t  d< tr2d| v r2tj| d d dS )as	  
    Select default sparse direct solver to be used.

    Parameters
    ----------
    useUmfpack : bool, optional
        Use UMFPACK [1]_, [2]_, [3]_, [4]_. over SuperLU. Has effect only
        if ``scikits.umfpack`` is installed. Default: True
    assumeSortedIndices : bool, optional
        Allow UMFPACK to skip the step of sorting indices for a CSR/CSC matrix.
        Has effect only if useUmfpack is True and ``scikits.umfpack`` is
        installed. Default: False

    Notes
    -----
    The default sparse solver is UMFPACK when available
    (``scikits.umfpack`` is installed). This can be changed by passing
    useUmfpack = False, which then causes the always present SuperLU
    based solver to be used.

    UMFPACK requires a CSR/CSC matrix to have sorted column/row indices. If
    sure that the matrix fulfills this, pass ``assumeSortedIndices=True``
    to gain some speed.

    References
    ----------
    .. [1] T. A. Davis, Algorithm 832:  UMFPACK - an unsymmetric-pattern
           multifrontal method with a column pre-ordering strategy, ACM
           Trans. on Mathematical Software, 30(2), 2004, pp. 196--199.
           https://dl.acm.org/doi/abs/10.1145/992200.992206

    .. [2] T. A. Davis, A column pre-ordering strategy for the
           unsymmetric-pattern multifrontal method, ACM Trans.
           on Mathematical Software, 30(2), 2004, pp. 165--195.
           https://dl.acm.org/doi/abs/10.1145/992200.992205

    .. [3] T. A. Davis and I. S. Duff, A combined unifrontal/multifrontal
           method for unsymmetric sparse matrices, ACM Trans. on
           Mathematical Software, 25(1), 1999, pp. 1--19.
           https://doi.org/10.1145/305658.287640

    .. [4] T. A. Davis and I. S. Duff, An unsymmetric-pattern multifrontal
           method for sparse LU factorization, SIAM J. Matrix Analysis and
           Computations, 18(1), 1997, pp. 140--158.
           https://doi.org/10.1137/S0895479894246905T.

    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse.linalg import use_solver, spsolve
    >>> from scipy.sparse import csc_matrix
    >>> R = np.random.randn(5, 5)
    >>> A = csc_matrix(R)
    >>> b = np.random.randn(5)
    >>> use_solver(useUmfpack=False) # enforce superLU over UMFPACK
    >>> x = spsolve(A, b)
    >>> np.allclose(A.dot(x), b)
    True
    >>> use_solver(useUmfpack=True) # reset umfPack usage to default
    
useUmfpackassumeSortedIndices)r   N)globalsr   umfpack	configure)kwargsr   r   r   r      s    =r   c              
   C   s   t jt jfdt jt jfdt jt jfdt jt jfdi}tt | jj}tt | jjj}z|||f }W n@ t	y } z(d| d| d}t
||W Y d}~n
d}~0 0 |d	 d
 }t| }t j| jt jd|_t j| jt jd|_||fS )z8Get umfpack family string given the sparse matrix dtype.ZdiZzidlZzlz]only float64 or complex128 matrices with int32 or int64 indices are supported! (got: matrix: z, indices: )Nr   ldtype)npfloat64Zint32Z
complex128Zint64getattrr#   nameindicesKeyError
ValueErrorcopyr   indptr)AZ	_familiesZf_typeZi_typefamilyemsgZA_newr   r   r   _get_umf_family_   s*    	 
r1   c                 C   sv   t t jj}| jd |kr$tdt| j |krJt | j|krJtd| jj	t jdd}| jj	t jdd}||fS )Nz#indptr values too large for SuperLUz$indices values too large for SuperLUFr+   )
r$   Ziinfointcmaxr,   r*   shapeanyr(   astype)r-   Z	max_valuer(   r,   r   r   r   _safe_downcast_indices   s    r9   c               
   C   s|  t |}|r|jnd}t| } t|}t| r8| jdv sNt| } tdtdd t|}|sbt|}|j	dkp|j	dko|j
d dk}|   |  } t| j|j}| j|kr| |} |j|kr||}| j
\}	}
|	|
krtd|	|
f d|	|j
d	 kr td
| j
 d|j
d	  d|o(t}|r|r|rF| }n|}t|| jd }trjtd| jjdvrtdt| \}} t|}|jtj| |dd}n|r|r| }d}|sh| jdkrd}nd	}| jjtjdd}| jjtjdd}t |d}t!j"|
| j#| j$|||||d\}}|d	krVtdt%dd |&tj' |rx| }nt(| }|jdkst |stdtdd t|}g }g }g }t)|j
d D ]v}|dd|gf   }||}t*|}|j
d	 }|+| |+tj,||t-d |+tj|| | jd qt.|}t.|}t.|}| j|||ff|j
| jd}|rx|/|}|S )a  Solve the sparse linear system Ax=b, where b may be a vector or a matrix.

    Parameters
    ----------
    A : ndarray or sparse matrix
        The square matrix A will be converted into CSC or CSR form
    b : ndarray or sparse matrix
        The matrix or vector representing the right hand side of the equation.
        If a vector, b.shape must be (n,) or (n, 1).
    permc_spec : str, optional
        How to permute the columns of the matrix for sparsity preservation.
        (default: 'COLAMD')

        - ``NATURAL``: natural ordering.
        - ``MMD_ATA``: minimum degree ordering on the structure of A^T A.
        - ``MMD_AT_PLUS_A``: minimum degree ordering on the structure of A^T+A.
        - ``COLAMD``: approximate minimum degree column ordering [1]_, [2]_.

    use_umfpack : bool, optional
        if True (default) then use UMFPACK for the solution [3]_, [4]_, [5]_,
        [6]_ . This is only referenced if b is a vector and
        ``scikits.umfpack`` is installed.

    Returns
    -------
    x : ndarray or sparse matrix
        the solution of the sparse linear equation.
        If b is a vector, then x is a vector of size A.shape[1]
        If b is a matrix, then x is a matrix of size (A.shape[1], b.shape[1])

    Notes
    -----
    For solving the matrix expression AX = B, this solver assumes the resulting
    matrix X is sparse, as is often the case for very sparse inputs.  If the
    resulting X is dense, the construction of this sparse result will be
    relatively expensive.  In that case, consider converting A to a dense
    matrix and using scipy.linalg.solve or its variants.

    References
    ----------
    .. [1] T. A. Davis, J. R. Gilbert, S. Larimore, E. Ng, Algorithm 836:
           COLAMD, an approximate column minimum degree ordering algorithm,
           ACM Trans. on Mathematical Software, 30(3), 2004, pp. 377--380.
           :doi:`10.1145/1024074.1024080`

    .. [2] T. A. Davis, J. R. Gilbert, S. Larimore, E. Ng, A column approximate
           minimum degree ordering algorithm, ACM Trans. on Mathematical
           Software, 30(3), 2004, pp. 353--376. :doi:`10.1145/1024074.1024079`

    .. [3] T. A. Davis, Algorithm 832:  UMFPACK - an unsymmetric-pattern
           multifrontal method with a column pre-ordering strategy, ACM
           Trans. on Mathematical Software, 30(2), 2004, pp. 196--199.
           https://dl.acm.org/doi/abs/10.1145/992200.992206

    .. [4] T. A. Davis, A column pre-ordering strategy for the
           unsymmetric-pattern multifrontal method, ACM Trans.
           on Mathematical Software, 30(2), 2004, pp. 165--195.
           https://dl.acm.org/doi/abs/10.1145/992200.992205

    .. [5] T. A. Davis and I. S. Duff, A combined unifrontal/multifrontal
           method for unsymmetric sparse matrices, ACM Trans. on
           Mathematical Software, 25(1), 1999, pp. 1--19.
           https://doi.org/10.1145/305658.287640

    .. [6] T. A. Davis and I. S. Duff, An unsymmetric-pattern multifrontal
           method for sparse LU factorization, SIAM J. Matrix Analysis and
           Computations, 18(1), 1997, pp. 140--158.
           https://doi.org/10.1137/S0895479894246905T.


    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse import csc_matrix
    >>> from scipy.sparse.linalg import spsolve
    >>> A = csc_matrix([[3, 2, 0], [1, -1, 0], [0, 5, 1]], dtype=float)
    >>> B = csc_matrix([[2, 0], [-1, 0], [2, 0]], dtype=float)
    >>> x = spsolve(A, B)
    >>> np.allclose(A.dot(x).toarray(), B.toarray())
    True
    N)csccsrz.spsolve requires A be CSC or CSR matrix format   
stacklevelr   z!matrix must be square (has shape r    r   z!matrix - rhs dimension mismatch (z - r"   Scikits.umfpack not installed.dDZconvert matrix data to double, please, using .astype(), or set linsolve.useUmfpack = FalseTZautoTransposeFr:   r3   )ColPerm)optionszMatrix is exactly singularzCspsolve is more efficient when sparse b is in the CSC matrix format)r6   r#   )0r   	__class__r	   r   formatr   r   r   r   ndimr6   sum_duplicates	_asfptyper$   Zpromote_typesr#   r8   r*   r   ZtoarrayZravelnoScikitRuntimeErrorcharr1   r   UmfpackContextZlinsolve	UMFPACK_Ar(   r4   r,   dictr   Zgssvnnzdatar   fillnanr   rangeZflatnonzeroappendfullintZconcatenatefrom_scipy_sparse) r-   b
permc_specZuse_umfpackZis_pydata_sparseZpydata_sparse_clsZb_is_sparseZb_is_vectorZresult_dtypeMNZb_vec
umf_familyumfxflagr(   r,   rD   infoZ
AfactsolveZ	data_segsZrow_segsZcol_segsjZbjZxjwsegment_lengthZsparse_dataZ
sparse_rowZ
sparse_colr   r   r   r      s    R"


















r   c              
   C   s   t | r(t| ddd}|   } nt}t| r>| jdksTt| } tdtdd | 	  | 
 } | j\}}||kr~tdt| \}	}
t||||d	}|d
ur|| |d dkrd|d< tj|| j| j|	|
|d|dS )a  
    Compute the LU decomposition of a sparse, square matrix.

    Parameters
    ----------
    A : sparse matrix
        Sparse matrix to factorize. Most efficient when provided in CSC
        format. Other formats will be converted to CSC before factorization.
    permc_spec : str, optional
        How to permute the columns of the matrix for sparsity preservation.
        (default: 'COLAMD')

        - ``NATURAL``: natural ordering.
        - ``MMD_ATA``: minimum degree ordering on the structure of A^T A.
        - ``MMD_AT_PLUS_A``: minimum degree ordering on the structure of A^T+A.
        - ``COLAMD``: approximate minimum degree column ordering

    diag_pivot_thresh : float, optional
        Threshold used for a diagonal entry to be an acceptable pivot.
        See SuperLU user's guide for details [1]_
    relax : int, optional
        Expert option for customizing the degree of relaxing supernodes.
        See SuperLU user's guide for details [1]_
    panel_size : int, optional
        Expert option for customizing the panel size.
        See SuperLU user's guide for details [1]_
    options : dict, optional
        Dictionary containing additional expert options to SuperLU.
        See SuperLU user guide [1]_ (section 2.4 on the 'Options' argument)
        for more details. For example, you can specify
        ``options=dict(Equil=False, IterRefine='SINGLE'))``
        to turn equilibration off and perform a single iterative refinement.

    Returns
    -------
    invA : scipy.sparse.linalg.SuperLU
        Object, which has a ``solve`` method.

    See also
    --------
    spilu : incomplete LU decomposition

    Notes
    -----
    This function uses the SuperLU library.

    References
    ----------
    .. [1] SuperLU https://portal.nersc.gov/project/sparse/superlu/

    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse import csc_matrix
    >>> from scipy.sparse.linalg import splu
    >>> A = csc_matrix([[1., 0., 0.], [5., 0., 2.], [0., -1., 0.]], dtype=float)
    >>> B = splu(A)
    >>> x = np.array([1., 2., 3.], dtype=float)
    >>> B.solve(x)
    array([ 1. , -3. , -1.5])
    >>> A.dot(B.solve(x))
    array([ 1.,  2.,  3.])
    >>> B.solve(A.dot(x))
    array([ 1.,  2.,  3.])
    clsc                 W   s   |  t| S NrX   r   rf   ar   r   r   csc_construct_func  s    z splu.<locals>.csc_construct_funcr:   &splu converted its input to CSC formatr<   r=   can only factor square matrices)DiagPivotThreshrC   	PanelSizeRelaxNrC   NATURALTSymmetricModeFrk   ZilurD   r   typeto_scipy_sparsetocscr   r   rF   r   r   rH   rI   r6   r*   r9   rO   updater   ZgstrfrP   rQ   )r-   rZ   diag_pivot_threshrelax
panel_sizerD   rk   r[   r\   r(   r,   _optionsr   r   r   r   S  s4    D

r   c	              
   C   s   t | r(t| ddd}	|   } nt}	t| r>| jdksTt| } tdtdd | 	  | 
 } | j\}
}|
|kr~tdt| \}}t|||||||d	}|d
ur|| |d dkrd|d< tj|| j| j|||	d|dS )a  
    Compute an incomplete LU decomposition for a sparse, square matrix.

    The resulting object is an approximation to the inverse of `A`.

    Parameters
    ----------
    A : (N, N) array_like
        Sparse matrix to factorize. Most efficient when provided in CSC format.
        Other formats will be converted to CSC before factorization.
    drop_tol : float, optional
        Drop tolerance (0 <= tol <= 1) for an incomplete LU decomposition.
        (default: 1e-4)
    fill_factor : float, optional
        Specifies the fill ratio upper bound (>= 1.0) for ILU. (default: 10)
    drop_rule : str, optional
        Comma-separated string of drop rules to use.
        Available rules: ``basic``, ``prows``, ``column``, ``area``,
        ``secondary``, ``dynamic``, ``interp``. (Default: ``basic,area``)

        See SuperLU documentation for details.

    Remaining other options
        Same as for `splu`

    Returns
    -------
    invA_approx : scipy.sparse.linalg.SuperLU
        Object, which has a ``solve`` method.

    See also
    --------
    splu : complete LU decomposition

    Notes
    -----
    To improve the better approximation to the inverse, you may need to
    increase `fill_factor` AND decrease `drop_tol`.

    This function uses the SuperLU library.

    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse import csc_matrix
    >>> from scipy.sparse.linalg import spilu
    >>> A = csc_matrix([[1., 0., 0.], [5., 0., 2.], [0., -1., 0.]], dtype=float)
    >>> B = spilu(A)
    >>> x = np.array([1., 2., 3.], dtype=float)
    >>> B.solve(x)
    array([ 1. , -3. , -1.5])
    >>> A.dot(B.solve(x))
    array([ 1.,  2.,  3.])
    >>> B.solve(A.dot(x))
    array([ 1.,  2.,  3.])
    re   c                 W   s   |  t| S rg   rh   ri   r   r   r   rk     s    z!spilu.<locals>.csc_construct_funcr:   z'spilu converted its input to CSC formatr<   r=   rm   )ZILU_DropRuleZILU_DropTolZILU_FillFactorrn   rC   ro   rp   NrC   rq   Trr   rs   rt   )r-   Zdrop_tolZfill_factorZ	drop_rulerZ   ry   rz   r{   rD   rk   r[   r\   r(   r,   r|   r   r   r   r     s8    ;

r   c                    s   t  r    trtr$tdt r6 jdksLt  t	dt
dd     jjdvrhtdt \} t|   fdd	}|S t jS d
S )a  
    Return a function for solving a sparse linear system, with A pre-factorized.

    Parameters
    ----------
    A : (N, N) array_like
        Input. A in CSC format is most efficient. A CSR format matrix will
        be converted to CSC before factorization.

    Returns
    -------
    solve : callable
        To solve the linear system of equations given in `A`, the `solve`
        callable should be passed an ndarray of shape (N,).

    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse.linalg import factorized
    >>> from scipy.sparse import csc_matrix
    >>> A = np.array([[ 3. ,  2. , -1. ],
    ...               [ 2. , -2. ,  4. ],
    ...               [-1. ,  0.5, -1. ]])
    >>> solve = factorized(csc_matrix(A)) # Makes LU decomposition.
    >>> rhs1 = np.array([1, -2, 0])
    >>> solve(rhs1) # Uses the LU factors.
    array([ 1., -2., -2.])

    r?   r:   rl   r<   r=   r@   rA   c                    sF   t jddd$ jtj | dd}W d    n1 s80    Y  |S )Nignore)divideinvalidTrB   )r$   Zerrstatesolver   rN   )rY   resultr-   r^   r   r   r   R  s    2zfactorized.<locals>.solveN)r   rv   rw   r   rJ   rK   r   rF   r   r   r   rI   r#   rL   r*   r1   r   rM   numericr   r   )r-   r]   r   r   r   r   r     s&    

r   c                 C   sN  t | r|   } t| r&| jdks>tdtdd t| } n|sJ|  } | j	d | j	d krpt
d| j	 d|   t|}|jd	vrt
d
|j	 d| j	d |j	d krt
d| j	 d|j	 dt| j|tj}|rtj|j|ddr|}nt
d|j d| dn|j|dd}|r8tt|}ntt|d dd}|D ]}	| j|	 }
| j|	d  }|r|d }t|
|d }n|
}t|
d |}|s||
ks| j| |	k rtd|	 d|s| j| |	krtd|	| j| | j| }| j| }||	  t|| j|8  < |sP||	  | j|   < qP|S )a  
    Solve the equation ``A x = b`` for `x`, assuming A is a triangular matrix.

    Parameters
    ----------
    A : (M, M) sparse matrix
        A sparse square triangular matrix. Should be in CSR format.
    b : (M,) or (M, N) array_like
        Right-hand side matrix in ``A x = b``
    lower : bool, optional
        Whether `A` is a lower or upper triangular matrix.
        Default is lower triangular matrix.
    overwrite_A : bool, optional
        Allow changing `A`. The indices of `A` are going to be sorted and zero
        entries are going to be removed.
        Enabling gives a performance gain. Default is False.
    overwrite_b : bool, optional
        Allow overwriting data in `b`.
        Enabling gives a performance gain. Default is False.
        If `overwrite_b` is True, it should be ensured that
        `b` has an appropriate dtype to be able to store the result.
    unit_diagonal : bool, optional
        If True, diagonal elements of `a` are assumed to be 1 and will not be
        referenced.

        .. versionadded:: 1.4.0

    Returns
    -------
    x : (M,) or (M, N) ndarray
        Solution to the system ``A x = b``. Shape of return matches shape
        of `b`.

    Raises
    ------
    LinAlgError
        If `A` is singular or not triangular.
    ValueError
        If shape of `A` or shape of `b` do not match the requirements.

    Notes
    -----
    .. versionadded:: 0.19.0

    Examples
    --------
    >>> import numpy as np
    >>> from scipy.sparse import csr_matrix
    >>> from scipy.sparse.linalg import spsolve_triangular
    >>> A = csr_matrix([[3, 0, 0], [1, -1, 0], [2, 0, 1]], dtype=float)
    >>> B = np.array([[2, 0], [-1, 0], [2, 0]], dtype=float)
    >>> x = spsolve_triangular(A, B)
    >>> np.allclose(A.dot(x), B)
    True
    r;   z8CSR matrix format is required. Converting to CSR matrix.r<   r=   r   r   z+A must be a square matrix but its shape is .)r   r<   z)b must have 1 or 2 dims but its shape is zlThe size of the dimensions of A must be equal to the size of the first dimension of b but the shape of A is z and the shape of b is Z	same_kind)ZcastingzCannot overwrite b (dtype z) with result of type Tr3   r2   zA is singular: diagonal z	 is zero.z*A is not triangular: A[{}, {}] is nonzero.)r   rv   Ztocsrr   rF   r   r   r   r+   r6   r*   rH   r$   Z
asanyarrayrG   Zresult_typerQ   r%   Zcan_castr#   r8   rT   lenr,   slicer(   r
   dotT)r-   rY   lowerZoverwrite_AZoverwrite_bZunit_diagonalZx_dtyper_   Zrow_indicesiZindptr_startZindptr_stopZA_diagonal_index_row_iZA_off_diagonal_indices_row_iZA_column_indices_in_row_iZA_values_in_row_ir   r   r   r   ^  s    :








r   )NT)NNNNNNNN)TFFF)#warningsr   numpyr$   r   Zscipy.sparser   r   r   r   Zscipy.sparse._sputilsr   r	   Zscipy.linalgr
   r+    r   rJ   Zscikits.umfpackr   ImportErrorr   __all__UserWarningr   r   r1   r9   r   rO   r   r   r   r   r   r   r   r   <module>   s<   
B"
 D
h  
aB  