Sparse matrix

Example of sparse matrix
The above sparse matrix contains only 9 non-zero elements, with 26 zero elements. Its sparsity is 74%, and its density is 26%.
A sparse matrix obtained when solving a finite element problem in two dimensions. The non-zero elements are shown in black.

In numerical analysis and scientific computing, a sparse matrix or sparse array is a matrix in which most of the elements are zero.[1] There is no strict definition regarding the proportion of zero-value elements for a matrix to qualify as sparse but a common criterion is that the number of non-zero elements is roughly equal to the number of rows or columns. By contrast, if most of the elements are non-zero, the matrix is considered dense.[1] The number of zero-valued elements divided by the total number of elements (e.g., m × n for an m × n matrix) is sometimes referred to as the sparsity of the matrix.

Conceptually, sparsity corresponds to systems with few pairwise interactions. For example, consider a line of balls connected by springs from one to the next: this is a sparse system as only adjacent balls are coupled. By contrast, if the same line of balls were to have springs connecting each ball to all other balls, the system would correspond to a dense matrix. The concept of sparsity is useful in combinatorics and application areas such as network theory and numerical analysis, which typically have a low density of significant data or connections. Large sparse matrices often appear in scientific or engineering applications when solving partial differential equations.

When storing and manipulating sparse matrices on a computer, it is beneficial and often necessary to use specialized algorithms and data structures that take advantage of the sparse structure of the matrix. Specialized computers have been made for sparse matrices,[2] as they are common in the machine learning field.[3] Operations using standard dense-matrix structures and algorithms are slow and inefficient when applied to large sparse matrices as processing and memory are wasted on the zeros. Sparse data is by nature more easily compressed and thus requires significantly less storage. Some very large sparse matrices are infeasible to manipulate using standard dense-matrix algorithms.

Special cases

Banded

An important special type of sparse matrices is band matrix, defined as follows. The lower bandwidth of a matrix A is the smallest number p such that the entry ai,j vanishes whenever i > j + p. Similarly, the upper bandwidth is the smallest number p such that ai,j = 0 whenever i < jp (Golub & Van Loan 1996, §1.2.1). For example, a tridiagonal matrix has lower bandwidth 1 and upper bandwidth 1. As another example, the following sparse matrix has lower and upper bandwidth both equal to 3. Notice that zeros are represented with dots for clarity.

Matrices with reasonably small upper and lower bandwidth are known as band matrices and often lend themselves to simpler algorithms than general sparse matrices; or one can sometimes apply dense matrix algorithms and gain efficiency simply by looping over a reduced number of indices.

By rearranging the rows and columns of a matrix A it may be possible to obtain a matrix A with a lower bandwidth. A number of algorithms are designed for bandwidth minimization.

Diagonal

A very efficient structure for an extreme case of band matrices, the diagonal matrix, is to store just the entries in the main diagonal as a one-dimensional array, so a diagonal n × n matrix requires only n entries.

Symmetric

A symmetric sparse matrix arises as the adjacency matrix of an undirected graph; it can be stored efficiently as an adjacency list.

Block diagonal

A block-diagonal matrix consists of sub-matrices along its diagonal blocks. A block-diagonal matrix A has the form

where Ak is a square matrix for all k = 1, ..., n.

Use

Reducing fill-in

The fill-in of a matrix are those entries that change from an initial zero to a non-zero value during the execution of an algorithm. To reduce the memory requirements and the number of arithmetic operations used during an algorithm, it is useful to minimize the fill-in by switching rows and columns in the matrix. The symbolic Cholesky decomposition can be used to calculate the worst possible fill-in before doing the actual Cholesky decomposition.

There are other methods than the Cholesky decomposition in use. Orthogonalization methods (such as QR factorization) are common, for example, when solving problems by least squares methods. While the theoretical fill-in is still the same, in practical terms the "false non-zeros" can be different for different methods. And symbolic versions of those algorithms can be used in the same manner as the symbolic Cholesky to compute worst case fill-in.

Solving sparse matrix equations

Both iterative and direct methods exist for sparse matrix solving.

Iterative methods, such as conjugate gradient method and GMRES utilize fast computations of matrix-vector products , where matrix is sparse. The use of preconditioners can significantly accelerate convergence of such iterative methods.

Storage

A matrix is typically stored as a two-dimensional array. Each entry in the array represents an element ai,j of the matrix and is accessed by the two indices i and j. Conventionally, i is the row index, numbered from top to bottom, and j is the column index, numbered from left to right. For an m × n matrix, the amount of memory required to store the matrix in this format is proportional to m × n (disregarding the fact that the dimensions of the matrix also need to be stored).

In the case of a sparse matrix, substantial memory requirement reductions can be realized by storing only the non-zero entries. Depending on the number and distribution of the non-zero entries, different data structures can be used and yield huge savings in memory when compared to the basic approach. The trade-off is that accessing the individual elements becomes more complex and additional structures are needed to be able to recover the original matrix unambiguously.

Formats can be divided into two groups:

  • Those that support efficient modification, such as DOK (Dictionary of keys), LIL (List of lists), or COO (Coordinate list). These are typically used to construct the matrices.
  • Those that support efficient access and matrix operations, such as CSR (Compressed Sparse Row) or CSC (Compressed Sparse Column).

Dictionary of keys (DOK)

DOK consists of a dictionary that maps (row, column)-pairs to the value of the elements. Elements that are missing from the dictionary are taken to be zero. The format is good for incrementally constructing a sparse matrix in random order, but poor for iterating over non-zero values in lexicographical order. One typically constructs a matrix in this format and then converts to another more efficient format for processing.[4]

List of lists (LIL)

LIL stores one list per row, with each entry containing the column index and the value. Typically, these entries are kept sorted by column index for faster lookup. This is another format good for incremental matrix construction.[5]

Coordinate list (COO)

COO stores a list of (row, column, value) tuples. Ideally, the entries are sorted first by row index and then by column index, to improve random access times. This is another format that is good for incremental matrix construction.[6]

Compressed sparse row (CSR, CRS or Yale format)

The compressed sparse row (CSR) or compressed row storage (CRS) or Yale format represents a matrix M by three (one-dimensional) arrays, that respectively contain nonzero values, the extents of rows, and column indices. It is similar to COO, but compresses the row indices, hence the name. This format allows fast row access and matrix-vector multiplications (Mx). The CSR format has been in use since at least the mid-1960s, with the first complete description appearing in 1967.[7]

The CSR format stores a sparse m × n matrix M in row form using three (one-dimensional) arrays (V, COL_INDEX, ROW_INDEX). Let NNZ denote the number of nonzero entries in M. (Note that zero-based indices shall be used here.)

  • The arrays V and COL_INDEX are of length NNZ, and contain the non-zero values and the column indices of those values respectively
  • COL_INDEX contains the column in which the corresponding entry V is located.
  • The array ROW_INDEX is of length m + 1 and encodes the index in V and COL_INDEX where the given row starts. This is equivalent to ROW_INDEX[j] encoding the total number of nonzeros above row j. The last element is NNZ , i.e., the fictitious index in V immediately after the last valid index NNZ − 1.[8]

For example, the matrix is a 4 × 4 matrix with 4 nonzero elements, hence

V         = [ 5 8 3 6 ]
COL_INDEX = [ 0 1 2 1 ]
ROW_INDEX = [ 0 1 2 3 4 ] 

assuming a zero-indexed language.

To extract a row, we first define:

row_start = ROW_INDEX[row]
row_end   = ROW_INDEX[row + 1]

Then we take slices from V and COL_INDEX starting at row_start and ending at row_end.

To extract the row 1 (the second row) of this matrix we set row_start=1 and row_end=2. Then we make the slices V[1:2] = [8] and COL_INDEX[1:2] = [1]. We now know that in row 1 we have one element at column 1 with value 8.

In this case the CSR representation contains 13 entries, compared to 16 in the original matrix. The CSR format saves on memory only when NNZ < (m (n − 1) − 1) / 2.

Another example, the matrix is a 4 × 6 matrix (24 entries) with 8 nonzero elements, so

V         = [ 10 20 30 40 50 60 70 80 ]
COL_INDEX = [  0  1  1  3  2  3  4  5 ]   
ROW_INDEX = [  0  2  4  7  8 ]

The whole is stored as 21 entries: 8 in V, 8 in COL_INDEX, and 5 in ROW_INDEX.

  • ROW_INDEX splits the array V into rows: (10, 20) (30, 40) (50, 60, 70) (80), indicating the index of V (and COL_INDEX) where each row starts and ends;
  • COL_INDEX aligns values in columns: (10, 20, ...) (0, 30, 0, 40, ...)(0, 0, 50, 60, 70, 0) (0, 0, 0, 0, 0, 80).

Note that in this format, the first value of ROW_INDEX is always zero and the last is always NNZ, so they are in some sense redundant (although in programming languages where the array length needs to be explicitly stored, NNZ would not be redundant). Nonetheless, this does avoid the need to handle an exceptional case when computing the length of each row, as it guarantees the formula ROW_INDEX[i + 1] − ROW_INDEX[i] works for any row i. Moreover, the memory cost of this redundant storage is likely insignificant for a sufficiently large matrix.

The (old and new) Yale sparse matrix formats are instances of the CSR scheme. The old Yale format works exactly as described above, with three arrays; the new format combines ROW_INDEX and COL_INDEX into a single array and handles the diagonal of the matrix separately.[9]

For logical adjacency matrices, the data array can be omitted, as the existence of an entry in the row array is sufficient to model a binary adjacency relation.

It is likely known as the Yale format because it was proposed in the 1977 Yale Sparse Matrix Package report from Department of Computer Science at Yale University.[10]

Compressed sparse column (CSC or CCS)

CSC is similar to CSR except that values are read first by column, a row index is stored for each value, and column pointers are stored. For example, CSC is (val, row_ind, col_ptr), where val is an array of the (top-to-bottom, then left-to-right) non-zero values of the matrix; row_ind is the row indices corresponding to the values; and, col_ptr is the list of val indexes where each column starts. The name is based on the fact that column index information is compressed relative to the COO format. One typically uses another format (LIL, DOK, COO) for construction. This format is efficient for arithmetic operations, column slicing, and matrix-vector products. This is the traditional format for specifying a sparse matrix in MATLAB (via the sparse function).

Software

Many software libraries support sparse matrices, and provide solvers for sparse matrix equations. The following are open-source:

  • PETSc, a large C library, containing many different matrix solvers for a variety of matrix storage formats.
  • Trilinos, a large C++ library, with sub-libraries dedicated to the storage of dense and sparse matrices and solution of corresponding linear systems.
  • Eigen3 is a C++ library that contains several sparse matrix solvers. However, none of them are parallelized.
  • MUMPS (MUltifrontal Massively Parallel sparse direct Solver), written in Fortran90, is a frontal solver.
  • deal.II, a finite element library that also has a sub-library for sparse linear systems and their solution.
  • DUNE, another finite element library that also has a sub-library for sparse linear systems and their solution.
  • Armadillo provides a user-friendly C++ wrapper for BLAS and LAPACK.
  • SciPy provides support for several sparse matrix formats, linear algebra, and solvers.
  • ALGLIB is a C++ and C# library with sparse linear algebra support
  • ARPACK Fortran 77 library for sparse matrix diagonalization and manipulation, using the Arnoldi algorithm
  • SLEPc Library for solution of large scale linear systems and sparse matrices
  • scikit-learn, a Python library for machine learning, provides support for sparse matrices and solvers
  • SparseArrays is a Julia standart library.

History

The term sparse matrix was possibly coined by Harry Markowitz who initiated some pioneering work but then left the field.[11]

See also

Notes

  1. ^ a b Yan, Di; Wu, Tao; Liu, Ying; Gao, Yang (2017). "An efficient sparse-dense matrix multiplication on a multicore system". 2017 IEEE 17th International Conference on Communication Technology (ICCT). IEEE. pp. 1880–3. doi:10.1109/icct.2017.8359956. ISBN 978-1-5090-3944-9. The computation kernel of DNN is large sparse-dense matrix multiplication. In the field of numerical analysis, a sparse matrix is a matrix populated primarily with zeros as elements of the table. By contrast, if the number of non-zero elements in a matrix is relatively large, then it is commonly considered a dense matrix. The fraction of zero elements (non-zero elements) in a matrix is called the sparsity (density). Operations using standard dense-matrix structures and algorithms are relatively slow and consume large amounts of memory when applied to large sparse matrices.
  2. ^ "Cerebras Systems Unveils the Industry's First Trillion Transistor Chip". www.businesswire.com. 2019-08-19. Retrieved 2019-12-02. The WSE contains 400,000 AI-optimized compute cores. Called SLAC™ for Sparse Linear Algebra Cores, the compute cores are flexible, programmable, and optimized for the sparse linear algebra that underpins all neural network computation
  3. ^ "Argonne National Laboratory Deploys Cerebras CS-1, the World's Fastest Artificial Intelligence Computer | Argonne National Laboratory". www.anl.gov (Press release). Retrieved 2019-12-02. The WSE is the largest chip ever made at 46,225 square millimeters in area, it is 56.7 times larger than the largest graphics processing unit. It contains 78 times more AI optimized compute cores, 3,000 times more high speed, on-chip memory, 10,000 times more memory bandwidth, and 33,000 times more communication bandwidth.
  4. ^ See scipy.sparse.dok_matrix
  5. ^ See scipy.sparse.lil_matrix
  6. ^ See scipy.sparse.coo_matrix
  7. ^ Buluç, Aydın; Fineman, Jeremy T.; Frigo, Matteo; Gilbert, John R.; Leiserson, Charles E. (2009). Parallel sparse matrix-vector and matrix-transpose-vector multiplication using compressed sparse blocks (PDF). ACM Symp. on Parallelism in Algorithms and Architectures. CiteSeerX 10.1.1.211.5256.
  8. ^ Saad 2003
  9. ^ Bank, Randolph E.; Douglas, Craig C. (1993), "Sparse Matrix Multiplication Package (SMMP)" (PDF), Advances in Computational Mathematics, 1: 127–137, doi:10.1007/BF02070824, S2CID 6412241
  10. ^ Eisenstat, S. C.; Gursky, M. C.; Schultz, M. H.; Sherman, A. H. (April 1977). "Yale Sparse Matrix Package" (PDF). Archived (PDF) from the original on April 6, 2019. Retrieved 6 April 2019.
  11. ^ Oral history interview with Harry M. Markowitz, pp. 9, 10.

References

Further reading

Read other articles:

I simboli di rischio chimico (vecchi e nuovi),[1] o pittogrammi di pericolo, sono simboli che vengono stampati sulle etichette dei prodotti chimici e che servono a informare immediatamente riguardo ai tipi di pericoli connessi all'uso, alla manipolazione, al trasporto e alla conservazione degli stessi. L'uso dei simboli di rischio è spesso regolato da leggi e/o da direttive di organizzazioni di standardizzazione. Tali simboli, pur conservando lo stesso significato, possono presentare...

 

 

Menteri Badan Usaha Milik Negara IndonesiaLogo Kementerian Badan Usaha Milik Negara IndonesiaBendera Kementerian Badan Usaha Milik Negara IndonesiaPetahanaErick Thohirsejak 23 Oktober 2019Kementerian Badan Usaha Milik Negara IndonesiaDitunjuk olehPresiden IndonesiaPejabat perdanaTanri AbengDibentuk16 Maret 1998; 25 tahun lalu (1998-03-16)Situs webbumn.go.id Menteri Badan Usaha Milik Negara Indonesia, umumnya disingkat Menteri BUMN adalah kepala Kementerian Badan Usaha Milik Negara I...

 

 

Mohamad IrfanLahirMohamad IrfanKebangsaanIndonesiaAlmamaterUniversitas PakuanPekerjaanpengusahaDikenal atasFounder Reglow Indonesia Mohamad Irfan atau yang dikenal dengan Irfan adalah seorang pengusaha perawatan dan kecantikan pemilik dari Brand Reglow Indonesia.[1] Awal Karir Mohamad Irfan mengawali karir nya dengan menjadi petani singkong[2] seluas 7 hektar di Cigombong, Bogor setelah menyelesaikan kuliah di Universitas Pakuan dan Gagal Panen.[3][4][5 ...

Dimethylcadmium Identifiers CAS Number 506-82-1 3D model (JSmol) Interactive image ChemSpider 10254476 ECHA InfoCard 100.007.324 EC Number 208-055-4 PubChem CID 10479 UNII 0T3G3H597H CompTox Dashboard (EPA) DTXSID20964832 InChI InChI=1S/2CH3.Cd/h2*1H3;Key: KVVGSXJGEUULNM-UHFFFAOYSA-N SMILES C[Cd]C Properties Chemical formula C2H6Cd Molar mass 142.484 g·mol−1 Appearance Colorless liquid Odor Foul; unpleasant; metallic; disagreeable; characteristic Density 1.985 g/mL Meltin...

 

 

Decisive battle in Bolivar's campaign to liberate New Granada Battle of BoyacáPart of Bolívar's campaign to liberate New Granada and the Colombian War of IndependenceBattle of Boyaca, Martín Tovar y TovarDateAugust 7, 1819LocationBoyacá5°27′00″N 73°25′45″W / 5.45000°N 73.42917°W / 5.45000; -73.42917Result Patriot victoryBelligerents Venezuela New Granada British Legions Kingdom of SpainCommanders and leaders Simón Bolívar José Anzoátegui Francisco S...

 

 

علم المناعة خلية متعادلة (بلون بنفسجي) تلتهم بكتيريا من نوع المكورات العنقودية الذهبية المقاومة للميثيسيلين. الجهاز الجهاز المناعي فرع من علم الأحياء،  والطب الحيوي،  وطب الأطفال  التقسيمات علم المناعة الخلويةعلم المناعة السريرية علم الوراثة المناعي علم الناعة ا...

Questa voce sull'argomento centri abitati della città metropolitana di Torino è solo un abbozzo. Contribuisci a migliorarla secondo le convenzioni di Wikipedia. Villanova Canavesecomune Villanova Canavese – VedutaVeduta Chiesa Parrocchiale LocalizzazioneStato Italia Regione Piemonte Città metropolitana Torino AmministrazioneSindacoRoberto Ferrero (lista civica) dal 25-5-2014 TerritorioCoordinate45°14′06.66″N 7°32′51.08″E / 45.23518...

 

 

Синелобый амазон Научная классификация Домен:ЭукариотыЦарство:ЖивотныеПодцарство:ЭуметазоиБез ранга:Двусторонне-симметричныеБез ранга:ВторичноротыеТип:ХордовыеПодтип:ПозвоночныеИнфратип:ЧелюстноротыеНадкласс:ЧетвероногиеКлада:АмниотыКлада:ЗавропсидыКласс:Пт�...

 

 

GNU/Linux, GNU+Linux Pour les articles homonymes, voir Linux (homonymie). LinuxGNU/LinuxGNU+Linux Ubuntu, une distribution Linux. Famille UNIX Langues Anglais pour le noyau, multilingue pour la plupart des distributions Linux Type de noyau Linux État du projet En développement constant Plates-formes Géré par le noyau Linux : x86, x86-64, Itanium, DEC Alpha, ARM, H8, m68k, Microblaze, MIPS, PA-RISC, PowerPC, RISC-V, s390, SuperH, SPARC, Unicore32, Xtensa (en) Entreprise /Fondateu...

Austrian and British film director Paul L. SteinFrom a 1926 magazineBorn(1892-02-04)4 February 1892Vienna, Austria-HungaryDied2 May 1951(1951-05-02) (aged 59)London, EnglandOccupationFilm directorYears active1918 – 1950 Paul Ludwig Stein (4 February 1892 – 2 May 1951) was an Austrian and British film director with at least 67 films to his credit. Biography Born in Vienna in 1892, Stein began his film career in Berlin in 1918. He worked exclusively in the German silent fi...

 

 

Framework for machine learning This article is about statistical learning in machine learning. For its use in psychology, see Statistical learning in language acquisition. See also: Computational learning theory Part of a series onMachine learningand data mining Paradigms Supervised learning Unsupervised learning Online learning Batch learning Meta-learning Semi-supervised learning Self-supervised learning Reinforcement learning Curriculum learning Rule-based learning Quantum machine learning...

 

 

Dewi HandajaniS.E., M M. Bupati Tanggamus ke-4PetahanaMulai menjabat 2018PresidenIr. H. Joko WidodoGubernurMuhammad Ridho Ficardo Arinal DjunaidiWakilH. AM Syafi'iPendahuluBambang KurniawanPenggantiPetahana Informasi pribadiLahir03 Januari 1971 (umur 53)Banda Aceh, AcehKebangsaanIndonesiaPartai politikPDI-PSuami/istriBambang KurniawanPekerjaanBupati TanggamusDikenal karenaBupati TanggamusSunting kotak info • L • B Hj. Dewi Handajani, S.E., M.M.. (lahir 3 Januari 197...

Extinct Tucanoan language of Colombia You can help expand this article with text translated from the corresponding article in Russian. (April 2024) Click [show] for important translation instructions. View a machine-translated version of the Russian article. Machine translation, like DeepL or Google Translate, is a useful starting point for translations, but translators must revise errors as necessary and confirm that the translation is accurate, rather than simply copy-pasting machine-t...

 

 

Region or constituency of the Scottish Parliament Inverness and NairnCounty constituencyfor the Scottish ParliamentInverness and Nairn shown within the Highlands and Islands electoral region and the region shown within ScotlandPopulation89,755 (2019)[1]Current constituencyCreated2011PartyScottish National PartyMSPFergus EwingCouncil areaHighlandCreated fromInverness East, Nairn & Lochaber,Ross, Skye & Inverness West Inverness and Nairn is a constituency of the Scottish Parliam...

 

 

This article needs additional citations for verification. Please help improve this article by adding citations to reliable sources. Unsourced material may be challenged and removed.Find sources: Tamenglong – news · newspapers · books · scholar · JSTOR (December 2018) (Learn how and when to remove this message) Town in Manipur, IndiaTamenglongTownTamenglongLocation in Manipur, IndiaShow map of ManipurTamenglongTamenglong (India)Show map of IndiaCoordina...

إنكي   زوجات ننهورساج  ذرية نينغال،  ونانشي،  وجيبيل  تعديل مصدري - تعديل   إنكي هو أحد أهم الآلهة في الأساطير السومرية، والذي عُرِفَ فيما بعد باسم إئا أو إيا في الأساطير الأكادية والبابلية. بُدِئَت عبادته بوصفه الراعي الأكبر لإريدو في سومر، ثم انتشرت عبادته ...

 

 

Indian dancer, choreographer, actor This article is about the dancer. For other people, see Uday Shankar (disambiguation). Uday ShankarBorn8 December 1900Udaipur, Udaipur State, British IndiaDied26 September 1977(aged 76)Kolkata, West Bengal, IndiaNationalityIndianOccupation(s)Dancer, choreographerSpouseAmala ShankarChildrenAnanda ShankarMamata ShankarParentsShyam Shankar Choudhary (father)Hemangini Devi (mother)HonoursSangeet Natak Akademi Fellowship (1962)Padma Vibhushan (1971) Uday Shankar...

 

 

匈牙利語人名顺序为先姓后名。本条目中的译名遵从此顺序。 罗饶Rózsa Miklós出生1907年4月18日布达佩斯逝世1995年7月27日(82歲)洛杉矶国籍匈牙利知名作品管弦乐《主题,变奏与终曲》《三首匈牙利素描》,五部协奏曲,电影配乐《宾虚》《王中之王》所属时期/乐派20世纪擅长类型管弦乐,电影配乐 罗饶·米克罗斯(匈牙利語:Rózsa Miklós,1907年4月18日—1995年7月27日),美籍�...

  Grand Prix Thailand 2019Detail lombaLomba ke 15 dari 19Grand Prix Sepeda Motor musim 2019Tanggal6 Oktober 2019Nama resmiPTT Thailand Grand PrixLokasiBuriram International Circuit, Buriram, ThailandSirkuitFasilitas balapan permanen4.554 km (2.830 mi)MotoGPPole positionPembalap Fabio Quartararo YamahaCatatan waktu 1:29.719 Putaran tercepatPembalap Marc Márquez HondaCatatan waktu 1:30.904 di lap 11 PodiumPertama Marc Márquez HondaKedua Fabio Quartararo YamahaKetiga Maveri...

 

 

Scottish nobleman and politician The Right HonourableThe Earl FifeKTThe Earl Fife in 1863Member of Parliament for BanffshireIn office1837–1857Preceded byGeorge FergusonSucceeded byLachlan Gordon-Duff Personal detailsBornJames Duff(1814-07-06)6 July 1814Edinburgh, ScotlandDied7 August 1879(1879-08-07) (aged 65)Spouse Lady Agnes Hay ​ ​(m. 1846; died 1869)​Children5Parent(s)Sir Alexander DuffAnne Stein James Duff, 5th Earl Fife, KT (6 July ...