From: wolf Date: Thu, 9 Dec 1999 16:47:21 +0000 (+0000) Subject: Change include file names. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=48f3d0cb42c97774b7635638751080ffcd33f6e3;p=dealii-svn.git Change include file names. git-svn-id: https://svn.dealii.org/trunk@2028 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/doc/tutorial/chapter-1.elements/condense.html b/deal.II/doc/tutorial/chapter-1.elements/condense.html index e11bd3a990..3cbd1b1ac8 100644 --- a/deal.II/doc/tutorial/chapter-1.elements/condense.html +++ b/deal.II/doc/tutorial/chapter-1.elements/condense.html @@ -68,10 +68,10 @@ function calls needed. Be sure to use them in their appropriate places.

 
-#include <grid/dof.h>
-#include <lac/sparsematrix.h>
-#include <grid/dof_constraints.h>
-#include <basic/dof_tools.h>
+#include <dofs/dof_handler.h>
+#include <lac/sparse_matrix.h>
+#include <dofs/dof_constraints.h>
+#include <dofs/dof_tools.h>
 
 const unsigned int dim=2; // Work in two dimensions, could also be three
 SparseMatrixStruct sparsity_pattern;
diff --git a/deal.II/doc/tutorial/chapter-1.elements/dofs.html b/deal.II/doc/tutorial/chapter-1.elements/dofs.html
index 69377289a7..0423d72ff4 100644
--- a/deal.II/doc/tutorial/chapter-1.elements/dofs.html
+++ b/deal.II/doc/tutorial/chapter-1.elements/dofs.html
@@ -73,7 +73,7 @@ The finite elements used are bilinear.
 
 
 #include <grid/tria.h>
-#include <grid/dof.h>
+#include <dofs/dof_handler.h>
 #include <grid/grid_generator.h>
 #include <fe/fe_lib.lagrange.h>
 
diff --git a/deal.II/doc/tutorial/chapter-1.elements/matrix_generation.html b/deal.II/doc/tutorial/chapter-1.elements/matrix_generation.html
index 0eb6b652ad..da3bfcc263 100644
--- a/deal.II/doc/tutorial/chapter-1.elements/matrix_generation.html
+++ b/deal.II/doc/tutorial/chapter-1.elements/matrix_generation.html
@@ -52,8 +52,8 @@ with 100 rows and 50 columns in two different ways.
 

 
-#include <grid/dof.h>
-#include <lac/fullmatrix.h>
+#include <dofs/dof_handler.h>
+#include <lac/full_matrix.h>
 
 FullMatrix<double> A;
 
@@ -89,8 +89,8 @@ appropriate places. This example initializes a sparse square matrix structure.
 

 
-#include <grid/dof.h>
-#include <lac/sparsematrix.h>
+#include <dofs/dof_handler.h>
+#include <lac/sparse_matrix.h>
 
 
 const unsigned int dim=2; // For example
diff --git a/deal.II/doc/tutorial/chapter-1.elements/matrix_structure.html b/deal.II/doc/tutorial/chapter-1.elements/matrix_structure.html
index 2c16e186e3..1b52466b8a 100644
--- a/deal.II/doc/tutorial/chapter-1.elements/matrix_structure.html
+++ b/deal.II/doc/tutorial/chapter-1.elements/matrix_structure.html
@@ -118,9 +118,9 @@ appropriate places. This example initializes a sparse square matrix structure.
 

 
-#include <grid/dof.h>
-#include <lac/sparsematrix.h>
-#include <basic/dof_tools.h>
+#include <dofs/dof_handler.h>
+#include <lac/sparse_matrix.h>
+#include <dofs/dof_tools.h>
 
 
 const unsigned int dim=2; // For example
diff --git a/deal.II/doc/tutorial/chapter-1.elements/output.html b/deal.II/doc/tutorial/chapter-1.elements/output.html
index 6b88d97ebc..fa57e64646 100644
--- a/deal.II/doc/tutorial/chapter-1.elements/output.html
+++ b/deal.II/doc/tutorial/chapter-1.elements/output.html
@@ -245,7 +245,7 @@ to a file if you want to use the data later on.
   1.
   Use the correct include-file.
   
-  #include <basic/data_out.h>
+  #include <numerics/data_out.h>
   
 
 
@@ -543,7 +543,7 @@ to which parameters can be passed.
   1.
   Use the correct include-file.
   
-  #include <basic/grid_out.h>
+  #include <grid/grid_out.h>
   
 
 
@@ -583,8 +583,8 @@ to which parameters can be passed.
   1.
   Use the correct include-files.
   
-  #include <basic/grid_out.h>
- #include <basic/data_out_base.h> + #include <grid/grid_out.h>
+ #include <numerics/data_out_base.h> diff --git a/deal.II/doc/tutorial/chapter-1.elements/solve.html b/deal.II/doc/tutorial/chapter-1.elements/solve.html index 38283ebece..b9bd8d6c1f 100644 --- a/deal.II/doc/tutorial/chapter-1.elements/solve.html +++ b/deal.II/doc/tutorial/chapter-1.elements/solve.html @@ -146,7 +146,7 @@ doubles and the right hand side a vector of doubles. #include <lac/solver_control.h> #include <lac/solver_selector.h> -#include <lac/sparsematrix.h> +#include <lac/sparse_matrix.h> #include <lac/vector.h> SolverControl control; @@ -202,8 +202,8 @@ of the problem Au=f.
 
 #include <lac/precondition_selector.h>
-#include <grid/dof.h>
-#include <lac/fullmatrix.h>
+#include <dofs/dof_handler.h>
+#include <lac/full_matrix.h>
 
 FullMatrix<double> A(100,50);
 
@@ -237,7 +237,7 @@ we solve the problem.
 #include <lac/precondition_selector.h>
 
 // Include files for matrices and vectors
-#include <lac/sparsematrix.h>
+#include <lac/sparse_matrix.h>
 #include <lac/vector.h>
 
 // Initialize the solver control and the solver
@@ -287,7 +287,7 @@ we solve the problem.
 #include <lac/precondition_selector.h>
 
 // Include files for matrices and vectors
-#include <lac/sparsematrix.h>
+#include <lac/sparse_matrix.h>
 #include <lac/vector.h>
 
 // Initialize the solver control and the solver
@@ -348,7 +348,7 @@ vectors.
 #include <lac/precondition_selector.h>
 
 // Include files for matrices and vectors
-#include <lac/sparsematrix.h>
+#include <lac/sparse_matrix.h>
 #include <lac/vector.h>
 
 // Initialize the solver control and the solver
@@ -403,7 +403,7 @@ we solve the problem. We use the default damping parameter of 1.
 #include <lac/precondition_selector.h>
 
 // Include files for matrices and vectors
-#include <lac/sparsematrix.h>
+#include <lac/sparse_matrix.h>
 #include <lac/vector.h>
 
 // Initialize the solver control and the solver