]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Change include file names.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 9 Dec 1999 16:47:21 +0000 (16:47 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 9 Dec 1999 16:47:21 +0000 (16:47 +0000)
git-svn-id: https://svn.dealii.org/trunk@2028 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/tutorial/chapter-1.elements/condense.html
deal.II/doc/tutorial/chapter-1.elements/dofs.html
deal.II/doc/tutorial/chapter-1.elements/matrix_generation.html
deal.II/doc/tutorial/chapter-1.elements/matrix_structure.html
deal.II/doc/tutorial/chapter-1.elements/output.html
deal.II/doc/tutorial/chapter-1.elements/solve.html

index e11bd3a990fcfe3f0a6b4a929a1cdb5efa7ccf07..3cbd1b1ac867b78054e0561e2c1c1c8f90fc9387 100644 (file)
@@ -68,10 +68,10 @@ function calls needed. Be sure to use them in their appropriate places.
 </p>
 <pre class="example">
 <code>
-#include &lt;grid/dof.h&gt;
-#include &lt;lac/sparsematrix.h&gt;
-#include &lt;grid/dof_constraints.h&gt;
-#include &lt;basic/dof_tools.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
+#include &lt;dofs/dof_constraints.h&gt;
+#include &lt;dofs/dof_tools.h&gt;
 
 const unsigned int dim=2; // Work in two dimensions, could also be three
 SparseMatrixStruct sparsity_pattern;
index 69377289a74f53461ef939a6142ce40dcdec2fb9..0423d72ff460f34c66ec3f026c8c3f33e536ccfc 100644 (file)
@@ -73,7 +73,7 @@ The finite elements used are bilinear.
 <pre class="example">
 <code>
 #include &lt;grid/tria.h&gt;
-#include &lt;grid/dof.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
 #include &lt;grid/grid_generator.h&gt;
 #include &lt;fe/fe_lib.lagrange.h&gt;
 
index 0eb6b652ad32857f4843a17b5ea8a0a013186d97..da3bfcc263df7600e050ee1fe2041435a2fac570 100644 (file)
@@ -52,8 +52,8 @@ with 100 rows and 50 columns in two different ways.
 </p>
 <pre class="example">
 <code>
-#include &lt;grid/dof.h&gt;
-#include &lt;lac/fullmatrix.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
+#include &lt;lac/full_matrix.h&gt;
 
 FullMatrix&lt;double&gt; A;
 
@@ -89,8 +89,8 @@ appropriate places. This example initializes a sparse square matrix structure.
 </p>
 <pre class="example">
 <code>
-#include &lt;grid/dof.h&gt;
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 
 
 const unsigned int dim=2; // For example
index 2c16e186e3fc4ab664fcabc2aea3d836e2470821..1b52466b8a2f4b58d34e7882be5febc8740d6f7a 100644 (file)
@@ -118,9 +118,9 @@ appropriate places. This example initializes a sparse square matrix structure.
 </p>
 <pre class="example">
 <code>
-#include &lt;grid/dof.h&gt;
-#include &lt;lac/sparsematrix.h&gt;
-#include &lt;basic/dof_tools.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
+#include &lt;dofs/dof_tools.h&gt;
 
 
 const unsigned int dim=2; // For example
index 6b88d97ebc32b375dd9fbefb9de5a3fd19941f4b..fa57e646468d0d0c82a160332a367b1daf008e74 100644 (file)
@@ -245,7 +245,7 @@ to a file if you want to use the data later on.
   <td>1.</td>
   <td>Use the correct include-file.
   </td>
-  <td><code>#include &lt;basic/data_out.h&gt;</code>
+  <td><code>#include &lt;numerics/data_out.h&gt;</code>
   </td>
 </tr>
 <tr>
@@ -543,7 +543,7 @@ to which parameters can be passed.
   <td>1.</td>
   <td>Use the correct include-file.
   </td>
-  <td><code>#include &lt;basic/grid_out.h&gt;</code>
+  <td><code>#include &lt;grid/grid_out.h&gt;</code>
   </td>
 </tr>
 <tr>
@@ -583,8 +583,8 @@ to which parameters can be passed.
   <td>1.</td>
   <td>Use the correct include-files.
   </td>
-  <td><code>#include &lt;basic/grid_out.h&gt;</code><br>
-      <code>#include &lt;basic/data_out_base.h&gt;</code>
+  <td><code>#include &lt;grid/grid_out.h&gt;</code><br>
+      <code>#include &lt;numerics/data_out_base.h&gt;</code>
   </td>
 </tr>
 <tr>
index 38283ebece04f908e4aa87df478577af44f6e0c3..b9bd8d6c1f0e78be16231eeba725333e173834de 100644 (file)
@@ -146,7 +146,7 @@ doubles and the right hand side a vector of doubles.
 <code>
 #include &lt;lac/solver_control.h&gt;
 #include &lt;lac/solver_selector.h&gt;
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 #include &lt;lac/vector.h&gt;
 
 SolverControl control;
@@ -202,8 +202,8 @@ of the problem <code>Au=f</code>.
 <pre class="example">
 <code>
 #include &lt;lac/precondition_selector.h&gt;
-#include &lt;grid/dof.h&gt;
-#include &lt;lac/fullmatrix.h&gt;
+#include &lt;dofs/dof_handler.h&gt;
+#include &lt;lac/full_matrix.h&gt;
 
 FullMatrix&lt;double&gt; A(100,50);
 
@@ -237,7 +237,7 @@ we solve the problem.
 #include &lt;lac/precondition_selector.h&gt;
 
 // Include files for matrices and vectors
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 #include &lt;lac/vector.h&gt;
 
 // Initialize the solver control and the solver
@@ -287,7 +287,7 @@ we solve the problem.
 #include &lt;lac/precondition_selector.h&gt;
 
 // Include files for matrices and vectors
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 #include &lt;lac/vector.h&gt;
 
 // Initialize the solver control and the solver
@@ -348,7 +348,7 @@ vectors.
 #include &lt;lac/precondition_selector.h&gt;
 
 // Include files for matrices and vectors
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 #include &lt;lac/vector.h&gt;
 
 // Initialize the solver control and the solver
@@ -403,7 +403,7 @@ we solve the problem. We use the default damping parameter of 1.
 #include &lt;lac/precondition_selector.h&gt;
 
 // Include files for matrices and vectors
-#include &lt;lac/sparsematrix.h&gt;
+#include &lt;lac/sparse_matrix.h&gt;
 #include &lt;lac/vector.h&gt;
 
 // Initialize the solver control and the solver

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.