From 2b76f5fbfd3a45b3362c8ccdb107c029004d5632 Mon Sep 17 00:00:00 2001 From: wolf Date: Mon, 20 Dec 1999 15:26:28 +0000 Subject: [PATCH] Document include files. git-svn-id: https://svn.dealii.org/trunk@2091 0785d39b-7218-0410-832d-ea1e28bc413d --- .../examples/step-by-step/step-3/step-3.cc | 64 +++++++++++++++++-- deal.II/examples/step-3/step-3.cc | 64 +++++++++++++++++-- 2 files changed, 116 insertions(+), 12 deletions(-) diff --git a/deal.II/deal.II/Attic/examples/step-by-step/step-3/step-3.cc b/deal.II/deal.II/Attic/examples/step-by-step/step-3/step-3.cc index eb81074355..93e06010aa 100644 --- a/deal.II/deal.II/Attic/examples/step-by-step/step-3/step-3.cc +++ b/deal.II/deal.II/Attic/examples/step-by-step/step-3/step-3.cc @@ -1,18 +1,67 @@ -#include -#include + // These include files are already + // known to you. They declare the + // classes which handle + // triangulations and enumerate the + // degrees of freedom. #include +#include + // And this is the file in which the + // functions are declared which + // create grids. +#include + + // The next three files contain + // classes which are needed for loops + // over all cells and to get the + // information from the cell objects. #include #include -#include -#include #include + + // In this file are the finite + // element descriptions. #include -#include + + // And this file is needed for the + // creation of sparsity patterns of + // sparse matrices, as shown in + // previous examples: #include -#include + + // The next two file are needed for + // assembling the matrix using + // quadrature on each cell. The + // classes declared in them will be + // explained below. +#include +#include + + // The following three include files + // we need for the treatment of + // boundary values: +#include #include #include + // These include files are for the + // linear algebra which we employ to + // solve the system of equations + // arising from the finite element + // discretization of the Laplace + // equation. We will use vectors and + // full matrices for assembling the + // system of equations locally on + // each cell, and transfer the + // results into a sparse matrix. We + // will then use a Conjugate Gradient + // solver to solve the problem, for + // which we need a preconditioner (in + // this program, we use the identity + // preconditioner which does nothing, + // but we need to include the file + // anyway), and a class which + // provides the solver with some + // memory for temporary vectors. #include #include #include @@ -20,6 +69,9 @@ #include #include + // Finally, this is for output to a + // file. +#include #include diff --git a/deal.II/examples/step-3/step-3.cc b/deal.II/examples/step-3/step-3.cc index eb81074355..93e06010aa 100644 --- a/deal.II/examples/step-3/step-3.cc +++ b/deal.II/examples/step-3/step-3.cc @@ -1,18 +1,67 @@ -#include -#include + // These include files are already + // known to you. They declare the + // classes which handle + // triangulations and enumerate the + // degrees of freedom. #include +#include + // And this is the file in which the + // functions are declared which + // create grids. +#include + + // The next three files contain + // classes which are needed for loops + // over all cells and to get the + // information from the cell objects. #include #include -#include -#include #include + + // In this file are the finite + // element descriptions. #include -#include + + // And this file is needed for the + // creation of sparsity patterns of + // sparse matrices, as shown in + // previous examples: #include -#include + + // The next two file are needed for + // assembling the matrix using + // quadrature on each cell. The + // classes declared in them will be + // explained below. +#include +#include + + // The following three include files + // we need for the treatment of + // boundary values: +#include #include #include + // These include files are for the + // linear algebra which we employ to + // solve the system of equations + // arising from the finite element + // discretization of the Laplace + // equation. We will use vectors and + // full matrices for assembling the + // system of equations locally on + // each cell, and transfer the + // results into a sparse matrix. We + // will then use a Conjugate Gradient + // solver to solve the problem, for + // which we need a preconditioner (in + // this program, we use the identity + // preconditioner which does nothing, + // but we need to include the file + // anyway), and a class which + // provides the solver with some + // memory for temporary vectors. #include #include #include @@ -20,6 +69,9 @@ #include #include + // Finally, this is for output to a + // file. +#include #include -- 2.39.5