Participer au site avec un Tip
Rechercher
 

Améliorations / Corrections

Vous avez des améliorations (ou des corrections) à proposer pour ce document : je vous remerçie par avance de m'en faire part, cela m'aide à améliorer le site.

Emplacement :

Description des améliorations :

Vous êtes un professionnel et vous avez besoin d'une formation ? Calcul scientifique
avec Python
Voir le programme détaillé
Module « scipy.sparse »

Classe « csc_matrix »

Informations générales

Héritage

    builtins.object
        IndexMixin
    builtins.object
        _minmax_mixin
builtins.object
    _spbase
        _data_matrix
            _cs_matrix
                _csc_base
            builtins.object
                spmatrix
                    csc_matrix

Définition

class csc_matrix(spmatrix, _csc_base):

help(csc_matrix)

Compressed Sparse Column matrix.

This can be instantiated in several ways:
    csc_matrix(D)
        where D is a 2-D ndarray

    csc_matrix(S)
        with another sparse array or matrix S (equivalent to S.tocsc())

    csc_matrix((M, N), [dtype])
        to construct an empty matrix with shape (M, N)
        dtype is optional, defaulting to dtype='d'.

    csc_matrix((data, (row_ind, col_ind)), [shape=(M, N)])
        where ``data``, ``row_ind`` and ``col_ind`` satisfy the
        relationship ``a[row_ind[k], col_ind[k]] = data[k]``.

    csc_matrix((data, indices, indptr), [shape=(M, N)])
        is the standard CSC representation where the row indices for
        column i are stored in ``indices[indptr[i]:indptr[i+1]]``
        and their corresponding values are stored in
        ``data[indptr[i]:indptr[i+1]]``.  If the shape parameter is
        not supplied, the matrix dimensions are inferred from
        the index arrays.

Attributes
----------
dtype : dtype
    Data type of the matrix
shape : 2-tuple
    Shape of the matrix
ndim : int
    Number of dimensions (this is always 2)
nnz
size
data
    CSC format data array of the matrix
indices
    CSC format index array of the matrix
indptr
    CSC format index pointer array of the matrix
has_sorted_indices
has_canonical_format
T

Notes
-----

Sparse matrices can be used in arithmetic operations: they support
addition, subtraction, multiplication, division, and matrix power.

Advantages of the CSC format
    - efficient arithmetic operations CSC + CSC, CSC * CSC, etc.
    - efficient column slicing
    - fast matrix vector products (CSR, BSR may be faster)

Disadvantages of the CSC format
  - slow row slicing operations (consider CSR)
  - changes to the sparsity structure are expensive (consider LIL or DOK)

Canonical format
  - Within each column, indices are sorted by row.
  - There are no duplicate entries.

Examples
--------

>>> import numpy as np
>>> from scipy.sparse import csc_matrix
>>> csc_matrix((3, 4), dtype=np.int8).toarray()
array([[0, 0, 0, 0],
       [0, 0, 0, 0],
       [0, 0, 0, 0]], dtype=int8)

>>> row = np.array([0, 2, 2, 0, 1, 2])
>>> col = np.array([0, 0, 1, 2, 2, 2])
>>> data = np.array([1, 2, 3, 4, 5, 6])
>>> csc_matrix((data, (row, col)), shape=(3, 3)).toarray()
array([[1, 0, 4],
       [0, 0, 5],
       [2, 3, 6]])

>>> indptr = np.array([0, 2, 3, 6])
>>> indices = np.array([0, 2, 2, 0, 1, 2])
>>> data = np.array([1, 2, 3, 4, 5, 6])
>>> csc_matrix((data, indices, indptr), shape=(3, 3)).toarray()
array([[1, 0, 4],
       [0, 0, 5],
       [2, 3, 6]])

Constructeur(s)

Signature du constructeur Description
__init__(self, arg1, shape=None, dtype=None, copy=False, *, maxprint=None)

Liste des propriétés

Nom de la propriétéDescription
dtype
formatFormat string for matrix. [extrait de format.__doc__]
has_canonical_formatWhether the array/matrix has sorted indices and no duplicates [extrait de has_canonical_format.__doc__]
has_sorted_indicesWhether the indices are sorted [extrait de has_sorted_indices.__doc__]
imag
ndim
nnzNumber of stored values, including explicit zeros. [extrait de nnz.__doc__]
real
shapeShape of the matrix [extrait de shape.__doc__]
sizeNumber of stored values. [extrait de size.__doc__]
TTranspose. [extrait de T.__doc__]

Liste des opérateurs

Opérateurs hérités de la classe _cs_matrix

__eq__, __ge__, __gt__, __le__, __lt__, __ne__

Liste des opérateurs

Opérateurs hérités de la classe IndexMixin

__getitem__, __setitem__

Liste des opérateurs

Opérateurs hérités de la classe _data_matrix

__imul__, __itruediv__, __neg__

Liste des opérateurs

Opérateurs hérités de la classe _spbase

__add__, __iadd__, __isub__, __matmul__, __mul__, __pow__, __radd__, __rmul__, __rsub__, __rtruediv__, __sub__, __truediv__

Liste des méthodes

Toutes les méthodes Méthodes d'instance Méthodes statiques Méthodes dépréciées
Signature de la méthodeDescription

Méthodes héritées de la classe _csc_base

__init_subclass__, __iter__, __subclasshook__, nonzero, tocsc, tocsr, transpose

Méthodes héritées de la classe _cs_matrix

check_format, count_nonzero, diagonal, eliminate_zeros, maximum, minimum, multiply, prune, resize, sort_indices, sorted_indices, sum, sum_duplicates, toarray, tocoo

Méthodes héritées de la classe _minmax_mixin

argmax, argmin, max, min, nanmax, nanmin

Méthodes héritées de la classe _data_matrix

__abs__, __round__, astype, conjugate, copy, power

Méthodes héritées de la classe _spbase

__bool__, __div__, __idiv__, __len__, __nonzero__, __rdiv__, __repr__, __rmatmul__, __str__, asformat, conj, dot, mean, reshape, setdiag, tobsr, todense, todia, todok, tolil, trace

Méthodes héritées de la classe spmatrix

asfptype, get_shape, getcol, getformat, getH, getmaxprint, getnnz, getrow, set_shape

Méthodes héritées de la classe object

__delattr__, __dir__, __format__, __getattribute__, __getstate__, __hash__, __reduce__, __reduce_ex__, __setattr__, __sizeof__

Vous êtes un professionnel et vous avez besoin d'une formation ? Machine Learning
avec Scikit-Learn
Voir le programme détaillé