]> https://gitweb.dealii.org/ - dealii.git/commitdiff
More on sparsity.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Mon, 15 Aug 2011 00:22:00 +0000 (00:22 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Mon, 15 Aug 2011 00:22:00 +0000 (00:22 +0000)
git-svn-id: https://svn.dealii.org/trunk@24063 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/examples/step-2/doc/intro.dox

index 5b0b69b33d83667841364d49cbdac994639a7e09..6c4b30f3946748c7b6f78e49b2728c42af3b5095 100644 (file)
@@ -36,9 +36,22 @@ number of nonzero entries per row is five, and therefore independent of the
 total size of the matrix.)  Sparsity is one of the distinguishing feature of
 the finite element method compared to, say, approximating the solution of a
 partial differential equation using a Taylor expension and matching
-coefficients, or using a Fourier basis. In practical terms, it is the sparsity
-of matrices that enables us to solve problems with millions or billions of
-unknowns.
+coefficients, or using a Fourier basis. 
+
+In practical terms, it is the sparsity of matrices that enables us to solve
+problems with millions or billions of unknowns. To understand this, note that
+a matrix with $N$ rows, each with a fixed upper bound for the number of
+nonzero entries, requires ${\cal O}(N)$ memory locations for storage, and a
+matrix-vector multiplication also requires only ${\cal O}(N)$
+operations. Consequently, if we had a linear solver that requires only a fixed
+number of matrix-vector multiplications to come up with the solution of a
+linear system with this matrix, then we would have a solver that can find the
+values of all $N$ unknowns with optimal complexity, i.e., with a total of
+${\cal O}(N)$ operations. It is clear that this wouldn't be possible if the
+matrix were not sparse, but it also requires very specialized solvers such as
+multigrid methods to satisfy the requirement that the solution requires only a
+fixed number of matrix-vector multiplications. We will frequently look at the
+question of what solver to use in the remaining programs of this tutorial.
 
 The sparsity is generated by the fact that finite element shape
 functions are defined locally on individual cells, rather than
@@ -50,5 +63,6 @@ optimized for any particular purpose. However, for
 some algorithms, especially for some linear solvers and preconditioners, it is
 advantageous to have the degrees of freedom numbered in a certain
 order, and we will use the algorithm of Cuthill and McKee to do
-so. The results are written to a file and visualized using GNUPLOT; you get to
+so. The results are written to a file and visualized using a simple
+visualization program; you get to
 see the outcome in the <a href="#Results">results section below</a>.

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.