a
    a;                     @   s  d Z g ZddlmZ ddlZddlZddlmZ ddl	m
Z
mZmZ ddl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 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'm(Z(m)Z)m*Z*m+Z+m,Z,m-Z- G dd deeeZ.dd Z/dS )z>Base class for sparse matrix formats using compressed storage.    )warnN)_prune_array   )spmatrix
isspmatrixSparseEfficiencyWarning)_data_matrix_minmax_mixin)
dia_matrix)_sparsetools)get_csr_submatrixcsr_sample_offsetscsr_todensecsr_sample_valuescsr_row_indexcsr_row_slicecsr_column_index1csr_column_index2)
IndexMixin)upcastupcast_char	to_nativeisdenseisshapegetdtypeisscalarlike	isintlikeget_index_dtypedowncast_intp_indexget_sum_dtypecheck_shapematrixasmatrixis_pydata_spmatrixc                   @   sZ  e Zd ZdZdyddZdzddZejje_d{dd	Zd|ddZdd Z	dd Z
dd Zdd Zdd Zdd Zdd Zdd Zdd Zdd  Zd!d" Zd#d$ Zd%d& Zd'd( Zd)d* Zd}d,d-Zejje_d.d/ Zd0d1 Zejje_d2d3 Zejje_d~d4d5Zejje_dd6d7Zd8d9 Zd:d; Zd<d= Z d>d? Z!d@dA Z"ddBdCZ#dDdE Z$ddFdGZ%ddHdIZ&dJdK Z'dLdM Z(dNdO Z)dPdQ Z*dRdS Z+dTdU Z,dVdW Z-dXdY Z.ddZd[Z/ej/je/_dd\d]Z0ej0je0_d^d_ Z1d`da Z2dbdc Z3e4e2e3ddZ5dedf Z6dgdh Z7didj Z8e4e7e8ddZ9dkdl Z:dmdn Z;dodp Z<dqdr Z=ej=je=_ddsdtZ>dudv Z?dwdx Z@dS )
_cs_matrixzBbase matrix class for compressed row- and column-oriented matricesNFc              
   C   s  t |  t|rF|j| jkr,|r,| }n|| j}| | nt|trt	|rt
|| _| j\}}tt||d}tdt|td| _td|| _tj| ||fd d |d| _nt|dkrddlm} | ||||d}	| |	 nt|d	krv|\}
}}d }|d ur,t|}t||f|d
d}tj|||d| _tj|||d| _tj|
||d| _ntd| jnlzt|}W n8 ty } ztd| j|W Y d }~n
d }~0 0 ddlm} | | |||d |d ur
t
|| _nr| jd u r|z t| jd }| j d }W n0 tyf } ztd|W Y d }~nd }~0 0 t
| ||f| _|d ur| jj|dd| _| j dd d S )Nmaxvalr   )defaultr   dtype   
coo_matrixshaper)      T)r&   Zcheck_contentscopyr)   z(unrecognized {}_matrix constructor usagez!unable to infer matrix dimensionsFr1   
full_check)!r   __init__r   formatr1   asformat	_set_self
isinstancetupler   r    _shaper.   r   maxnpzerosr   floatdataindices_swapindptrlencoor,   	__class__array
ValueErrorasarray	Exceptionastypecheck_format)selfZarg1r.   r)   r1   MN	idx_dtyper,   otherr@   rA   rC   r&   e	major_dim	minor_dim rU   g/Users/vegardjervell/Documents/master/model/venv/lib/python3.9/site-packages/scipy/sparse/compressed.pyr5      s~    








 

z_cs_matrix.__init__c                 C   s   |d u rt | jd S |dk r&|d7 }| |d| f\}}| | j\}}|dkrhtjt| j|dS |dkr|t| jS t	dd S )Nr   r*   r   )Z	minlengthzaxis out of bounds)
intrC   rB   r.   r=   Zbincountr   rA   diffrH   )rM   axis_rO   rU   rU   rV   getnnzl   s    z_cs_matrix.getnnzc                 C   s4   |r|  }|j| _|j| _|j| _t|j| _dS )z:take the member variables of other and assign them to selfN)r1   r@   rA   rC   r    r.   r;   )rM   rQ   r1   rU   rU   rV   r8   }   s    z_cs_matrix._set_selfTc                 C   s  |  d\}}|  | j\}}| jjjdkrDtd| jjjdd | jjjdkrjtd| jjjdd t	| j| jf}t
j| j|d| _t
j| j|d| _t| j| _| jj| jj| jjfD ]}|dkrtd	qt| j|d krtd
t| j|d | jd dkrtdt| jt| jkr:td| jd t| jkrXtd|   |r| jdkr| j |krtd||| j dk rtd|t
| j dk rtddS )zcheck whether the matrix format is valid

        Parameters
        ----------
        full_check : bool, optional
            If `True`, rigorous check, O(N) operations. Otherwise
            basic check, O(1) operations (default True).
        )rowcolumniz'indptr array has non-integer dtype ({})r/   
stacklevelz(indices array has non-integer dtype ({})r(   r   z'data, indices, and indptr should be 1-Dz&index pointer size ({}) should be ({})r   z!index pointer should start with 0z*indices and data should have the same sizerW   zQLast value of index pointer should be less than the size of index and data arraysz{} index values must be < {}z{} index values must be >= 0z8index pointer values must form a non-decreasing sequenceN)rB   r.   rC   r)   kindr   r6   namerA   r   r=   rI   r   r@   ndimrH   rD   prunennzr<   minrY   )rM   r4   Z
major_nameZ
minor_namerS   rT   rP   xrU   rU   rV   rL      sX    

z_cs_matrix.check_formatc                 C   s*   |    | j|| j|dd}|  |S )zScalar version of self._binopt, for cases in which no new nonzeros
        are added. Produces a new spmatrix in canonical form.
        Tr2   )sum_duplicates
_with_datar@   eliminate_zeros)rM   rQ   opresrU   rU   rV   _scalar_binopt   s    z_cs_matrix._scalar_binoptc                 C   s  t |rxt|r$| j| jtjdS |dkrhtdtdd | tj| jtjd}| 	|t
j}|| S | 	|t
jS nt|r|  |kS t|rtS t|rtdtdd | j|jkrdS | j|jkr|| j}| |d}| tj| jtjd}|| S dS d S )	Nr(   r   zOComparing a sparse matrix with 0 using == is inefficient, try using != instead.r/   r`   zHComparing sparse matrices using == is inefficient, try using != instead.F_ne_)r   r=   isnanrF   r.   bool_r   r   onesrn   operatorneeqr   todenser#   NotImplementedr   r6   r7   _binopt)rM   rQ   all_trueinvrm   rU   rU   rV   __eq__   s8    

z_cs_matrix.__eq__c                 C   s   t |rt|r<tdtdd | tj| jtjd}|S |dkrtdtdd | jt| jtjd}| 	|t
j}|| S | 	|t
jS n`t|r|  |kS t|rtS t|r| j|jkrdS | j|jkr|| j}| |dS dS d S )	Nz:Comparing a sparse matrix with nan using != is inefficientr/   r`   r(   r   z^Comparing a sparse matrix with a nonzero scalar using != is inefficient, try using == instead.Tro   )r   r=   rp   r   r   rF   rr   r.   rq   rn   rs   ru   rt   r   rv   r#   rw   r   r6   r7   rx   )rM   rQ   ry   rz   rU   rU   rV   __ne__   s4    
z_cs_matrix.__ne__c                 C   s,  t |rzd|kr"|dv r"tdnV|d|rlt|t tj| jt|d}|| | 	|}| 
||S | ||S nt|r||  |S t|r | j|jkrtdn| j|jkr|| j}|dvr| 
||S tdt | 	tj| jtjd}| 
||dkrd	nd
}|| S tdd S )Nr   )_le__ge_z >= and <= don't work with 0.r(   inconsistent shapes)r~   r}   zUComparing sparse matrices using >= and <= is inefficient, using <, >, or !=, instead.r}   _gt__lt_zOperands could not be compared.)r   NotImplementedErrorr   r   r=   emptyr.   Zresult_typefillrF   rx   rn   r   rv   r   rH   r6   r7   rr   rq   )rM   rQ   rl   op_nameZbad_scalar_msg	other_arrry   rm   rU   rU   rV   _inequality  s4    






z_cs_matrix._inequalityc                 C   s   |  |tjddS )Nr   zgComparing a sparse matrix with a scalar greater than zero using < is inefficient, try using >= instead.)r   rs   ltrM   rQ   rU   rU   rV   __lt__?  s    z_cs_matrix.__lt__c                 C   s   |  |tjddS )Nr   zdComparing a sparse matrix with a scalar less than zero using > is inefficient, try using <= instead.)r   rs   gtr   rU   rU   rV   __gt__E  s    z_cs_matrix.__gt__c                 C   s   |  |tjddS )Nr}   zgComparing a sparse matrix with a scalar greater than zero using <= is inefficient, try using > instead.)r   rs   ler   rU   rU   rV   __le__K  s    z_cs_matrix.__le__c                 C   s   |  |tjddS )Nr~   zdComparing a sparse matrix with a scalar less than zero using >= is inefficient, try using < instead.)r   rs   ger   rU   rU   rV   __ge__Q  s    z_cs_matrix.__ge__c                 C   s   |j | j kr td| j |j t| jj|jj}| dd }tj|||dd}| | j \}}|j	j
rn|n|j}t||| j| j| j| t|ddS )NzIncompatible shapes ({} and {})ZCFr   T)r)   orderr1   Fr2   )r.   rH   r6   r   r)   charrB   r=   rG   flagsc_contiguousTr   rC   rA   r@   r!   )rM   rQ   r)   r   resultrN   rO   yrU   rU   rV   
_add_dense[  s    z_cs_matrix._add_densec                 C   s   |  |dS )NZ_plus_rx   r   rU   rU   rV   _add_sparseg  s    z_cs_matrix._add_sparsec                 C   s   |  |dS )NZ_minus_r   r   rU   rU   rV   _sub_sparsej  s    z_cs_matrix._sub_sparsec                 C   s2  t |r| |S t|r:| j|jkr>| |}| |dS |jdkrZ| | d S | jdkrv||  d S | jd dkr|jd dkr| | S | jd dkr|jd dkr||  S |jd dkr$| jd |jd kr$t	| 
 dgf|jd |jd fd}| |S | jd dkr~| jd |jd kr~t	|  
 dgf| jd | jd fd}||S |jd dkr| jd |jd krt	| 
 dgf|jd |jd fd}|| S | jd dkr2| jd |jd kr2t	|  
 dgf| jd | jd fd}||S tdt|}|jdkr`t|  |S |jdkr|| |jd S | jdkrt|  d |S dd	lm} |  }| j|jkrt|j||j|jf }n@| jd dkr|jd dkrt|j|}n<|jd | jd kr@t|j|d
d
|jf }ntdtt|jd t|j}t|j|jd }||tj
 ||ff|jd | jd fddS | jd dkr|jd dkrt|jd
d
d
f |}n@|jd | jd kr t|jd
d
d
f ||j }ntdt|j|jd }tt|jd t|j}||tj
 ||ff| jd |jd fddS |jd dkr| jd |jd krt|j|d
d
|jf 
 }nH|jd dkr| jd |jd krt|j||j 
 }ntd|tj
 |_|S )zPPoint-wise multiplication by another matrix, vector, or
        scalar.
        Z_elmul_)r   r   )r   r   r   r   r.   r   r*   r+   NFr.   r1   )r   Z_mul_scalarr   r.   rF   rx   toarray_mul_sparse_matrixtocscr
   ravelrH   r=   Z
atleast_2drd   multiplysizeZflatrE   r,   tocoor@   r]   colrepeatarangerD   tileviewZndarray)rM   rQ   r1   r,   retr@   r]   r   rU   rU   rV   r   m  s    




&
&
&
&

"&"&z_cs_matrix.multiplyc                 C   sT   | j \}}tj|t| jj|jjd}tt| jd }|||| j	| j
| j|| |S )Nr(   Z_matvec)r.   r=   r>   r   r)   r   getattrr   r6   rC   rA   r@   )rM   rQ   rN   rO   r   fnrU   rU   rV   _mul_vector  s    
z_cs_matrix._mul_vectorc              
   C   sl   | j \}}|j d }tj||ft| jj|jjd}tt| jd }||||| j	| j
| j| |  |S )Nr   r(   Z_matvecs)r.   r=   r>   r   r)   r   r   r   r6   rC   rA   r@   r   )rM   rQ   rN   rO   Zn_vecsr   r   rU   rU   rV   _mul_multivector  s    


z_cs_matrix._mul_multivectorc                 C   sf  | j \}}|j \}}| ||fd }| |}t| j| j|j|jf}tt| jd }|||t	j
| j|dt	j
| j|dt	j
|j|dt	j
|j|d}	t| j| j|j|jf|	d}t	j|d |d}
t	j|	|d}t	j|	t| j|jd}tt| jd }|||t	j
| j|dt	j
| j|d| jt	j
|j|dt	j
|j|d|j|
|| | j|||
f||fdS )Nr   Z_matmat_maxnnzr(   r%   r   Z_matmatr   )r.   rB   rF   r   rC   rA   r   r   r6   r=   rI   r   r   r)   r@   )rM   rQ   rN   ZK1ZK2rO   Z
major_axisrP   r   rf   rC   rA   r@   rU   rU   rV   r     s@    




z_cs_matrix._mul_sparse_matrixr   c                 C   s   | j \}}|| ks||kr.tjd| jjdS tt| jd }tjt|t|d |t	|d t
| jd}||| j d | j d | j| j| j| |S )Nr   r(   Z	_diagonalr   )r.   r=   r   r@   r)   r   r   r6   rg   r<   r   rC   rA   )rM   krowscolsr   r   rU   rU   rV   diagonal  s    
 z_cs_matrix.diagonalc                 C   s   t |r||rVtdtdd tj| jt|jd}|| | 	|}| 
||S |   || jt|}| j	|| j| jf|j| jd}|S n2t|r||  |S t|r| 
||S tdd S )NzITaking maximum (minimum) with > 0 (< 0) number results to a dense matrix.r/   r`   r(   )r)   r.   zOperands not compatible.)r   r   r   r=   r   r.   rI   r)   r   rF   rx   ri   r@   rA   rC   r   rv   r   rH   )rM   rQ   Znpopr   Zdense_checkr   Znew_datamatrU   rU   rV   _maximum_minimum%  s*    

z_cs_matrix._maximum_minimumc                 C   s   |  |tjddd S )NZ	_maximum_c                 S   s   t | dkS Nr   r=   rI   rh   rU   rU   rV   <lambda>>      z$_cs_matrix.maximum.<locals>.<lambda>)r   r=   maximumr   rU   rU   rV   r   <  s    
z_cs_matrix.maximumc                 C   s   |  |tjddd S )NZ	_minimum_c                 S   s   t | dk S r   r   r   rU   rU   rV   r   D  r   z$_cs_matrix.minimum.<locals>.<lambda>)r   r=   minimumr   rU   rU   rV   r   B  s    
z_cs_matrix.minimumc                 C   s   t | ds|| dd v rt| j}tjt| jd |d}| tj	\}}|||< t
|}|d dkrp|j}|dur|j|jkrtd|jd	||d
S tj| |||d
S dS )z~Sum the matrix over the given axis.  If the axis is None, sum
        over both rows and columns, returning a scalar.
        	blocksize))r   rW   )r   r*   r   r   r(   r*   Nzdimensions do not matchrU   )rZ   r)   out)hasattrrB   r   r)   r=   r>   rD   rC   _minor_reduceaddr"   r   r.   rH   sumr   )rM   rZ   r)   r   Z	res_dtyper   major_indexvaluerU   rU   rV   r   L  s    

z_cs_matrix.sumc                 C   s>   |du r| j }tt| j}||t| j| }||fS )a  Reduce nonzeros with a ufunc over the minor axis when non-empty

        Can be applied to a function of self.data by supplying data parameter.

        Warning: this does not call sum_duplicates()

        Returns
        -------
        major_index : array of ints
            Major indices where nonzero

        value : array of self.dtype
            Reduce result for nonzeros in each major_index
        N)r@   r=   ZflatnonzerorY   rC   Zreduceatr   )rM   Zufuncr@   r   r   rU   rU   rV   r   i  s    z_cs_matrix._minor_reducec           
      C   s\   |  | j\}}|  ||f\}}t||| j| j| j||d ||d 	\}}}	|	j| jdS )Nr   r(   )rB   r.   r   rC   rA   r@   r   r)   )
rM   r]   r   rN   rO   majorminorrC   rA   r@   rU   rU   rV   _get_intXint  s    
z_cs_matrix._get_intXintc                 C   sF   |  ||f\}}|jdv r6|jdv r6| j||ddS | ||S )N)r   NTr2   )rB   step_get_submatrix_major_slice_minor_slicerM   r]   r   r   r   rU   rU   rV   _get_sliceXslice  s    z_cs_matrix._get_sliceXslicec           	   
   C   s   | j j}| | j\}}| ||f\}}tj||d}tj||d}tj|j| jd}t||| j	| j | j
|j| | |	 |jdkrt|S | ||jS )Nr(   r   )rA   r)   rB   r.   r=   rI   r   r   r   rC   r@   r   rd   r"   rF   Zreshape)	rM   r]   r   rP   rN   rO   r   r   valrU   rU   rV   _get_arrayXarray  s    
z_cs_matrix._get_arrayXarrayc                 C   s"   |  ||f\}}| ||S N)rB   _major_index_fancy_minor_index_fancyr   rU   rU   rV   _get_columnXarray  s    z_cs_matrix._get_columnXarrayc                 C   s   | j j}tj||d }| | j\}}t|}| ||f}|dkrR| |S | j	|d  | j	|  }| j j}tj
|d |d}	tj||	dd d |	d }
tj|
|d}tj|
| jd}t||| j	| j | j|| | j|||	f|ddS )	zBIndex along the major axis where idx is an array of ints.
        r(   r   r   Nr   rW   Fr   )rA   r)   r=   rI   r   rB   r.   rD   rF   rC   r>   cumsumr   r   r@   )rM   idxrP   rA   r[   rO   rN   	new_shaperow_nnz
res_indptrrf   res_indicesres_datarU   rU   rV   r     s(    
z_cs_matrix._major_index_fancyc              	   C   s  |t dkr|r|  S | S | | j\}}||\}}}tt|||}| ||f}|dkrl| |S || }	}
|dkr|dkrd}
|d |d  }}| j||| | j|	|
|  }| jj	}t
j|d |d}t
j||dd d |dkr6t | j| | j| }t
j| j| |d}t
j| j| |d}nB|d }t
j||d}t
j|| j	d}t|||| j| j| j|| | j|||f|dd	S )
z@Index along the major axis where idx is a slice object.
        Nr   rW   r   r(   r   r2   Fr   )slicer1   rB   r.   rA   rD   rangerF   rC   r)   r=   r>   r   rG   r@   r   r   )rM   r   r1   rN   rO   startstopr   r   Zstart0Zstop0Zstart1Zstop1r   rP   r   Zall_idxr   r   rf   rU   rU   rV   r     s>    


z_cs_matrix._major_slicec              	   C   s   | j j}tj||d }| | j\}}t|}| ||f}|dkrR| |S tj	||d}t
| j}t||||| j| j || t|j|dd}	|d }
tj|
|d}tj|
| jd}t|	|t| j | j | j|| | j|||f|ddS )zBIndex along the minor axis where idx is an array of ints.
        r(   r   Fr2   rW   r   )rA   r)   r=   rI   r   rB   r.   rD   rF   r>   Z
empty_likerC   r   argsortrK   r   r   r@   )rM   r   rP   rN   rO   r   r   Zcol_offsetsr   Z	col_orderrf   r   r   rU   rU   rV   r     s,    
z_cs_matrix._minor_index_fancyc                 C   s   |t dkr|r|  S | S | | j\}}||\}}}tt|||}|dkrh| | ||fS |dkr~| j||dS | 	t
|||S )z@Index along the minor axis where idx is a slice object.
        Nr   r   )r   r1   )r   r1   rB   r.   rA   rD   r   rF   r   r   r=   r   )rM   r   r1   rN   rO   r   r   r   rU   rU   rV   r     s    z_cs_matrix._minor_slicec              
   C   s   |  | j\}}t||\}}t||\}}	|dkr\|dkr\||kr\|	|kr\|rX|  S | S t||| j| j| j||||		\}
}}|  || |	| f}| j|||
f|| j	ddS )zbReturn a submatrix of this matrix.

        major, minor: None, int, or slice with step 1
        r   F)r.   r)   r1   )
rB   r.   _process_slicer1   r   rC   rA   r@   rF   r)   )rM   r   r   r1   rN   rO   i0i1Zj0Zj1rC   rA   r@   r.   rU   rU   rV   r     s     
z_cs_matrix._get_submatrixc                 C   s$   |  ||f\}}| ||| d S r   rB   	_set_manyrM   r]   r   rh   r_   jrU   rU   rV   _set_intXint&  s    z_cs_matrix._set_intXintc                 C   s$   |  ||f\}}| ||| d S r   r   r   rU   rU   rV   _set_arrayXarray*  s    z_cs_matrix._set_arrayXarrayc                 C   s  | j | ||f  |j\}}|dko2|jd dk}|dkoH|jd dk}|j|j }}	tj|j| jd}|j	dkrxd S |rt
t|t|}t|	|}	t||}|rt
||}tt|t|	}	t
||}| |||	f |||	f f\}
}| |
|| d S )Nr   r   r(   )
_zero_manyrB   r.   r]   r   r=   rI   r@   r)   r   r   r   rD   r   r   )rM   r]   r   rh   rN   rO   Zbroadcast_rowZbroadcast_colrcr_   r   rU   rU   rV   _set_arrayXarray_sparse.  s$    

"z"_cs_matrix._set_arrayXarray_sparsec           	      C   s   d| j v rd S | j \}}|jdk}|dk r|r>t|| |}nt|| |t|}tj|| jjd}tj|| jjd}||8 }nT|rt||| }nt||| t|}tj|| jjd}tj|| jjd}||7 }|s|d t| }|| ||f< d S )Nr   r(   )r.   rd   rg   rD   r=   r   rA   r)   )	rM   valuesr   rN   rO   	broadcastZ	max_indexr_   r   rU   rU   rV   _setdiagG  s(    



z_cs_matrix._setdiagc                 C   sl   |  | j\}}dd }tj|| jjddd }tj|| jjddd }||| ||| ||||fS )Nc                 S   sF   |   }||kr td||f |  }|| k rBtd||f d S )Nzindex (%d) out of range (>= %d)zindex (%d) out of range (< -%d))r<   
IndexErrorrg   )rA   boundr   rU   rU   rV   check_boundsh  s    
z1_cs_matrix._prepare_indices.<locals>.check_boundsFr   r)   r1   Zndmin)rB   r.   r=   rG   rA   r)   r   )rM   r_   r   rN   rO   r   rU   rU   rV   _prepare_indicese  s    


z_cs_matrix._prepare_indicesc           
   	   C   s"  |  ||\}}}}tj|| jddd }|j}tj|| jjd}t||| j	| j||||}|dkr| 
  t||| j	| j|||| d|vr|| j|< dS td| jtdd	 |dk}	||	 | j||	 < |	 }	||	 }||d
k   |7  < ||	 }||d
k   |7  < | ||||	  dS )zSets value at each (i, j) to x

        Here (i,j) index major and minor respectively, and must not contain
        duplicate entries.
        Fr   r   r(   rW   NzZChanging the sparsity structure of a {}_matrix is expensive. lil_matrix is more efficient.r/   r`   r   )r   r=   rG   r)   r   r   r   rA   r   rC   ri   r@   r   r6   r   _insert_many)
rM   r_   r   rh   rN   rO   	n_samplesoffsetsr   maskrU   rU   rV   r   x  s8    
z_cs_matrix._set_manyc              	   C   s   |  ||\}}}}t|}tj|| jjd}t||| j| j||||}|dkrr|   t||| j| j|||| d| j	||dk < dS )zSets value at each (i, j) to zero, preserving sparsity structure.

        Here (i,j) index major and minor respectively.
        r(   r   r   rW   N)
r   rD   r=   r   rA   r)   r   rC   ri   r@   )rM   r_   r   rN   rO   r   r   r   rU   rU   rV   r     s    z_cs_matrix._zero_manyc                 C   s  t j|dd}|j|dd}|j|dd}|j|dd}| j}t| j| jf| jd |j d}t j| j|d| _t j| j|d| _t j||d}t j||d}g }g }t j	|dd	\}	}
t 
|
t|}
t |
}d
}tt|	|
|
dd D ]\}\}}}| j| }| j| }|
| j||  |
| j||  t j	||| ddd dd	\}}t||| kr|
|||  |
|||  nL|
||| ddd |  |
||| ddd |  t|||< |}q| j| }|
| j|d  |
| j|d  t || _t || _t j| jj|d}|d
|d
< t | j}||	  |7  < ||dd< t j||d| _|rd| _|   | jdd dS )a:  Inserts new nonzero at each (i, j) with value x

        Here (i,j) index major and minor respectively.
        i, j and x must be non-empty, 1d arrays.
        Inserts each major group (e.g. all entries per row) at a time.
        Maintains has_sorted_indices property.
        Modifies i, j, x in place.
        Z	mergesort)rb   Zclip)moderW   r%   r(   T)Zreturn_indexr   r   Nr   Fr3   )r=   r   Ztakehas_sorted_indicesr   rA   rC   r   rI   uniqueappendrD   rY   	enumeratezipr@   Zconcatenater   r.   r   sort_indicesrL   )rM   r_   r   rh   r   Zdo_sortrP   Zindices_partsZ
data_partsZuiZ	ui_indptrZnew_nnzsprevr   iiZjsZjer   r   ZujZ	uj_indptrZnnzsZindptr_diffrU   rU   rV   r     s\    	
&

$  
z_cs_matrix._insert_manyc           	      C   sx   |  | j\}}| j}tjt|| jjd}t|| j	| |  ||f\}}ddl
m} || j||ff| j|| jdS )Nr(   r   r+   r0   )rB   r.   rA   r=   r   rD   r)   r   Z	expandptrrC   rE   r,   r@   )	rM   r1   rS   rT   Zminor_indicesZmajor_indicesr]   r   r,   rU   rU   rV   r     s    z_cs_matrix.tocooc                 C   s   |d u r|d u r|  dd }| ||}|jjsB|jjsBtd|jjrX|  }|}n|  }|j}| |j	\}}t
|||j|j|j| |S )Ncfr   z&Output array must be C or F contiguous)rB   Z_process_toarray_argsr   r   f_contiguousrH   Ztocsrr   r   r.   r   rC   rA   r@   )rM   r   r   rh   r   rN   rO   rU   rU   rV   r     s    z_cs_matrix.toarrayc                 C   s4   |  | j\}}t||| j| j| j |   dS )zVRemove zero entries from the matrix

        This is an *in place* operation.
        N)rB   r.   r   Zcsr_eliminate_zerosrC   rA   r@   re   rM   rN   rO   rU   rU   rV   rk   #  s
    z_cs_matrix.eliminate_zerosc                 C   sF   t | ddsd| _n,t| ds@ttt| jd | j| j| _	| jS )a^  Determine whether the matrix has sorted indices and no duplicates

        Returns
            - True: if the above applies
            - False: otherwise

        has_canonical_format implies has_sorted_indices, so if the latter flag
        is False, so will the former be; if the former is found True, the
        latter flag is also set.
        _has_sorted_indicesTF_has_canonical_formatr   )
r   r  r   boolr   Zcsr_has_canonical_formatrD   rC   rA   has_canonical_formatrM   rU   rU   rV   Z__get_has_canonical_format-  s    
z%_cs_matrix.__get_has_canonical_formatc                 C   s   t || _|rd| _d S )NT)r  r  r   rM   r   rU   rU   rV   Z__set_has_canonical_formatC  s    
z%_cs_matrix.__set_has_canonical_format)fgetfsetc                 C   sL   | j r
dS |   | | j\}}t||| j| j| j | 	  d| _ dS )zmEliminate duplicate matrix entries by adding them together

        This is an *in place* operation.
        NT)
r  r   rB   r.   r   Zcsr_sum_duplicatesrC   rA   r@   re   r  rU   rU   rV   ri   K  s    z_cs_matrix.sum_duplicatesc                 C   s2   t | ds,ttt| jd | j| j| _| jS )zDetermine whether the matrix has sorted indices

        Returns
            - True: if the indices of the matrix are in sorted order
            - False: otherwise

        r  r   )r   r  r   Zcsr_has_sorted_indicesrD   rC   rA   r  r	  rU   rU   rV   Z__get_sorted[  s    

z_cs_matrix.__get_sortedc                 C   s   t || _d S r   )r  r  r
  rU   rU   rV   Z__set_sortedk  s    z_cs_matrix.__set_sortedc                 C   s   |   }|  |S )z9Return a copy of this matrix with sorted indices
        )r1   r   )rM   ArU   rU   rV   sorted_indicesp  s    z_cs_matrix.sorted_indicesc                 C   s0   | j s,tt| jd | j| j| j d| _ dS )z3Sort the indices of this matrix *in place*
        r   TN)r   r   Zcsr_sort_indicesrD   rC   rA   r@   r	  rU   rU   rV   r   {  s
    z_cs_matrix.sort_indicesc                 C   s   |  | jd }t| j|d kr*tdt| j| jk rBtdt| j| jk rZtdt| jd| j | _t| jd| j | _dS )z8Remove empty space after all non-zero elements.
        r   r   z index pointer has invalid lengthz)indices array has fewer than nnz elementsz&data array has fewer than nnz elementsN)	rB   r.   rD   rC   rH   rA   rf   r@   r   )rM   rS   rU   rU   rV   re     s    z_cs_matrix.prunec                 G   s  t |}t| drz| j\}}t|d |\}}t|d |\}}|sH|rZtd| j|f | jd | | jd |  }}	n| |\}}| | j\}}	||k r| jd | j|  | _| j	d | j|  | _	| jd |d  | _n<||krt
| j|d | _| j|d d  | j|  ||	k r| j|k }
t
|
s| j|
 | _| j	|
 | _	| t
j|
\}}| jd || jdd  |< t
j| j| jd || _d S )Nr   r   r   z.shape must be divisible into %s blocks. Got %sr   )r    r   r   divmodrH   r.   rB   rA   rC   r@   r=   resizer   allr   r   r   r;   )rM   r.   ZbmZbnZnew_MZrmZnew_NZrnrN   rO   r   r   r   rU   rU   rV   r    s:    

 


z_cs_matrix.resizec                 C   sL   |r*| j || j | j f| j|jdS | j || j| jf| j|jdS dS )zReturns a matrix with the same sparsity structure as self,
        but with different data.  By default the structure arrays
        (i.e. .indptr and .indices) are copied.
        r-   N)rF   rA   r1   rC   r.   r)   )rM   r@   r1   rU   rU   rV   rj     s    z_cs_matrix._with_datac                 C   s   |  |}tt| j| | j }| j|j }t| j| j|j|jf|d}tj	| jj
|d}tj	||d}g d}||v rtj	|tjd}	ntj	|t| j|jd}	|| j
d | j
d tj| j|dtj| j|d| jtj|j|dtj|j|d|j|||	 | j |	||f| j
d}
|
  |
S )z5apply the binary operation fn to two sparse matrices.r%   r(   )ro   r   r   r}   r~   r   r   r   )rF   r   r   r6   rf   r   rC   rA   r=   r   r.   rq   r   r)   rI   r@   re   )rM   rQ   rl   r   ZmaxnnzrP   rC   rA   Zbool_opsr@   r  rU   rU   rV   rx     s4    

	z_cs_matrix._binoptc                 C   s   |j | j krtd| |d}t|jtjrtj| j | jd}|tj	 |
 \}}d|||f< | }|j||j|jf< t|}n|}|S )z?
        Divide this matrix by a second sparse matrix.
        r   Z_eldiv_r(   r   )r.   rH   rx   r=   Z
issubdtyper)   Zinexactr   r   nanZnonzeror   r@   r]   r   r!   )rM   rQ   r   r   r]   r   rU   rU   rV   _divide_sparse  s    
z_cs_matrix._divide_sparse)NNF)N)F)T)r   )NNN)N)F)F)NNF)T)NN)T)A__name__
__module____qualname____doc__r5   r\   r   r8   rL   rn   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   r   r   r   r   r   r   r   r   r   r   r   rk   Z$_cs_matrix__get_has_canonical_formatZ$_cs_matrix__set_has_canonical_formatpropertyr  ri   Z_cs_matrix__get_sortedZ_cs_matrix__set_sortedr   r  r   re   r  rj   rx   r  rU   rU   rU   rV   r$      s   
Q



F	$""
h$







(

'L




	"

"r$   c                 C   s   | d u rd| }}nt | trJ| |\}}}|dkr>tdt||}nRt| r| dk rb| |7 } | | d  }}|dk s||krtd|||f ntd||fS )Nr   r   z$slicing with step != 1 not supportedz'index out of bounds: 0 <= %d < %d <= %dzexpected slice or scalar)r9   r   rA   rH   rg   r   r   	TypeError)slnumr   r   ZstriderU   rU   rV   r     s"    
r   )0r  __all__warningsr   rs   Znumpyr=   Zscipy._lib._utilr   baser   r   r   r@   r   r	   Zdiar
    r   r   r   r   r   r   r   r   r   _indexr   Zsputilsr   r   r   r   r   r   r   r   r   r   r   r    r!   r"   r#   r$   r   rU   rU   rU   rV   <module>   s.   (D         y