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 ? Deep Learning avec Python
et Keras et Tensorflow
Voir le programme détaillé
Module « scipy.sparse »

Classe « dia_matrix »

Informations générales

Héritage

builtins.object
    _spbase
        _data_matrix
            _dia_base
        builtins.object
            spmatrix
                dia_matrix

Définition

class dia_matrix(spmatrix, _dia_base):

help(dia_matrix)

Sparse matrix with DIAgonal storage.

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

    dia_matrix(S)
        with another sparse array or matrix S (equivalent to S.todia())

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

    dia_matrix((data, offsets), shape=(M, N))
        where the ``data[k,:]`` stores the diagonal entries for
        diagonal ``offsets[k]`` (See example below)

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
    DIA format data array of the matrix
offsets
    DIA format offset array of the matrix
T

Notes
-----

Sparse matrices can be used in arithmetic operations: they support
addition, subtraction, multiplication, division, and matrix power.
Sparse matrices with DIAgonal storage do not support slicing.

Examples
--------

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

>>> data = np.array([[1, 2, 3, 4]]).repeat(3, axis=0)
>>> offsets = np.array([0, -1, 2])
>>> dia_matrix((data, offsets), shape=(4, 4)).toarray()
array([[1, 0, 3, 0],
       [1, 2, 0, 4],
       [0, 2, 3, 0],
       [0, 0, 3, 4]])

>>> from scipy.sparse import dia_matrix
>>> n = 10
>>> ex = np.ones(n)
>>> data = np.array([ex, 2 * ex, ex])
>>> offsets = np.array([-1, 0, 1])
>>> dia_matrix((data, offsets), shape=(n, n)).toarray()
array([[2., 1., 0., ..., 0., 0., 0.],
       [1., 2., 1., ..., 0., 0., 0.],
       [0., 1., 2., ..., 0., 0., 0.],
       ...,
       [0., 0., 0., ..., 2., 1., 0.],
       [0., 0., 0., ..., 1., 2., 1.],
       [0., 0., 0., ..., 0., 1., 2.]])

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__]
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 _data_matrix

__imul__, __itruediv__, __neg__

Liste des opérateurs

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

__add__, __eq__, __ge__, __gt__, __iadd__, __isub__, __le__, __lt__, __matmul__, __mul__, __ne__, __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 _dia_base

__init_subclass__, __repr__, __subclasshook__, count_nonzero, diagonal, resize, sum, tocoo, tocsc, todia, transpose

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__, __iter__, __len__, __nonzero__, __rdiv__, __rmatmul__, __str__, asformat, conj, dot, maximum, mean, minimum, multiply, nonzero, reshape, setdiag, toarray, tobsr, tocsr, todense, 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 ? Coder avec une
Intelligence Artificielle
Voir le programme détaillé